changeset 0:f1db758949f4 draft

planemo upload commit a0e968c7bd2b6f7b963baeecb08f3a39e50f52d6
author galaxyp
date Fri, 14 Sep 2018 12:22:13 -0400
parents
children dec87511835e
files quantp.r quantp.xml test-data/exp_design_file.tabular test-data/output.html test-data/protein_data.tabular test-data/transcript_data.tabular
diffstat 6 files changed, 6996 insertions(+), 0 deletions(-) [+]
line wrap: on
line diff
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/quantp.r	Fri Sep 14 12:22:13 2018 -0400
@@ -0,0 +1,1004 @@
+#***************************************************************************************************************************************
+# Functions: Start
+#***************************************************************************************************************************************
+
+#===============================================================================
+# PCA
+#===============================================================================
+multisample_PCA = function(df, sampleinfo_df, outfile)
+{
+  tempdf = df[,-1];
+  tempcol = colnames(tempdf);
+  tempgrp = sampleinfo_df[tempcol,2];
+  tempdf = t(tempdf) %>% as.data.frame();
+  tempdf[is.na(tempdf)] = 0;
+  tempdf$Group = tempgrp;
+  png(outfile, width = 6, height = 6, units = 'in', res=300);
+  # bitmap(outfile, "png16m");
+  g = autoplot(prcomp(select(tempdf, -Group)), data = tempdf, colour = 'Group', size=3);
+  plot(g);
+  dev.off();
+}
+
+#===============================================================================
+# Regression and Cook's distance
+#===============================================================================
+singlesample_regression = function(PE_TE_data,htmloutfile, append=TRUE)
+{
+  rownames(PE_TE_data) = PE_TE_data$PE_ID;
+  regmodel = lm(PE_abundance~TE_abundance, data=PE_TE_data);
+  regmodel_summary = summary(regmodel);
+  
+  cat("<font><h3>Linear Regression model fit between Proteome and Transcriptome data</h3></font>\n",
+    "<p>Assuming a linear relationship between Proteome and Transcriptome data, we here fit a linear regression model.</p>\n",
+    '<table  border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Parameter</font></th><th><font color=#ffcc33>Value</font></th></tr>\n',
+    file = htmloutfile, append = TRUE);
+  
+  cat("<tr><td>Formula</td><td>","PE_abundance~TE_abundance","</td></tr>\n",
+    "<tr><td colspan='2' align='center'> <b>Coefficients</b></td>","</tr>\n",
+    "<tr><td>",names(regmodel$coefficients[1]),"</td><td>",regmodel$coefficients[1]," (Pvalue:", regmodel_summary$coefficients[1,4],")","</td></tr>\n",
+    "<tr><td>",names(regmodel$coefficients[2]),"</td><td>",regmodel$coefficients[2]," (Pvalue:", regmodel_summary$coefficients[2,4],")","</td></tr>\n",
+    "<tr><td colspan='2' align='center'> <b>Model parameters</b></td>","</tr>\n",
+    "<tr><td>Residual standard error</td><td>",regmodel_summary$sigma," (",regmodel_summary$df[2]," degree of freedom)</td></tr>\n",
+    "<tr><td>F-statistic</td><td>",regmodel_summary$fstatistic[1]," ( on ",regmodel_summary$fstatistic[2]," and  ",regmodel_summary$fstatistic[3]," degree of freedom)</td></tr>\n",
+    "<tr><td>R-squared</td><td>",regmodel_summary$r.squared,"</td></tr>\n",
+    "<tr><td>Adjusted R-squared</td><td>",regmodel_summary$adj.r.squared,"</td></tr>\n",
+    file = htmloutfile, append = TRUE);
+  
+  cat("</table>\n", file = htmloutfile, append = TRUE);
+  
+  cat(
+    "<font color='#ff0000'><h3>Regression and diagnostics plots</h3></font>\n",
+    file = htmloutfile, append = TRUE);
+  
+  outplot = paste(outdir,"/PE_TE_lm_1.png",sep="",collapse="");
+  png(outplot, width = 10, height = 10, units = 'in',res=300);
+  # bitmap(outplot, "png16m");
+  par(mfrow=c(1,1));
+  plot(regmodel, 1, cex.lab=1.5);
+  dev.off();
+  
+  outplot = paste(outdir,"/PE_TE_lm_2.png",sep="",collapse="");
+  png(outplot,width = 10, height = 10, units = 'in', res=300);
+  # bitmap(outplot, "png16m");
+  par(mfrow=c(1,1));
+  plot(regmodel, 2, cex.lab=1.5);
+  dev.off();
+  
+  outplot = paste(outdir,"/PE_TE_lm_5.png",sep="",collapse="");
+  png(outplot, width = 10, height = 10, units = 'in',res=300);
+  # bitmap(outplot, "png16m");
+  par(mfrow=c(1,1));
+  plot(regmodel, 5, cex.lab=1.5);
+  dev.off();
+  
+  cat('<table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; ">', file = htmloutfile, append = TRUE);
+  
+    cat(
+    '<tr bgcolor="#7a0019"><th>', "<font color='#ffcc33'><h4>1) <u>Residuals vs Fitted plot</h4></font></u></th>\n",
+    '<th><font color=#ffcc33><h4>2) <u>Normal Q-Q plot of residuals</h4></font></u></th></tr>\n',
+    file = htmloutfile, append = TRUE);
+  
+  cat(
+    '<tr><td align=center><img src="PE_TE_lm_1.png" width=600 height=600></td><td align=center><img src="PE_TE_lm_2.png" width=600 height=600></td></tr>\n',
+    file = htmloutfile, append = TRUE);
+  
+  cat(
+    '<tr><td align=center>This plot checks for linear relationship assumptions.<br>If a horizontal line is observed without any distinct patterns, it indicates a linear relationship.</td>\n',
+    '<td align=center>This plot checks whether residuals are normally distributed or not.<br>It is good if the residuals points follow the straight dashed line i.e., do not deviate much from dashed line.</td></tr></table>\n',
+    file = htmloutfile, append = TRUE);
+    
+    
+    #@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@
+    # Residuals data
+    #@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@
+    res_all = regmodel$residuals;
+    res_mean = mean(res_all);
+    res_sd = sd(res_all);
+    res_diff = (res_all-res_mean);
+    res_zscore = res_diff/res_sd;
+    # res_outliers = res_all[which((res_zscore > 2)|(res_zscore < -2))]
+    
+    
+    tempind = which((res_zscore > 2)|(res_zscore < -2));
+    res_PE_TE_data_no_outlier = PE_TE_data[-tempind,];
+    res_PE_TE_data_no_outlier$residuals = res_all[-tempind];
+    res_PE_TE_data_outlier = PE_TE_data[tempind,];
+    res_PE_TE_data_outlier$residuals = res_all[tempind];
+  
+  # Save the complete table for download (influential_observations)
+    temp_outlier_data = data.frame(res_PE_TE_data_outlier$PE_ID, res_PE_TE_data_outlier$TE_abundance, res_PE_TE_data_outlier$PE_abundance, res_PE_TE_data_outlier$residuals)
+    colnames(temp_outlier_data) = c("Gene", "Transcript abundance", "Protein abundance", "Residual value")
+    outdatafile = paste(outdir,"/PE_TE_outliers_residuals.txt", sep="", collapse="");
+    write.table(temp_outlier_data, file=outdatafile, row.names=F, sep="\t", quote=F);
+  
+  
+  # Save the complete table for download (non influential_observations)
+    temp_all_data = data.frame(PE_TE_data$PE_ID, PE_TE_data$TE_abundance, PE_TE_data$PE_abundance, res_all)
+    colnames(temp_all_data) = c("Gene", "Transcript abundance", "Protein abundance", "Residual value")
+    outdatafile = paste(outdir,"/PE_TE_abundance_residuals.txt", sep="", collapse="");
+    write.table(temp_all_data, file=outdatafile, row.names=F, sep="\t", quote=F);
+  
+  
+  cat('<br><h2 id="inf_obs"><font color=#ff0000>Outliers based on the residuals from regression analysis</font></h2>\n',
+    file = htmloutfile, append = TRUE);
+  cat('<table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; ">\n',
+  '<tr bgcolor="#7a0019"><th colspan=2><font color=#ffcc33>Residuals from Regression</font></th></tr>\n',
+   '<tr bgcolor="#7a0019"><th><font color=#ffcc33>Parameter</font></th><th><font color=#ffcc33>Value</font></th></tr>\n',
+    file = htmloutfile, append = TRUE);
+    
+  cat("<tr><td>Mean Residual value</td><td>",res_mean,"</td></tr>\n",
+    "<tr><td>Standard deviation (Residuals)</td><td>",res_sd,"</td></tr>\n",
+    '<tr><td>Total outliers (Residual value > 2 standard deviation from the mean)</td><td>',length(tempind),' <font size=4>(<b><a href=PE_TE_outliers_residuals.txt target="_blank">Download these ',length(tempind),' data points with high residual values here</a></b>)</font></td>\n',
+    '<tr><td colspan=2 align=center><font size=4>(<b><a href=PE_TE_abundance_residuals.txt target="_blank">Download the complete residuals data here</a></b>)</font></td></td>\n',
+    "</table><br><br>\n",
+    file = htmloutfile, append = TRUE);
+    
+  #@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@
+    
+    
+  cat('<br><br><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; ">', file = htmloutfile, append = TRUE);
+
+  cat(
+    '<tr bgcolor="#7a0019"><th><font color=#ffcc33><h4>3) <u>Residuals vs Leverage plot</h4></font></u></th></tr>\n',
+    file = htmloutfile, append = TRUE);
+  
+  cat(
+    '<tr><td align=center><img src="PE_TE_lm_5.png" width=600 height=600></td></tr>\n',
+    file = htmloutfile, append = TRUE);
+  
+  cat(
+    '<tr><td align=center>This plot is useful to identify any influential cases, that is outliers or extreme values.<br>They might influence the regression results upon inclusion or exclusion from the analysis.</td></tr></table><br>\n',
+    file = htmloutfile, append = TRUE);
+  
+  
+  
+  #^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^
+  # Cook's Distance
+  #^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^
+  cat('<hr/><h2 id="inf_obs"><font color=#ff0000>INFLUENTIAL OBSERVATIONS</font></h2>\n',
+    file = htmloutfile, append = TRUE);
+  cat(
+    '<p><b>Cook\'s distance</b> computes the influence of each data point/observation on the predicted outcome. i.e. this measures how much the observation is influencing the fitted values.<br>In general use, those observations that have a <b>Cook\'s distance > than ', cookdist_upper_cutoff,' times the mean</b> may be classified as <b>influential.</b></p>\n',
+    file = htmloutfile, append = TRUE);
+  
+  cooksd <- cooks.distance(regmodel);
+  
+  outplot = paste(outdir,"/PE_TE_lm_cooksd.png",sep="",collapse="");
+  png(outplot, width = 10, height = 10, units = 'in', res=300);
+  # bitmap(outplot, "png16m");
+  par(mfrow=c(1,1));
+  plot(cooksd, main="Influential Obs. by Cook\'s distance", ylab="Cook\'s distance", xlab="Observations", type="n")  # plot cooks distance
+  sel_outlier=which(cooksd>=as.numeric(cookdist_upper_cutoff)*mean(cooksd, na.rm=T))
+  sel_nonoutlier=which(cooksd<as.numeric(cookdist_upper_cutoff)*mean(cooksd, na.rm=T))
+  points(sel_outlier, cooksd[sel_outlier],pch="*", cex=2, cex.lab=1.5, col="red")
+  points(sel_nonoutlier, cooksd[sel_nonoutlier],pch="*", cex=2, cex.lab=1.5, col="black")
+  abline(h = as.numeric(cookdist_upper_cutoff)*mean(cooksd, na.rm=T), col="red")  # add cutoff line
+  #text(x=1:length(cooksd)+1, y=cooksd, labels=ifelse(cooksd>as.numeric(cookdist_upper_cutoff)*mean(cooksd, na.rm=T),names(cooksd),""), col="red", pos=2)  # add labels
+  dev.off();
+  
+  cat(
+    '<img src="PE_TE_lm_cooksd.png" width=800 height=800>',
+    '<br>In the above plot, observations above red line (',cookdist_upper_cutoff,' * mean Cook\'s distance) are influential. Genes that are outliers could be important. These observations influences the correlation values and regression coefficients<br><br>',
+    file = htmloutfile, append = TRUE);    
+
+  tempind = which(cooksd>as.numeric(cookdist_upper_cutoff)*mean(cooksd, na.rm=T));
+  PE_TE_data_no_outlier = PE_TE_data[-tempind,];
+  PE_TE_data_no_outlier$cooksd = cooksd[-tempind];
+  PE_TE_data_outlier = PE_TE_data[tempind,];
+  PE_TE_data_outlier$cooksd = cooksd[tempind];
+  a = sort(PE_TE_data_outlier$cooksd, decreasing=T, index.return=T);
+  PE_TE_data_outlier_sorted = PE_TE_data_outlier[a$ix,];
+  
+  cat(
+    '<table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Parameter</font></th><th><font color=#ffcc33>Value</font></th></tr>\n',
+    file = htmloutfile, append = TRUE);
+  
+  # Save the complete table for download (influential_observations)
+    temp_outlier_data = data.frame(PE_TE_data_outlier$PE_ID, PE_TE_data_outlier$TE_abundance, PE_TE_data_outlier$PE_abundance, PE_TE_data_outlier$cooksd)
+    colnames(temp_outlier_data) = c("Gene", "Transcript abundance", "Protein abundance", "Cook's distance")
+    outdatafile = paste(outdir,"/PE_TE_influential_observation.txt", sep="", collapse="");
+    write.table(temp_outlier_data, file=outdatafile, row.names=F, sep="\t", quote=F);
+  
+  
+  # Save the complete table for download (non influential_observations)
+    temp_no_outlier_data = data.frame(PE_TE_data_no_outlier$PE_ID, PE_TE_data_no_outlier$TE_abundance, PE_TE_data_no_outlier$PE_abundance, PE_TE_data_no_outlier$cooksd)
+    colnames(temp_no_outlier_data) = c("Gene", "Transcript abundance", "Protein abundance", "Cook's distance")
+    outdatafile = paste(outdir,"/PE_TE_non_influential_observation.txt", sep="", collapse="");
+    write.table(temp_no_outlier_data, file=outdatafile, row.names=F, sep="\t", quote=F);
+  
+  
+  cat("<tr><td>Mean Cook\'s distance</td><td>",mean(cooksd, na.rm=T),"</td></tr>\n",
+    "<tr><td>Total influential observations (Cook\'s distance > ",cookdist_upper_cutoff," * mean Cook\'s distance)</td><td>",length(tempind),"</td>\n",
+    
+    "<tr><td>Observations with Cook\'s distance < ",cookdist_upper_cutoff," * mean Cook\'s distance</td><td>",length(which(cooksd<as.numeric(cookdist_upper_cutoff)*mean(cooksd, na.rm=T))),"</td>\n",
+    "</table><br><br>\n",
+    file = htmloutfile, append = TRUE);
+    
+    
+    #@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@
+    # Scatter plot after removal of influential points
+    #@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@
+    outplot = paste(outdir,"/AbundancePlot_scatter_without_outliers.png",sep="",collapse="");
+    min_lim = min(c(PE_TE_data$PE_abundance,PE_TE_data$TE_abundance));
+    max_lim = max(c(PE_TE_data$PE_abundance,PE_TE_data$TE_abundance));
+    png(outplot, width = 10, height = 10, units = 'in', res=300);
+    # bitmap(outplot,"png16m");
+    g = ggplot(PE_TE_data_no_outlier, aes(x=TE_abundance, y=PE_abundance))+geom_point() + geom_smooth() + xlab("Transcript abundance log fold-change") + ylab("Protein abundance log fold-change") + xlim(min_lim,max_lim) + ylim(min_lim,max_lim);
+    suppressMessages(plot(g));
+    dev.off();
+    
+    cat('<table  border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Scatterplot: Before removal</font></th><th><font color=#ffcc33>Scatterplot: After removal</font></th></tr>\n', file = htmloutfile, append = TRUE);
+    # Before
+    cat("<tr><td align=center><!--<font color='#ff0000'><h3>Scatter plot between Proteome and Transcriptome Abundance</h3></font>\n-->", '<img src="TE_PE_scatter.png" width=600 height=600></td>\n', file = htmloutfile, append = TRUE);
+    
+    # After
+    cat("<td align=center>\n",
+    '<img src="AbundancePlot_scatter_without_outliers.png" width=600 height=600></td></tr>\n',
+    file = htmloutfile, append = TRUE);
+    #@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@@
+    
+  
+  cor_result_pearson = cor.test(PE_TE_data_no_outlier[,"TE_abundance"], PE_TE_data_no_outlier[,"PE_abundance"], method = "pearson");
+  cor_result_spearman = cor.test(PE_TE_data_no_outlier[,"TE_abundance"], PE_TE_data_no_outlier[,"PE_abundance"], method = "spearman");
+  cor_result_kendall = cor.test(PE_TE_data_no_outlier[,"TE_abundance"], PE_TE_data_no_outlier[,"PE_abundance"], method = "kendall");
+  
+  cat('<tr><td>\n', file = htmloutfile, append=TRUE);
+  singlesample_cor(PE_TE_data, htmloutfile, append=TRUE);
+  cat('</td>\n', file = htmloutfile, append=TRUE);
+  
+  
+  cat('<td><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Parameter</font></th><th><font color=#ffcc33>Method 1</font></th><th><font color=#ffcc33>Method 2</font></th><th><font color=#ffcc33>Method 3</font></th></tr>\n',
+    file = htmloutfile, append = TRUE);
+  
+  cat(
+    "<tr><td>Correlation method</td><td>",cor_result_pearson$method,"</td><td>",cor_result_spearman$method,"</td><td>",cor_result_kendall$method,"</td></tr>\n",
+    "<tr><td>Correlation coefficient</td><td>",cor_result_pearson$estimate,"</td><td>",cor_result_spearman$estimate,"</td><td>",cor_result_kendall$estimate,"</td></tr>\n",
+    file = htmloutfile, append = TRUE)
+  cat("</table></td></tr></table>\n", file = htmloutfile, append = TRUE)
+  
+  
+  
+  if(dim(PE_TE_data_outlier)[1]<10)
+  {
+    tab_n_row = dim(PE_TE_data_outlier)[1];
+  }else{
+    tab_n_row = 10;
+  }
+  
+  cat("<br><br><font size=5><b><a href='PE_TE_influential_observation.txt' target='_blank'>Download the complete list of influential observations</a></b></font>&nbsp;&nbsp;&nbsp;&nbsp;",
+  "<font size=5><b><a href='PE_TE_non_influential_observation.txt' target='_blank'>Download the complete list (After removing influential points)</a></b></font><br>\n",
+  '<br><font color="brown"><h4>Top ',as.character(tab_n_row),' Influential observations (Cook\'s distance > ',cookdist_upper_cutoff,' * mean Cook\'s distance)</h4></font>\n',
+    file = htmloutfile, append = TRUE);
+  
+  cat('<table border=1 cellspacing=0 cellpadding=5> <tr bgcolor="#7a0019">\n', sep = "",file = htmloutfile, append = TRUE);
+  cat("<th><font color=#ffcc33>Gene</font></th><th><font color=#ffcc33>Protein Log Fold-Change</font></th><th><font color=#ffcc33>Transcript Log Fold-Change</font></th><th><font color=#ffcc33>Cook's Distance</font></th></tr>\n",
+    file = htmloutfile, append = TRUE);
+  
+  
+  for(i in 1:tab_n_row)
+  {
+    cat(
+      '<tr>','<td>',as.character(PE_TE_data_outlier_sorted[i,1]),'</td>\n',
+      '<td>',format(PE_TE_data_outlier_sorted[i,2], scientific=F),'</td>\n',
+      '<td>',PE_TE_data_outlier_sorted[i,4],'</td>\n',
+      '<td>',format(PE_TE_data_outlier_sorted[i,5], scientific=F),'</td></tr>\n',
+      file = htmloutfile, append = TRUE);
+  }
+    cat('</table><br><br>\n',file = htmloutfile, append = TRUE);
+    
+    
+}
+
+
+
+#===============================================================================
+# Heatmap
+#===============================================================================
+singlesample_heatmap=function(PE_TE_data, htmloutfile, hm_nclust){
+  cat('<br><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Heatmap of PE and TE abundance values (Hierarchical clustering)</font></th><th><font color=#ffcc33>Number of clusters to extract: ',hm_nclust,'</font></th></tr>\n',
+    file = htmloutfile, append = TRUE);
+  
+  hc=hclust(dist(as.matrix(PE_TE_data[,c("PE_abundance","TE_abundance")])))
+  hm_cluster = cutree(hc,k=hm_nclust);
+  
+  outplot = paste(outdir,"/PE_TE_heatmap.png",sep="",collapse="");
+  png(outplot, width = 10, height = 10, units = 'in', res=300);
+  # bitmap(outplot, "png16m");
+  par(mfrow=c(1,1));
+  hmap = heatmap.2(as.matrix(PE_TE_data[,c("PE_abundance","TE_abundance")]), trace="none", cexCol=1, col=greenred(100),Colv=F, labCol=c("Proteins","Transcripts"), scale="col", hclustfun = hclust, distfun = dist);
+  dev.off();
+  
+  cat('<tr><td align=center colspan="2"><img src="PE_TE_heatmap.png" width=800 height=800></td></tr>\n',
+    file = htmloutfile, append = TRUE);
+  
+  
+  temp_PE_TE_data = data.frame(PE_TE_data$PE_ID, PE_TE_data$TE_abundance, PE_TE_data$PE_abundance, hm_cluster);
+  colnames(temp_PE_TE_data) = c("Gene", "Transcript abundance", "Protein abundance", "Cluster (Hierarchical clustering)")
+  tempoutfile = paste(outdir,"/PE_TE_hc_clusterpoints.txt",sep="",collapse="");
+  write.table(temp_PE_TE_data, file=tempoutfile, row.names=F, quote=F, sep="\t", eol="\n")
+  
+  
+  cat('<tr><td colspan="2" align=center><font size=5><a href="PE_TE_hc_clusterpoints.txt" target="_blank"><b>Download the hierarchical cluster list</b></a></font></td></tr></table>\n',
+    file = htmloutfile, append = TRUE);
+}
+
+
+#===============================================================================
+# K-means clustering
+#===============================================================================
+singlesample_kmeans=function(PE_TE_data, htmloutfile, nclust){
+  PE_TE_data_kdata = PE_TE_data;
+  k1 = kmeans(PE_TE_data_kdata[,c("PE_abundance","TE_abundance")], nclust);
+  outplot = paste(outdir,"/PE_TE_kmeans.png",sep="",collapse="");
+  png(outplot, width = 10, height = 10, units = 'in', res=300);
+  # bitmap(outplot, "png16m");
+  par(mfrow=c(1,1));
+  scatter.smooth(PE_TE_data_kdata[,"TE_abundance"], PE_TE_data_kdata[,"PE_abundance"], xlab="Transcript Abundance", ylab="Protein Abundance", cex.lab=1.5);
+  legend(1, 95, legend=c("Cluster 1", "Line 2"), col="red", lty=1:1, cex=0.8)
+  legend(1, 95, legend="Cluster 2", col="green", lty=1:1, cex=0.8)
+  
+  
+  ind=which(k1$cluster==1);
+  points(PE_TE_data_kdata[ind,"TE_abundance"], PE_TE_data_kdata[ind,"PE_abundance"], col="red", pch=16);
+  ind=which(k1$cluster==2);
+  points(PE_TE_data_kdata[ind,"TE_abundance"], PE_TE_data_kdata[ind,"PE_abundance"], col="green", pch=16);
+  ind=which(k1$cluster==3);
+  points(PE_TE_data_kdata[ind,"TE_abundance"], PE_TE_data_kdata[ind,"PE_abundance"], col="blue", pch=16);
+  ind=which(k1$cluster==4);
+  points(PE_TE_data_kdata[ind,"TE_abundance"], PE_TE_data_kdata[ind,"PE_abundance"], col="cyan", pch=16);
+  ind=which(k1$cluster==5);
+  points(PE_TE_data_kdata[ind,"TE_abundance"], PE_TE_data_kdata[ind,"PE_abundance"], col="black", pch=16);
+  ind=which(k1$cluster==6);
+  points(PE_TE_data_kdata[ind,"TE_abundance"], PE_TE_data_kdata[ind,"PE_abundance"], col="brown", pch=16);
+  ind=which(k1$cluster==7);
+  points(PE_TE_data_kdata[ind,"TE_abundance"], PE_TE_data_kdata[ind,"PE_abundance"], col="gold", pch=16);
+  ind=which(k1$cluster==8);
+  points(PE_TE_data_kdata[ind,"TE_abundance"], PE_TE_data_kdata[ind,"PE_abundance"], col="thistle", pch=16);
+  ind=which(k1$cluster==9);
+  points(PE_TE_data_kdata[ind,"TE_abundance"], PE_TE_data_kdata[ind,"PE_abundance"], col="yellow", pch=16);
+  ind=which(k1$cluster==10);
+  points(PE_TE_data_kdata[ind,"TE_abundance"], PE_TE_data_kdata[ind,"PE_abundance"], col="orange", pch=16);
+  dev.off();
+  
+  cat('<br><br><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>K-mean clustering</font></th><th><font color=#ffcc33>Number of clusters: ',nclust,'</font></th></tr>\n',
+    file = htmloutfile, append = TRUE);
+  
+  tempind = order(k1$cluster);
+  tempoutfile = paste(outdir,"/PE_TE_kmeans_clusterpoints.txt",sep="",collapse="");
+  write.table(data.frame(PE_TE_data_kdata[tempind, ], Cluster=k1$cluster[tempind]), file=tempoutfile, row.names=F, quote=F, sep="\t", eol="\n")
+  
+  
+  cat('<tr><td colspan="2" align=center><img src="PE_TE_kmeans.png" width=800 height=800></td></tr>\n',
+    file = htmloutfile, append = TRUE);
+  cat('<tr><td colspan="2" align=center><font size=5><a href="PE_TE_kmeans_clusterpoints.txt" target="_blank"><b>Download the cluster list</b></a></font></td></tr></table><br><hr/>\n',
+    file = htmloutfile, append = TRUE);
+  
+}
+
+#===============================================================================
+# scatter plot
+#===============================================================================
+singlesample_scatter = function(PE_TE_data, outfile)
+{
+  min_lim = min(c(PE_TE_data$PE_abundance,PE_TE_data$TE_abundance));
+  max_lim = max(c(PE_TE_data$PE_abundance,PE_TE_data$TE_abundance));
+  png(outfile, width = 10, height = 10, units = 'in', res=300);
+  # bitmap(outfile, "png16m");
+  g = ggplot(PE_TE_data, aes(x=TE_abundance, y=PE_abundance))+geom_point() + geom_smooth() + xlab("Transcript abundance log fold-change") + ylab("Protein abundance log fold-change") + xlim(min_lim,max_lim) + ylim(min_lim,max_lim);
+  suppressMessages(plot(g));
+  # plot(g);
+  dev.off();
+}
+
+#===============================================================================
+# Correlation table
+#===============================================================================
+singlesample_cor = function(PE_TE_data, htmloutfile, append=TRUE)
+{
+  cor_result_pearson = cor.test(PE_TE_data$TE_abundance, PE_TE_data$PE_abundance, method = "pearson");
+  cor_result_spearman = cor.test(PE_TE_data$TE_abundance, PE_TE_data$PE_abundance, method = "spearman");
+  cor_result_kendall = cor.test(PE_TE_data$TE_abundance, PE_TE_data$PE_abundance, method = "kendall");
+  
+  cat(
+    '<table  border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Parameter</font></th><th><font color=#ffcc33>Method 1</font></th><th><font color=#ffcc33>Method 2</font></th><th><font color=#ffcc33>Method 3</font></th></tr>\n',
+    file = htmloutfile, append = TRUE);
+  
+  cat(
+    "<tr><td>Correlation method</td><td>",cor_result_pearson$method,"</td><td>",cor_result_spearman$method,"</td><td>",cor_result_kendall$method,"</td></tr>\n",
+    "<tr><td>Correlation coefficient</td><td>",cor_result_pearson$estimate,"</td><td>",cor_result_spearman$estimate,"</td><td>",cor_result_kendall$estimate,"</td></tr>\n",
+    file = htmloutfile, append = TRUE)
+  cat("</table>\n", file = htmloutfile, append = TRUE);
+  
+}
+
+#===============================================================================
+# Boxplot
+#===============================================================================
+multisample_boxplot = function(df, sampleinfo_df, outfile, fill_leg, user_xlab, user_ylab)
+{
+  tempdf = df[,-1, drop=FALSE];
+  tempdf = t(tempdf) %>% as.data.frame();
+  tempdf[is.na(tempdf)] = 0;
+  tempdf$Sample = rownames(tempdf);
+  tempdf1 = melt(tempdf, id.vars = "Sample");
+  tempdf1$Group = sampleinfo_df[tempdf1$Sample,2];
+  png(outplot, width = 6, height = 6, units = 'in', res=300);
+  # bitmap(outplot, "png16m");
+  if(fill_leg=="Yes")
+  {
+    g = ggplot(tempdf1, aes(x=Sample, y=value, fill=Group)) + geom_boxplot() + labs(x=user_xlab) + labs(y=user_ylab)
+  }else{
+    if(fill_leg=="No")
+    {
+      tempdf1$Group = c("case", "control")
+      g = ggplot(tempdf1, aes(x=Sample, y=value, fill=Group)) + geom_boxplot() + labs(x=user_xlab) + labs(y=user_ylab)
+    }
+  }
+  plot(g);
+  dev.off();
+}
+
+
+#===============================================================================
+# Mean or Median of Replicates
+#===============================================================================
+
+mergeReplicates = function(TE_df,PE_df, sampleinfo_df, method)
+{
+grps = unique(sampleinfo_df[,2]);
+
+TE_df_merged <<- sapply(grps, function(x){
+  tempsample = sampleinfo_df[which(sampleinfo_df$Group==x),1]
+  if(length(tempsample)!=1){
+    apply(TE_df[,tempsample],1,method);
+  }else{
+    return(TE_df[,tempsample]);
+  }
+});
+TE_df_merged <<-   data.frame(as.character(TE_df[,1]), TE_df_merged);
+colnames(TE_df_merged) = c(colnames(TE_df)[1], grps);
+
+PE_df_merged <<- sapply(grps, function(x){
+  tempsample = sampleinfo_df[which(sampleinfo_df$Group==x),1]
+  if(length(tempsample)!=1){
+    apply(PE_df[,tempsample],1,method);
+  }else{
+    return(PE_df[,tempsample]);
+  }
+});
+
+PE_df_merged <<-   data.frame(as.character(PE_df[,1]), PE_df_merged);
+colnames(PE_df_merged) = c(colnames(PE_df)[1], grps);
+
+#sampleinfo_df_merged =  data.frame(Sample = grps, Group = grps, stringsAsFactors = F);
+sampleinfo_df_merged =  data.frame(Sample = grps, Group = "Group", stringsAsFactors = F);
+
+return(list(TE_df_merged = TE_df_merged, PE_df_merged = PE_df_merged, sampleinfo_df_merged = sampleinfo_df_merged));
+}
+
+#===============================================================================
+# (T-Test or Wilcoxon ranksum test) and Volcano Plot
+#===============================================================================
+
+perform_Test_Volcano = function(TE_df_data,PE_df_data,TE_df_logfold, PE_df_logfold,sampleinfo_df, method, correction_method,volc_with)
+{
+
+PE_colnames = colnames(PE_df_data);
+control_sample = sampleinfo_df[which(sampleinfo_df$Group=="control"),1];
+control_ind <<- sapply(control_sample, function(x){temp_ind = which(PE_colnames==x); as.numeric(temp_ind)});
+condition_sample = sampleinfo_df[which(sampleinfo_df$Group=="case"),1];
+condition_ind <<- sapply(condition_sample, function(x){temp_ind = which(PE_colnames==x); as.numeric(temp_ind)});
+
+if(method=="mean"){
+  #PE_pval = apply(PE_df_data[2:length(colnames(PE_df_data))],1,function(x) t.test(x[condition_ind-1], x[control_ind-1])$p.value);
+  PE_pval = apply(PE_df_data[2:length(colnames(PE_df_data))],1,function(x) {obj<-try(t.test(x[condition_ind-1], x[control_ind-1]),silent=TRUE); if(is(obj, "try-error")){return(NA)}else{return(obj$p.value)}})
+}else{
+if(method=="median"){
+    PE_pval = apply(PE_df_data[2:length(colnames(PE_df_data))],1,function(x) {obj<-try(wilcox.test(x[condition_ind-1], x[control_ind-1]),silent=TRUE); if(is(obj, "try-error")){return(NA)}else{return(obj$p.value)}})
+    # PE_pval = apply(PE_df_data[2:length(colnames(PE_df_data))],1,function(x) wilcox.test(x[condition_ind-1], x[control_ind-1])$p.value);
+  }
+}
+PE_adj_pval = p.adjust(PE_pval, method = correction_method, n = length(PE_pval))
+
+
+TE_colnames = colnames(TE_df_data);
+control_sample = sampleinfo_df[which(sampleinfo_df$Group=="control"),1];
+control_ind <<- sapply(control_sample, function(x){temp_ind = which(TE_colnames==x); as.numeric(temp_ind)});
+condition_sample = sampleinfo_df[which(sampleinfo_df$Group=="case"),1];
+condition_ind <<- sapply(condition_sample, function(x){temp_ind = which(TE_colnames==x); as.numeric(temp_ind)});
+
+if(method=="mean"){
+  # TE_pval = apply(TE_df_data[2:length(colnames(TE_df_data))],1,function(x) t.test(x[condition_ind-1], x[control_ind-1])$p.value);
+  TE_pval = apply(TE_df_data[2:length(colnames(TE_df_data))],1,function(x) {obj<-try(t.test(x[condition_ind-1], x[control_ind-1]),silent=TRUE); if(is(obj, "try-error")){return(NA)}else{return(obj$p.value)}})
+}else{
+  if(method=="median"){
+  TE_pval = apply(TE_df_data[2:length(colnames(TE_df_data))],1,function(x) {obj<-try(wilcox.test(x[condition_ind-1], x[control_ind-1]),silent=TRUE); if(is(obj, "try-error")){return(NA)}else{return(obj$p.value)}})
+  # TE_pval = apply(TE_df_data[2:length(colnames(TE_df_data))],1,function(x) wilcox.test(x[condition_ind-1], x[control_ind-1])$p.value);
+  }
+}
+TE_adj_pval = p.adjust(TE_pval, method = correction_method, n = length(TE_pval))
+
+
+PE_TE_logfold_pval = data.frame(TE_df_logfold$Gene, TE_df_logfold$LogFold, TE_pval, TE_adj_pval, PE_df_logfold$LogFold, PE_pval, PE_adj_pval);
+colnames(PE_TE_logfold_pval) = c("Gene", "Transcript log fold-change", "p-value (transcript)", "adj p-value (transcript)", "Protein log fold-change", "p-value (protein)", "adj p-value (protein)");
+outdatafile = paste(outdir,"/PE_TE_logfold_pval.txt", sep="", collapse="");
+write.table(PE_TE_logfold_pval, file=outdatafile, row.names=F, sep="\t", quote=F);
+cat("<br><br><font size=5><b><a href='PE_TE_logfold_pval.txt' target='_blank'>Download the complete fold change data here</a></b></font><br>\n",
+    file = htmloutfile, append = TRUE);
+
+    if(length(condition_ind)!=1)
+        {
+        # Volcano Plot
+
+        if(volc_with=="adj_pval")
+        {
+            PE_pval = PE_adj_pval
+            TE_pval = TE_adj_pval
+            volc_ylab = "-log10 Adjusted p-value";
+        }else{
+          if(volc_with=="pval")
+          {
+            volc_ylab = "-log10 p-value";
+          }
+        }
+        outplot = paste(outdir,"/PE_volcano.png",sep="",collapse="");
+          png(outplot, width = 10, height = 10, units = 'in', res=300);
+          # bitmap(outplot, "png16m");
+          par(mfrow=c(1,1));
+  
+        plot(PE_df_logfold$LogFold, -log10(PE_pval),
+             xlab="log2 fold change", ylab=volc_ylab,
+             type="n")
+        sel <- which((PE_df_logfold$LogFold<=log(2,base=2))&(PE_df_logfold$LogFold>=log(0.5, base=2))) # or whatever you want to use
+        points(PE_df_logfold[sel,"LogFold"], -log10(PE_pval[sel]),col="black")
+        #sel <- which((PE_df_logfold$LogFold>log(2,base=2))&(PE_df_logfold$LogFold<log(0.5,base=2))) # or whatever you want to use
+        sel <- which((PE_df_logfold$LogFold>log(2,base=2))|(PE_df_logfold$LogFold<log(0.5, base=2)))
+        sel1 <- which(PE_pval<=0.05)
+        sel=intersect(sel,sel1)
+        points(PE_df_logfold[sel,"LogFold"], -log10(PE_pval[sel]),col="red")
+        sel <- which((PE_df_logfold$LogFold>log(2,base=2))|(PE_df_logfold$LogFold<log(0.5, base=2)))
+        sel1 <- which(PE_pval>0.05)
+        sel=intersect(sel,sel1)
+        points(PE_df_logfold[sel,"LogFold"], -log10(PE_pval[sel]),col="blue")
+        abline(h = -log(0.05,base=10), col="red", lty=2)
+        abline(v = log(2,base=2), col="red", lty=2)
+        abline(v = log(0.5,base=2), col="red", lty=2)
+        dev.off();
+  
+
+
+        outplot = paste(outdir,"/TE_volcano.png",sep="",collapse="");
+          png(outplot, width = 10, height = 10, units = 'in', res=300);
+          # bitmap(outplot, "png16m");
+          par(mfrow=c(1,1));
+
+        plot(TE_df_logfold$LogFold, -log10(TE_pval),
+             xlab="log2 fold change", ylab=volc_ylab,
+             type="n")
+        sel <- which((TE_df_logfold$LogFold<=log(2,base=2))&(TE_df_logfold$LogFold>=log(0.5, base=2))) # or whatever you want to use
+        points(TE_df_logfold[sel,"LogFold"], -log10(TE_pval[sel]),col="black")
+        #sel <- which((TE_df_logfold$LogFold>log(2,base=2))&(TE_df_logfold$LogFold<log(0.5,base=2))) # or whatever you want to use
+        sel <- which((TE_df_logfold$LogFold>log(2,base=2))|(TE_df_logfold$LogFold<log(0.5, base=2)))
+        sel1 <- which(TE_pval<=0.05)
+        sel=intersect(sel,sel1)
+        points(TE_df_logfold[sel,"LogFold"], -log10(TE_pval[sel]),col="red")
+        sel <- which((TE_df_logfold$LogFold>log(2,base=2))|(TE_df_logfold$LogFold<log(0.5, base=2)))
+        sel1 <- which(TE_pval>0.05)
+        sel=intersect(sel,sel1)
+        points(TE_df_logfold[sel,"LogFold"], -log10(TE_pval[sel]),col="blue")
+        abline(h = -log(0.05,base=10), col="red", lty=2)
+        abline(v = log(2,base=2), col="red", lty=2)
+        abline(v = log(0.5,base=2), col="red", lty=2)
+        dev.off();
+
+
+
+        cat('<br><table  border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Transcript Fold-Change</font></th><th><font color=#ffcc33>Protein Fold-Change</font></th></tr>\n', file = htmloutfile, append = TRUE);
+            cat("<tr><td align=center>", '<img src="TE_volcano.png" width=600 height=600></td>\n', file = htmloutfile, append = TRUE);
+            cat("<td align=center>",
+            '<img src="PE_volcano.png" width=600 height=600></td></tr></table><br>\n',
+            file = htmloutfile, append = TRUE);
+    }else{
+        cat('<br><br><b><font color=red>!!! No replicates found. Cannot perform test to check significance of differential expression. Thus, no Volcano plot generated !!!</font></b><br><br>',
+        file = htmloutfile, append = TRUE);
+    }
+
+}
+
+
+#***************************************************************************************************************************************
+# Functions: End
+#***************************************************************************************************************************************
+
+
+
+
+#===============================================================================
+# Arguments
+#===============================================================================
+noargs = 12;
+args = commandArgs(trailingOnly = TRUE);
+if(length(args) != noargs)
+{
+  stop(paste("Please check usage. Number of arguments is not equal to ",noargs,sep="",collapse=""));
+}
+
+mode = args[1]; # "multiple" or "logfold"
+method = args[2]; # "mean" or "median"
+sampleinfo_file = args[3];
+proteome_file = args[4];
+transcriptome_file = args[5];
+correction_method = args[6];
+cookdist_upper_cutoff = args[7];
+numCluster = args[8];
+hm_nclust = args[9];
+volc_with = args[10];
+
+htmloutfile = args[11]; # html output file
+outdir = args[12]; # html supporting files
+
+
+#===============================================================================
+# Check for file existance
+#===============================================================================
+if(! file.exists(proteome_file))
+{
+  stop(paste("Proteome Data file does not exists. Path given: ",proteome_file,sep="",collapse=""));
+}
+if(! file.exists(transcriptome_file))
+{
+  stop(paste("Transcriptome Data file does not exists. Path given: ",transcriptome_file,sep="",collapse=""));
+}
+
+#===============================================================================
+# Load library
+#===============================================================================
+options(warn=-1);
+
+suppressPackageStartupMessages(library(dplyr));
+suppressPackageStartupMessages(library(data.table));
+suppressPackageStartupMessages(library(gplots));
+suppressPackageStartupMessages(library(ggplot2));
+suppressPackageStartupMessages(library(ggfortify));
+
+#===============================================================================
+# Select mode and parse experiment design file
+#===============================================================================
+if(mode=="multiple")
+{
+    expDesign = fread(sampleinfo_file, header = FALSE, stringsAsFactors = FALSE, sep="\t") %>% data.frame();
+    expDesign_cc = expDesign[1:2,];
+    
+    sampleinfo_df = expDesign[3:nrow(expDesign),];
+    rownames(sampleinfo_df)=1:nrow(sampleinfo_df);
+    colnames(sampleinfo_df) =  c("Sample","Group");
+    
+    condition_cols = sampleinfo_df[which(sampleinfo_df[,2]==expDesign_cc[which(expDesign_cc[,1]=="case"),2]),1];
+    condition_g_name = "case";
+    control_cols = sampleinfo_df[which(sampleinfo_df[,2]==expDesign_cc[which(expDesign_cc[,1]=="control"),2]),1];
+    control_g_name = "control";
+    sampleinfo_df[which(sampleinfo_df[,2]==expDesign_cc[which(expDesign_cc[,1]=="case"),2]),2] = "case";
+    sampleinfo_df[which(sampleinfo_df[,2]==expDesign_cc[which(expDesign_cc[,1]=="control"),2]),2] = "control";
+    sampleinfo_df_orig = sampleinfo_df;
+}
+
+if(mode=="logfold")
+{
+    sampleinfo_df = data.frame("Sample"= c("LogFold"), "Group"=c("Fold_Change"))
+}
+
+#===============================================================================
+# Parse Transcriptome data
+#===============================================================================
+TE_df_orig = fread(transcriptome_file, sep="\t", stringsAsFactor=F, header=T) %>% data.frame();
+if(mode=="multiple")
+{
+    TE_df = TE_df_orig[,c(colnames(TE_df_orig)[1],condition_cols,control_cols)];
+}
+if(mode=="logfold")
+{
+    TE_df = TE_df_orig;
+    colnames(TE_df) = c("Genes", "LogFold");
+}
+#===============================================================================
+# Parse Proteome data
+#===============================================================================
+PE_df_orig = fread(proteome_file, sep="\t", stringsAsFactor=F, header=T) %>% data.frame();
+if(mode=="multiple")
+{
+    PE_df = PE_df_orig[,c(colnames(PE_df_orig)[1],condition_cols,control_cols)];
+}
+if(mode=="logfold")
+{
+    PE_df = PE_df_orig;
+    colnames(PE_df) = c("Genes", "LogFold");
+}
+
+#=============================================================================================================
+# Create directory structures and then set the working directory to output directory
+#=============================================================================================================
+if(! file.exists(outdir))
+{
+  dir.create(outdir);
+}
+#===============================================================================
+# Write initial data summary in html outfile
+#===============================================================================
+    cat("<html><head></head><body>\n", file = htmloutfile);
+    
+    cat("<h1><u>QuanTP: Association between abundance ratios of transcript and protein</u></h1><hr/>\n",
+    "<font><h3>Input data summary</h3></font>\n",
+    "<ul>\n",
+    "<li>Abbreviations used: PE (Proteome data) and TE (Transcriptome data)","</li><br>\n",
+    "<li>Input Proteome data dimension (Row Column): ", dim(PE_df)[1]," x ", dim(PE_df)[2],"</li>\n",
+    "<li>Input Transcriptome data dimension (Row Column): ", dim(TE_df)[1]," x ", dim(TE_df)[2],"</li></ul><hr/>\n",
+    file = htmloutfile, append = TRUE);
+    
+    cat("<h3 id=table_of_content>Table of Contents:</h3>\n",
+    "<ul>\n",
+    "<li><a href=#sample_dist>Sample distribution</a></li>\n",
+    "<li><a href=#corr_data>Correlation</a></li>\n",
+    "<li><a href=#regression_data>Regression analysis</a></li>\n",
+    "<li><a href=#inf_obs>Influential observations</a></li>\n",
+    "<li><a href=#cluster_data>Cluster analysis</a></li></ul><hr/>\n",
+    file = htmloutfile, append = TRUE);
+#===============================================================================
+# Find common samples
+#===============================================================================
+common_samples = intersect(sampleinfo_df[,1], colnames(TE_df)[-1]) %>% intersect(., colnames(PE_df)[-1]);
+
+if(length(common_samples)==0)
+{
+  stop("No common samples found ");
+  cat("<b>Please check your experiment design file. Sample names (column names) in the Transcriptome and the Proteome data do not match. </b>\n",file = htmloutfile, append = TRUE);
+}
+
+#===============================================================================
+# Create subsets based on common samples
+#===============================================================================
+TE_df =  select(TE_df, 1, common_samples);
+PE_df =  select(PE_df, 1, common_samples);
+sampleinfo_df = filter(sampleinfo_df, Sample %in% common_samples);
+rownames(sampleinfo_df) = sampleinfo_df[,1];
+
+#===============================================================================
+# Check for number of rows similarity
+#===============================================================================
+if(nrow(TE_df) != nrow(PE_df))
+{
+  stop("Number of rows in Transcriptome and Proteome data are not same i.e. they are not paired");
+  cat("<b>The correlation analysis expects paired TE and PE data i.e. (i)th gene/transcript of TE file should correspond to (i)th protein of PE file. In the current input provided there is mismatch in terms of number of rows of TE and PE file. Please make sure you provide paired data.</b>\n",file = htmloutfile, append = TRUE);
+}
+
+#===============================================================================
+# Number of groups
+#===============================================================================
+ngrps = unique(sampleinfo_df[,2]) %>% length();
+grps = unique(sampleinfo_df[,2]);
+names(grps) = grps;
+
+#===============================================================================
+# Change column1 name
+#===============================================================================
+colnames(TE_df)[1] = "Gene";
+colnames(PE_df)[1] = "Protein";
+
+#===============================================================================
+# Treat missing values
+#===============================================================================
+TE_nacount = sum(is.na(TE_df));
+PE_nacount = sum(is.na(PE_df));
+
+TE_df[is.na(TE_df)] = 0;
+PE_df[is.na(PE_df)] = 0;
+
+
+#===============================================================================
+# Decide based on analysis mode
+#===============================================================================
+if(mode=="logfold")
+{
+  cat('<h2 id="sample_dist"><font color=#ff0000>SAMPLE DISTRIBUTION</font></h2>\n',
+  file = htmloutfile, append = TRUE);
+  
+  # TE Boxplot
+  outplot = paste(outdir,"/Box_TE.png",sep="",collape="");
+  cat('<table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; ">\n',
+  '<tr bgcolor="#7a0019"><th><font color=#ffcc33>Boxplot: Transcriptome data</font></th><th><font color=#ffcc33>Boxplot: Proteome data</font></th></tr>\n',
+  "<tr><td align=center>", '<img src="Box_TE.png" width=500 height=500></td>\n', file = htmloutfile, append = TRUE);
+  multisample_boxplot(TE_df, sampleinfo_df, outplot, "Yes", "Samples", "Transcript Abundance data");
+  
+  # PE Boxplot
+  outplot = paste(outdir,"/Box_PE.png",sep="",collape="");
+  cat("<td align=center>", '<img src="Box_PE.png" width=500 height=500></td></tr></table>\n', file = htmloutfile, append = TRUE);
+  multisample_boxplot(PE_df, sampleinfo_df, outplot, "Yes", "Samples", "Protein Abundance data");
+  
+  cat('<hr/><h2 id="corr_data"><font color=#ff0000>CORRELATION</font></h2>\n',
+  file = htmloutfile, append = TRUE);
+  
+  # TE PE scatter
+  outplot = paste(outdir,"/TE_PE_scatter.png",sep="",collape="");
+  cat('<table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Scatter plot between Proteome and Transcriptome Abundance</font></th></tr>\n', file = htmloutfile, append = TRUE);
+  cat("<tr><td align=center>", '<img src="TE_PE_scatter.png" width=800 height=800></td></tr>\n', file = htmloutfile, append = TRUE);
+  PE_TE_data = data.frame(PE_df, TE_df);
+  colnames(PE_TE_data) = c("PE_ID","PE_abundance","TE_ID","TE_abundance");
+  singlesample_scatter(PE_TE_data, outplot);  
+  
+  # TE PE Cor
+  cat("<tr><td align=center>", file = htmloutfile, append = TRUE);
+  singlesample_cor(PE_TE_data, htmloutfile, append=TRUE);
+  cat('<font color="red">*Note that <u>correlation</u> is <u>sensitive to outliers</u> in the data. So it is important to analyze outliers/influential observations in the data.<br> Below we use <u>Cook\'s distance based approach</u> to identify such influential observations.</font>\n',
+    file = htmloutfile, append = TRUE);
+  cat('</td></table>',
+    file = htmloutfile, append = TRUE);
+  
+  cat('<hr/><h2 id="regression_data"><font color=#ff0000>REGRESSION ANALYSIS</font></h2>\n',
+  file = htmloutfile, append = TRUE);
+  
+  # TE PE Regression
+  singlesample_regression(PE_TE_data,htmloutfile, append=TRUE);
+  
+  cat('<hr/><h2 id="cluster_data"><font color=#ff0000>CLUSTER ANALYSIS</font></h2>\n',
+  file = htmloutfile, append = TRUE);
+  
+  # TE PE Heatmap
+  singlesample_heatmap(PE_TE_data, htmloutfile, hm_nclust);
+  
+  
+  # TE PE Clustering (kmeans)
+  singlesample_kmeans(PE_TE_data, htmloutfile, nclust=as.numeric(numCluster))
+  
+}else{
+  if(mode=="multiple")
+  {
+    cat('<h2 id="sample_dist"><font color=#ff0000>SAMPLE DISTRIBUTION</font></h2>\n',
+    file = htmloutfile, append = TRUE);
+    
+    # TE Boxplot
+    outplot = paste(outdir,"/Box_TE_all_rep.png",sep="",collape="");
+    cat('<table  border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; ">\n',
+    '<tr bgcolor="#7a0019"><th><font color=#ffcc33>Boxplot: Transcriptome data</font></th><th><font color=#ffcc33>Boxplot: Proteome data</font></th></tr>\n',
+    "<tr><td align=center>", '<img src="Box_TE_all_rep.png" width=500 height=500></td>\n', file = htmloutfile, append = TRUE);
+    temp_df_te_data = data.frame(TE_df[,1], log(TE_df[,2:length(TE_df)]));
+    colnames(temp_df_te_data) = colnames(TE_df);
+    multisample_boxplot(temp_df_te_data, sampleinfo_df, outplot, "Yes", "Samples", "Transcript Abundance (log)");
+    
+    # PE Boxplot
+    outplot = paste(outdir,"/Box_PE_all_rep.png",sep="",collape="");
+    cat("<td align=center>", '<img src="Box_PE_all_rep.png" width=500 height=500></td></tr></table>\n', file = htmloutfile, append = TRUE);
+    temp_df_pe_data = data.frame(PE_df[,1], log(PE_df[,2:length(PE_df)]));
+    colnames(temp_df_pe_data) = colnames(PE_df);
+    multisample_boxplot(temp_df_pe_data, sampleinfo_df, outplot, "Yes", "Samples", "Protein Abundance (log)");
+    
+    # Calc TE PCA
+    outplot = paste(outdir,"/PCA_TE_all_rep.png",sep="",collape="");
+    multisample_PCA(TE_df, sampleinfo_df, outplot);
+
+    # Calc PE PCA
+    outplot = paste(outdir,"/PCA_PE_all_rep.png",sep="",collape="");
+    multisample_PCA(PE_df, sampleinfo_df, outplot);
+    
+    
+    # Replicate mode
+    templist = mergeReplicates(TE_df,PE_df, sampleinfo_df, method);
+    TE_df = templist$TE_df_merged;
+    PE_df = templist$PE_df_merged;
+    sampleinfo_df = templist$sampleinfo_df_merged;
+    rownames(sampleinfo_df) = sampleinfo_df[,1];
+    
+    # TE Boxplot
+    outplot = paste(outdir,"/Box_TE_rep.png",sep="",collape="");
+    cat('<br><font color="#ff0000"><h3>Sample wise distribution (Box plot) after using ',method,' on replicates </h3></font><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Boxplot: Transcriptome data</font></th><th><font color=#ffcc33>Boxplot: Proteome data</font></th></tr>\n',
+    "<tr><td align=center>", '<img src="Box_TE_rep.png" width=500 height=500></td>\n', file = htmloutfile, append = TRUE);
+    temp_df_te_data = data.frame(TE_df[,1], log(TE_df[,2:length(TE_df)]));
+    colnames(temp_df_te_data) = colnames(TE_df);
+    multisample_boxplot(temp_df_te_data, sampleinfo_df, outplot, "No", "Sample Groups", "Mean Transcript Abundance (log)");
+
+    # PE Boxplot
+    outplot = paste(outdir,"/Box_PE_rep.png",sep="",collape="");
+    cat("<td align=center>", '<img src="Box_PE_rep.png" width=500 height=500></td></tr></table>\n', file = htmloutfile, append = TRUE);
+    temp_df_pe_data = data.frame(PE_df[,1], log(PE_df[,2:length(PE_df)]));
+    colnames(temp_df_pe_data) = colnames(PE_df);
+    multisample_boxplot(temp_df_pe_data, sampleinfo_df, outplot, "No", "Sample Groups", "Mean Protein Abundance (log)");
+
+    #===============================================================================
+    # Calculating log fold change and running the "single" code part 
+    #===============================================================================
+
+    TE_df = data.frame("Genes"=TE_df[,1], "LogFold"=apply(TE_df[,c(which(colnames(TE_df)==condition_g_name),which(colnames(TE_df)==control_g_name))],1,function(x) log(x[1]/x[2],base=2)));
+    PE_df = data.frame("Genes"=PE_df[,1], "LogFold"=apply(PE_df[,c(which(colnames(PE_df)==condition_g_name),which(colnames(PE_df)==control_g_name))],1,function(x) log(x[1]/x[2],base=2)));
+  
+      #===============================================================================
+      # Treat missing values
+      #===============================================================================
+  
+      TE_df[is.infinite(TE_df[,2]),2] = NA;
+      PE_df[is.infinite(PE_df[,2]),2] = NA;
+      TE_df[is.na(TE_df)] = 0;
+      PE_df[is.na(PE_df)] = 0;
+
+      sampleinfo_df = data.frame("Sample"= c("LogFold"), "Group"=c("Fold_Change"))
+      #===============================================================================
+      # Find common samples
+      #===============================================================================
+  
+      common_samples = intersect(sampleinfo_df[,1], colnames(TE_df)[-1]) %>% intersect(., colnames(PE_df)[-1]);
+      TE_df =  select(TE_df, 1, common_samples);
+      PE_df =  select(PE_df, 1, common_samples);
+      sampleinfo_df = filter(sampleinfo_df, Sample %in% common_samples);
+      rownames(sampleinfo_df) = sampleinfo_df[,1];
+  
+    # TE Boxplot
+    outplot = paste(outdir,"/Box_TE.png",sep="",collape="");
+    cat('<br><font color="#ff0000"><h3>Distribution (Box plot) of log fold change </h3></font>', file = htmloutfile, append = TRUE);
+    cat('<table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Boxplot: Transcriptome data</font></th><th><font color=#ffcc33>Boxplot: Proteome data</font></th></tr>\n',
+    "<tr><td align=center>", '<img src="Box_TE.png" width=500 height=500></td>\n', file = htmloutfile, append = TRUE);
+    multisample_boxplot(TE_df, sampleinfo_df, outplot, "Yes", "Sample (log2(case/control))", "Transcript Abundance fold-change (log2)");
+    
+    # PE Boxplot
+    outplot = paste(outdir,"/Box_PE.png",sep="",collape="");
+    cat("<td align=center>", '<img src="Box_PE.png" width=500 height=500></td></tr></table>\n', file = htmloutfile, append = TRUE);
+    multisample_boxplot(PE_df, sampleinfo_df, outplot, "Yes", "Sample (log2(case/control))", "Protein Abundance fold-change(log2)");
+    
+    
+    # Log Fold Data
+    perform_Test_Volcano(TE_df_orig,PE_df_orig,TE_df, PE_df,sampleinfo_df_orig,method,correction_method,volc_with)
+    
+    
+    
+    # Print PCA
+    
+    cat('<br><br><table  border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>PCA plot: Transcriptome data</font></th><th><font color=#ffcc33>PCA plot: Proteome data</font></th></tr>\n',
+    "<tr><td align=center>", '<img src="PCA_TE_all_rep.png" width=500 height=500></td>\n',
+    "<td align=center>", '<img src="PCA_PE_all_rep.png" width=500 height=500></td></tr></table>\n', 
+      file = htmloutfile, append = TRUE);
+    
+    
+    
+    cat('<hr/><h2 id="corr_data"><font color=#ff0000>CORRELATION</font></h2>\n',
+    file = htmloutfile, append = TRUE);
+    
+    # TE PE scatter
+    outplot = paste(outdir,"/TE_PE_scatter.png",sep="",collape="");
+    cat('<br><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Scatter plot between Proteome and Transcriptome Abundance</font></th></tr>\n', file = htmloutfile, append = TRUE);
+    cat("<tr><td align=center>", '<img src="TE_PE_scatter.png" width=800 height=800></td>\n', file = htmloutfile, append = TRUE);
+    PE_TE_data = data.frame(PE_df, TE_df);
+    colnames(PE_TE_data) = c("PE_ID","PE_abundance","TE_ID","TE_abundance");
+    singlesample_scatter(PE_TE_data, outplot);  
+
+    # TE PE Cor
+    cat("<tr><td align=center>\n", file = htmloutfile, append = TRUE);
+    singlesample_cor(PE_TE_data, htmloutfile, append=TRUE);
+    cat('<font color="red">*Note that <u>correlation</u> is <u>sensitive to outliers</u> in the data. So it is important to analyze outliers/influential observations in the data.<br> Below we use <u>Cook\'s distance based approach</u> to identify such influential observations.</font>\n',
+      file = htmloutfile, append = TRUE);
+    cat('</td></table>',
+    file = htmloutfile, append = TRUE);
+    
+    cat('<hr/><h2 id="regression_data"><font color=#ff0000>REGRESSION ANALYSIS</font></h2>\n',
+    file = htmloutfile, append = TRUE);
+    
+    # TE PE Regression
+    singlesample_regression(PE_TE_data,htmloutfile, append=TRUE);
+    
+    cat('<hr/><h2 id="cluster_data"><font color=#ff0000>CLUSTER ANALYSIS</font></h2>\n',
+    file = htmloutfile, append = TRUE);
+    
+    #TE PE Heatmap
+    singlesample_heatmap(PE_TE_data, htmloutfile, hm_nclust);
+    
+    #TE PE Clustering (kmeans)
+    singlesample_kmeans(PE_TE_data, htmloutfile, nclust=as.numeric(numCluster))
+    
+  }
+}
+cat("<h3>Go To:</h3>\n",
+    "<ul>\n",
+    "<li><a href=#sample_dist>Sample distribution</a></li>\n",
+    "<li><a href=#corr_data>Correlation</a></li>\n",
+    "<li><a href=#regression_data>Regression analysis</a></li>\n",
+    "<li><a href=#inf_obs>Influential observations</a></li>\n",
+    "<li><a href=#cluster_data>Cluster analysis</a></li></ul>\n",
+    "<br><a href=#>TOP</a>",
+    file = htmloutfile, append = TRUE);
+cat("</body></html>\n", file = htmloutfile, append = TRUE);
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/quantp.xml	Fri Sep 14 12:22:13 2018 -0400
@@ -0,0 +1,195 @@
+<tool id="quantp" name="QuanTP" version="1.0.0">
+    <description>Correlation between protein and transcript abundances</description>
+    <requirements>
+        <requirement type="package" version="1.10.4">r-data.table</requirement>
+        <requirement type="package" version="3.0.1">r-gplots</requirement>
+        <requirement type="package" version="0.7.6">r-dplyr</requirement>
+        <requirement type="package" version="3.0.0">r-ggplot2</requirement>
+        <requirement type="package" version="0.4.5">r-ggfortify</requirement>
+    </requirements>
+    <command detect_errors="exit_code"><![CDATA[
+Rscript '$__tool_directory__/quantp.r' 
+    $experiment_design_option.sample_type 
+    $experiment_design_option.method_type 
+    $experiment_design_option.exp_design 
+    '$pe_exp' 
+    '$te_exp' 
+    $experiment_design_option.correction_method 
+    $cooksd_upper 
+    $nclust 
+    $hm_nclust 
+    $experiment_design_option.volcano_with 
+    '$html_file' 
+    '$html_file.files_path'
+]]></command>
+    <inputs>
+        <param name="pe_exp" type="data" format="tabular" label="Input Protein Abundance File" help="Protein abundance input file"/>
+        <param name="te_exp" type="data" format="tabular" label="Input RNA Abundance File" help="Transcript abundance input file"/>
+        <conditional name="experiment_design_option">
+            <param name="sample_type" type="select" label="Select data input type" help="If the input files already have fold-change values, select Log fold-change. Else, select abundances and the tool will perform the fold-change analysis">
+                <option value="multiple" selected="True">Abundances from different conditions with or without replicates (in multiple columns)</option>
+                <option value="logfold">Log fold-change values (or single condition abundance without replicates in single column) data</option>
+            </param>
+            <when value="logfold">
+                <param name="exp_design" type="hidden" value="none" />
+                <param name="method_type" type="hidden" value="none" />
+                <param name="correction_method" type="hidden" value="none" />
+                <param name="volcano_with" type="hidden" value="pval" />
+            </when>
+            <when value="multiple">
+                <param name="exp_design" type="data" format="tabular" help="Please check the format of the experiment design file">
+                    <label>Experiment design File (Please see the format below)</label>
+                </param>
+                <param name="method_type" type="select" label="Data summarization method" help="Perform T-Test on selecting Mean; Wilcoxon Ranksum Test on selecting Median">
+                    <option value="mean" selected="True">Mean (Default)</option>
+                    <option value="median">Median</option>
+                </param>
+                <param name="correction_method" type="select" label="Multiple testing correction method">
+                    <option value="BH" selected="True">Benjamini and Hochberg (BH) (Default)</option>
+                    <option value="holm">Holm</option>
+                    <option value="hochberg">Hochberg</option>
+                    <option value="hommel">Hommel</option>
+                    <option value="bonferroni">Bonferroni</option>
+                    <option value="BY">Benjamini and Yekutieli (BY)</option>
+                    <option value="none">None</option>
+                </param>
+                <param name="volcano_with" type="select" display="radio" label="Volcano plot with p-value or adjusted p-value">
+                    <option value="pval" selected="True">P-value (Default)</option>
+                    <option value="adj_pval">Adjusted P-value</option>
+                </param>
+            </when>
+        </conditional>
+        <param name="cooksd_upper" type="integer" value="4" optional="false" >
+            <label>Influential Observation cutoff: Observations > value * mean of Cook's distances (Default: "4" * mean(Cook's Distance))</label>
+        </param>
+        <param name="nclust" type="select" label="K-mean clustering: Number of clusters">
+            <option value="1">1</option>
+            <option value="2">2</option>
+            <option value="3">3</option>
+            <option value="4" selected="True">4</option>
+            <option value="5">5</option>
+            <option value="6">6</option>
+            <option value="7">7</option>
+            <option value="8">8</option>
+            <option value="9">9</option>
+            <option value="10">10</option>
+        </param>
+      
+        <param name="hm_nclust" type="select" label="Hierarchical clustering: Number of clusters (from Heatmap)">
+            <option value="1">1</option>
+            <option value="2">2</option>
+            <option value="3">3</option>
+            <option value="4">4</option>
+            <option value="5" selected="True">5</option>
+            <option value="6">6</option>
+            <option value="7">7</option>
+            <option value="8">8</option>
+            <option value="9">9</option>
+            <option value="10">10</option>
+        </param>
+    </inputs>
+    <outputs>
+        <data format="html" name="html_file" label="protein transcript correlation on ${pe_exp.name} and ${te_exp.name}"/>
+    </outputs>
+    <tests>
+        <test>
+            <conditional name="experiment_design_option">
+                <param name="sample_type" value="multiple"/>
+                <param name="method_type" value="mean"/>
+                <param name="exp_design" value="exp_design_file.tabular" ftype="tabular" />
+                <param name="correction_method" value="BH"/>
+                <param name="volcano_with" value="pval"/>
+            </conditional>
+            <param name="pe_exp" value="protein_data.tabular" ftype="tabular" />
+            <param name="te_exp" value="transcript_data.tabular" ftype="tabular" />
+            <param name="cooksd_upper" value="4"/>
+            <param name="nclust" value="4"/>
+            <param name="hm_nclust" value="5"/>
+            <output name="html_file">
+                <assert_contents>
+                    <has_text text="SAMPLE DISTRIBUTION" />
+                </assert_contents>
+            </output>
+        </test>
+    </tests>
+    <help><![CDATA[
+
+**What it does**
+
+QuanTP correlates *transcript abundance* and *protein abundance* to examine the association between them.
+
+It either takes in the log fold-change of abundances as input or raw abundances from different conditions where it calculates the log ratios of abundances between two conditions.
+
+Transcript input file can be generated from the quantitative RNA-Seq study whereas Protein input file can be generated from quantitative analysis of mass-spectrometry-based protein data.
+
+-----
+
+**Input file formats**
+
+**Protein data file**
+
+First column - Gene
+
+Following columns - Abundance values (or log fold-change values)
+
+Example of Protein input file
+
+====== ========= ========= ========= ========= ========= ========= ========= =========
+Gene   sample1   sample2   sample3   sample4   sample5   sample6   sample7   sample8
+------ --------- --------- --------- --------- --------- --------- --------- ---------
+GeneX  value     value     value     value     value     value     value     value    
+GeneY  value     value     value     value     value     value     value     value    
+GeneZ  value     value     value     value     value     value     value     value    
+====== ========= ========= ========= ========= ========= ========= ========= =========
+
+
+**Transcript data file**
+
+First column - Gene
+
+Following columns - Abundance values (or log fold-change values)
+
+Example of Transcript input file
+
+====== ========= ========= ========= ========= ========= ========= ========= =========
+Gene   sample1   sample2   sample3   sample4   sample5   sample6   sample7   sample8 
+------ --------- --------- --------- --------- --------- --------- --------- ---------
+GeneX  value     value     value     value     value     value     value     value    
+GeneY  value     value     value     value     value     value     value     value    
+GeneZ  value     value     value     value     value     value     value     value    
+====== ========= ========= ========= ========= ========= ========= ========= =========
+
+
+**Data input type**
+
+If data input type is abundance, experiment design file is required.
+
+Example of experiment design file
+
+======== =========
+case     groupA   
+control  groupB   
+sample1  groupA   
+sample2  groupA   
+sample3  groupA   
+sample4  groupA   
+sample5  groupB   
+sample6  groupB   
+sample7  groupB   
+sample8  groupB   
+======== =========
+
+Note: No title/header in experiment design file and the first two lines of the experiment design must have keyword "case" and "control"
+
+  ]]>
+  </help>
+  <citations>
+        <citation type="bibtex">
+@misc{QuanTP: A software resource for quantitative proteo-transcriptomic comparative data analysis and informatics,
+    author={Praveen Kumar, Priyabrata Panigrahi, James Johnson, Wanda Weber, Subina Mehta, Ray Sajulga, Caleb Easterly, Brian Crooker, Mohammad Heydarian, Krishanpal Anamika, Timothy Griffin, and Pratik Jagtap},
+    year={2018},
+    title={QuanTP}
+}
+        </citation>
+    </citations>
+</tool>
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/exp_design_file.tabular	Fri Sep 14 12:22:13 2018 -0400
@@ -0,0 +1,6 @@
+case	G1
+control	G2
+D03_01	G1
+D03_02	G1
+M14_01	G2
+M14_02	G2
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/output.html	Fri Sep 14 12:22:13 2018 -0400
@@ -0,0 +1,155 @@
+<html><head></head><body>
+<h1><u>QuanTP: Association between abundance ratios of transcript and protein</u></h1><hr/>
+ <font><h3>Input data summary</h3></font>
+ <ul>
+ <li>Abbreviations used: PE (Proteome data) and TE (Transcriptome data) </li><br>
+ <li>Input Proteome data dimension (Row Column):  2817  x  5 </li>
+ <li>Input Transcriptome data dimension (Row Column):  2817  x  5 </li></ul><hr/>
+<h3 id=table_of_content>Table of Contents:</h3>
+ <ul>
+ <li><a href=#sample_dist>Sample distribution</a></li>
+ <li><a href=#corr_data>Correlation</a></li>
+ <li><a href=#regression_data>Regression analysis</a></li>
+ <li><a href=#inf_obs>Influential observations</a></li>
+ <li><a href=#cluster_data>Cluster analysis</a></li></ul><hr/>
+<h2 id="sample_dist"><font color=#ff0000>SAMPLE DISTRIBUTION</font></h2>
+<table  border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; ">
+ <tr bgcolor="#7a0019"><th><font color=#ffcc33>Boxplot: Transcriptome data</font></th><th><font color=#ffcc33>Boxplot: Proteome data</font></th></tr>
+ <tr><td align=center> <img src="Box_TE_all_rep.png" width=500 height=500></td>
+<td align=center> <img src="Box_PE_all_rep.png" width=500 height=500></td></tr></table>
+<br><font color="#ff0000"><h3>Sample wise distribution (Box plot) after using  mean  on replicates </h3></font><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Boxplot: Transcriptome data</font></th><th><font color=#ffcc33>Boxplot: Proteome data</font></th></tr>
+ <tr><td align=center> <img src="Box_TE_rep.png" width=500 height=500></td>
+<td align=center> <img src="Box_PE_rep.png" width=500 height=500></td></tr></table>
+<br><font color="#ff0000"><h3>Distribution (Box plot) of log fold change </h3></font><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Boxplot: Transcriptome data</font></th><th><font color=#ffcc33>Boxplot: Proteome data</font></th></tr>
+ <tr><td align=center> <img src="Box_TE.png" width=500 height=500></td>
+<td align=center> <img src="Box_PE.png" width=500 height=500></td></tr></table>
+<br><br><font size=5><b><a href='PE_TE_logfold_pval.txt' target='_blank'>Download the complete fold change data here</a></b></font><br>
+<br><table  border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Transcript Fold-Change</font></th><th><font color=#ffcc33>Protein Fold-Change</font></th></tr>
+<tr><td align=center> <img src="TE_volcano.png" width=600 height=600></td>
+<td align=center> <img src="PE_volcano.png" width=600 height=600></td></tr></table><br>
+<br><br><table  border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>PCA plot: Transcriptome data</font></th><th><font color=#ffcc33>PCA plot: Proteome data</font></th></tr>
+ <tr><td align=center> <img src="PCA_TE_all_rep.png" width=500 height=500></td>
+ <td align=center> <img src="PCA_PE_all_rep.png" width=500 height=500></td></tr></table>
+<hr/><h2 id="corr_data"><font color=#ff0000>CORRELATION</font></h2>
+<br><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Scatter plot between Proteome and Transcriptome Abundance</font></th></tr>
+<tr><td align=center> <img src="TE_PE_scatter.png" width=800 height=800></td>
+<tr><td align=center>
+<table  border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Parameter</font></th><th><font color=#ffcc33>Method 1</font></th><th><font color=#ffcc33>Method 2</font></th><th><font color=#ffcc33>Method 3</font></th></tr>
+<tr><td>Correlation method</td><td> Pearson's product-moment correlation </td><td> Spearman's rank correlation rho </td><td> Kendall's rank correlation tau </td></tr>
+ <tr><td>Correlation coefficient</td><td> 0.1173569 </td><td> 0.1608612 </td><td> 0.1093701 </td></tr>
+</table>
+<font color="red">*Note that <u>correlation</u> is <u>sensitive to outliers</u> in the data. So it is important to analyze outliers/influential observations in the data.<br> Below we use <u>Cook's distance based approach</u> to identify such influential observations.</font>
+</td></table><hr/><h2 id="regression_data"><font color=#ff0000>REGRESSION ANALYSIS</font></h2>
+<font><h3>Linear Regression model fit between Proteome and Transcriptome data</h3></font>
+ <p>Assuming a linear relationship between Proteome and Transcriptome data, we here fit a linear regression model.</p>
+ <table  border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Parameter</font></th><th><font color=#ffcc33>Value</font></th></tr>
+<tr><td>Formula</td><td> PE_abundance~TE_abundance </td></tr>
+ <tr><td colspan='2' align='center'> <b>Coefficients</b></td> </tr>
+ <tr><td> (Intercept) </td><td> -0.06910598  (Pvalue: 1.220723e-05 ) </td></tr>
+ <tr><td> TE_abundance </td><td> 0.1712395  (Pvalue: 4.168015e-10 ) </td></tr>
+ <tr><td colspan='2' align='center'> <b>Model parameters</b></td> </tr>
+ <tr><td>Residual standard error</td><td> 0.8363295  ( 2815  degree of freedom)</td></tr>
+ <tr><td>F-statistic</td><td> 39.31142  ( on  1  and   2815  degree of freedom)</td></tr>
+ <tr><td>R-squared</td><td> 0.01377265 </td></tr>
+ <tr><td>Adjusted R-squared</td><td> 0.0134223 </td></tr>
+</table>
+<font color='#ff0000'><h3>Regression and diagnostics plots</h3></font>
+<table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "><tr bgcolor="#7a0019"><th> <font color='#ffcc33'><h4>1) <u>Residuals vs Fitted plot</h4></font></u></th>
+ <th><font color=#ffcc33><h4>2) <u>Normal Q-Q plot of residuals</h4></font></u></th></tr>
+<tr><td align=center><img src="PE_TE_lm_1.png" width=600 height=600></td><td align=center><img src="PE_TE_lm_2.png" width=600 height=600></td></tr>
+<tr><td align=center>This plot checks for linear relationship assumptions.<br>If a horizontal line is observed without any distinct patterns, it indicates a linear relationship.</td>
+ <td align=center>This plot checks whether residuals are normally distributed or not.<br>It is good if the residuals points follow the straight dashed line i.e., do not deviate much from dashed line.</td></tr></table>
+<br><h2 id="inf_obs"><font color=#ff0000>Outliers based on the residuals from regression analysis</font></h2>
+<table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; ">
+ <tr bgcolor="#7a0019"><th colspan=2><font color=#ffcc33>Residuals from Regression</font></th></tr>
+ <tr bgcolor="#7a0019"><th><font color=#ffcc33>Parameter</font></th><th><font color=#ffcc33>Value</font></th></tr>
+<tr><td>Mean Residual value</td><td> 1.942328e-17 </td></tr>
+ <tr><td>Standard deviation (Residuals)</td><td> 0.836181 </td></tr>
+ <tr><td>Total outliers (Residual value > 2 standard deviation from the mean)</td><td> 164  <font size=4>(<b><a href=PE_TE_outliers_residuals.txt target="_blank">Download these  164  data points with high residual values here</a></b>)</font></td>
+ <tr><td colspan=2 align=center><font size=4>(<b><a href=PE_TE_abundance_residuals.txt target="_blank">Download the complete residuals data here</a></b>)</font></td></td>
+ </table><br><br>
+<br><br><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "><tr bgcolor="#7a0019"><th><font color=#ffcc33><h4>3) <u>Residuals vs Leverage plot</h4></font></u></th></tr>
+<tr><td align=center><img src="PE_TE_lm_5.png" width=600 height=600></td></tr>
+<tr><td align=center>This plot is useful to identify any influential cases, that is outliers or extreme values.<br>They might influence the regression results upon inclusion or exclusion from the analysis.</td></tr></table><br>
+<hr/><h2 id="inf_obs"><font color=#ff0000>INFLUENTIAL OBSERVATIONS</font></h2>
+<p><b>Cook's distance</b> computes the influence of each data point/observation on the predicted outcome. i.e. this measures how much the observation is influencing the fitted values.<br>In general use, those observations that have a <b>Cook's distance > than  4  times the mean</b> may be classified as <b>influential.</b></p>
+<img src="PE_TE_lm_cooksd.png" width=800 height=800> <br>In the above plot, observations above red line ( 4  * mean Cook's distance) are influential. Genes that are outliers could be important. These observations influences the correlation values and regression coefficients<br><br><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Parameter</font></th><th><font color=#ffcc33>Value</font></th></tr>
+<tr><td>Mean Cook's distance</td><td> 0.0004875011 </td></tr>
+ <tr><td>Total influential observations (Cook's distance >  4  * mean Cook's distance)</td><td> 115 </td>
+ <tr><td>Observations with Cook's distance <  4  * mean Cook's distance</td><td> 2702 </td>
+ </table><br><br>
+<table  border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Scatterplot: Before removal</font></th><th><font color=#ffcc33>Scatterplot: After removal</font></th></tr>
+<tr><td align=center><!--<font color='#ff0000'><h3>Scatter plot between Proteome and Transcriptome Abundance</h3></font>
+--> <img src="TE_PE_scatter.png" width=600 height=600></td>
+<td align=center>
+ <img src="AbundancePlot_scatter_without_outliers.png" width=600 height=600></td></tr>
+<tr><td>
+<table  border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Parameter</font></th><th><font color=#ffcc33>Method 1</font></th><th><font color=#ffcc33>Method 2</font></th><th><font color=#ffcc33>Method 3</font></th></tr>
+<tr><td>Correlation method</td><td> Pearson's product-moment correlation </td><td> Spearman's rank correlation rho </td><td> Kendall's rank correlation tau </td></tr>
+ <tr><td>Correlation coefficient</td><td> 0.1173569 </td><td> 0.1608612 </td><td> 0.1093701 </td></tr>
+</table>
+</td>
+<td><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Parameter</font></th><th><font color=#ffcc33>Method 1</font></th><th><font color=#ffcc33>Method 2</font></th><th><font color=#ffcc33>Method 3</font></th></tr>
+<tr><td>Correlation method</td><td> Pearson's product-moment correlation </td><td> Spearman's rank correlation rho </td><td> Kendall's rank correlation tau </td></tr>
+ <tr><td>Correlation coefficient</td><td> 0.1334038 </td><td> 0.1611936 </td><td> 0.1082761 </td></tr>
+</table></td></tr></table>
+<br><br><font size=5><b><a href='PE_TE_influential_observation.txt' target='_blank'>Download the complete list of influential observations</a></b></font>&nbsp;&nbsp;&nbsp;&nbsp; <font size=5><b><a href='PE_TE_non_influential_observation.txt' target='_blank'>Download the complete list (After removing influential points)</a></b></font><br>
+ <br><font color="brown"><h4>Top  10  Influential observations (Cook's distance >  4  * mean Cook's distance)</h4></font>
+<table border=1 cellspacing=0 cellpadding=5> <tr bgcolor="#7a0019">
+<th><font color=#ffcc33>Gene</font></th><th><font color=#ffcc33>Protein Log Fold-Change</font></th><th><font color=#ffcc33>Transcript Log Fold-Change</font></th><th><font color=#ffcc33>Cook's Distance</font></th></tr>
+<tr> <td> CATHL2 </td>
+ <td> -1.960863 </td>
+ <td> 4.88565 </td>
+ <td> 0.1432189 </td></tr>
+<tr> <td> CD177 </td>
+ <td> -4.173263 </td>
+ <td> 2.057499 </td>
+ <td> 0.06826605 </td></tr>
+<tr> <td> CATHL1 </td>
+ <td> -0.9912973 </td>
+ <td> 4.835209 </td>
+ <td> 0.05767091 </td></tr>
+<tr> <td> HP </td>
+ <td> 2.570727 </td>
+ <td> 3.885549 </td>
+ <td> 0.04680496 </td></tr>
+<tr> <td> AZU1 </td>
+ <td> -2.226356 </td>
+ <td> -5.561874 </td>
+ <td> 0.03737565 </td></tr>
+<tr> <td> ELANE </td>
+ <td> -2.732479 </td>
+ <td> -2.914936 </td>
+ <td> 0.03266198 </td></tr>
+<tr> <td> PYGM </td>
+ <td> -0.06079228 </td>
+ <td> 6.071712 </td>
+ <td> 0.03242859 </td></tr>
+<tr> <td> LTF </td>
+ <td> -2.4294 </td>
+ <td> 2.129742 </td>
+ <td> 0.02725017 </td></tr>
+<tr> <td> ATP1A2 </td>
+ <td> 0.2871971 </td>
+ <td> 6.446299 </td>
+ <td> 0.01939256 </td></tr>
+<tr> <td> C13H20orf194 </td>
+ <td> -5.640732 </td>
+ <td> -0.6697401 </td>
+ <td> 0.01852927 </td></tr>
+</table><br><br>
+<hr/><h2 id="cluster_data"><font color=#ff0000>CLUSTER ANALYSIS</font></h2>
+<br><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>Heatmap of PE and TE abundance values (Hierarchical clustering)</font></th><th><font color=#ffcc33>Number of clusters to extract:  5 </font></th></tr>
+<tr><td align=center colspan="2"><img src="PE_TE_heatmap.png" width=800 height=800></td></tr>
+<tr><td colspan="2" align=center><font size=5><a href="PE_TE_hc_clusterpoints.txt" target="_blank"><b>Download the hierarchical cluster list</b></a></font></td></tr></table>
+<br><br><table border=1 cellspacing=0 cellpadding=5 style="table-layout:auto; "> <tr bgcolor="#7a0019"><th><font color=#ffcc33>K-mean clustering</font></th><th><font color=#ffcc33>Number of clusters:  4 </font></th></tr>
+<tr><td colspan="2" align=center><img src="PE_TE_kmeans.png" width=800 height=800></td></tr>
+<tr><td colspan="2" align=center><font size=5><a href="PE_TE_kmeans_clusterpoints.txt" target="_blank"><b>Download the cluster list</b></a></font></td></tr></table><br><hr/>
+<h3>Go To:</h3>
+ <ul>
+ <li><a href=#sample_dist>Sample distribution</a></li>
+ <li><a href=#corr_data>Correlation</a></li>
+ <li><a href=#regression_data>Regression analysis</a></li>
+ <li><a href=#inf_obs>Influential observations</a></li>
+ <li><a href=#cluster_data>Cluster analysis</a></li></ul>
+ <br><a href=#>TOP</a></body></html>
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/protein_data.tabular	Fri Sep 14 12:22:13 2018 -0400
@@ -0,0 +1,2818 @@
+Gene	D03_01	D03_02	M14_01	M14_02
+ELANE	90604000.0	100390000.0	623380000.0	645960000.0
+AGL	976501500.0	960830000.0	697130000.0	719100000.0
+AGK	19878000.0	16422000.0	15565000.0	20390000.0
+HSPA6	67707000.0	176540000.0	117020000.0	121110000.0
+HSPA5	11009000000.0	6568200000.0	4795000000.0	5734100000.0
+HSPA4	117790000.0	30519000.0	90678000.0	87974000.0
+HSPA9	3544300000.0	3817500000.0	2235000000.0	2270700000.0
+HSPA8	7526200000.0	7289900000.0	3520000000.0	4052400000.0
+AGA	240460000.0	291780000.0	221830000.0	173620000.0
+LGALS3	186500000.0	258100000.0	242190000.0	301190000.0
+CSNK2A2	132720000.0	155250000.0	150050000.0	161600000.0
+PMM2	1632800000.0	1802500000.0	1614800000.0	1711000000.0
+PMM1	0.0	10979000.0	8686700.0	6732400.0
+ASS1	18134000000.0	18876000000.0	12966000000.0	12270000000.0
+SPR	1922200000.0	1865500000.0	1698600000.0	1728400000.0
+RNF114	183640000.0	174460000.0	178010000.0	173870000.0
+UCHL3	274130000.0	282050000.0	254500000.0	274000000.0
+ENSBTAG00000047256	57543000.0	71609000.0	71386000.0	61095000.0
+ABCD3	55147000.0	49370000.0	55492000.0	45594000.0
+SCLY	299950000.0	329280000.0	324400000.0	272070000.0
+DHX9	213070000.0	112580000.0	88925000.0	91000000.0
+OSGEP	601030000.0	575840000.0	580200000.0	637320000.0
+NUP98	2508700.0	0.0	6975000.0	9160400.0
+PPP2R2B	29533000.0	27090000.0	35168000.0	28130000.0
+GOLIM4	55757000.0	13447000.0	28969000.0	24689000.0
+ENSBTAG00000039928	20107200000.0	17840800000.0	22329600000.0	21414400000.0
+OPA3	238630000.0	258440000.0	236320000.0	194580000.0
+OPA1	170770000.0	88756000.0	124230000.0	135980000.0
+PIK3C3	624380.0	0.0	0.0	0.0
+GK	79958000.0	91689000.0	55521000.0	67336000.0
+PTRH2	630860000.0	635300000.0	792900000.0	721580000.0
+HNRNPDL	184260000.0	197110000.0	180510000.0	178040000.0
+ENSBTAG00000024233	6670900000.0	7453900000.0	5794600000.0	6289800000.0
+TRAPPC3	350960000.0	386150000.0	288830000.0	254040000.0
+TRAPPC5	110960000.0	91402000.0	94205000.0	99412000.0
+ACLY	121870000.0	11334000.0	52304000.0	57826000.0
+CTBP2	134900000.0	121550000.0	139080000.0	127730000.0
+ITGA9	2480600.0	0.0	0.0	0.0
+ENSBTAG00000021558	0.0	0.0	0.0	0.0
+HACL1	3750000000.0	4002800000.0	4908400000.0	5092300000.0
+ITGA1	1398200.0	0.0	0.0	0.0
+NOP2	4928000.0	0.0	0.0	0.0
+ITGA6	97078000.0	42673000.0	116280000.0	130990000.0
+PDCD10	142700000.0	124020000.0	194810000.0	170930000.0
+ENSBTAG00000014423	100010000.0	99218000.0	191870000.0	184010000.0
+EDC4	10047000.0	6662500.0	0.0	13081000.0
+APOA4	5577600000.0	5684300000.0	2510700000.0	2632000000.0
+APOA5	257940000.0	333300000.0	197140000.0	201230000.0
+UFSP2	8208200.0	6119600.0	0.0	7495400.0
+XPO1	6101300.0	0.0	21163000.0	15852000.0
+CSDE1	6845000.0	10436000.0	29616000.0	35114000.0
+XPO7	1621500.0	0.0	13304000.0	5299000.0
+MRPL28	82108000.0	97797000.0	62910000.0	50735000.0
+TIPRL	223950000.0	199410000.0	192400000.0	118190000.0
+LSS	346220000.0	249770000.0	234680000.0	220640000.0
+PSMG2	66523000.0	96697000.0	25795000.0	29839000.0
+GHDC	24907000.0	27587000.0	38327000.0	43611000.0
+COL4A2	116880000.0	133790000.0	113920000.0	117830000.0
+COL4A1	145000000.0	165870000.0	135390000.0	135500000.0
+MOGAT1	23667000.0	33273000.0	24912000.0	38349000.0
+RBM12B	2074800.0	0.0	2384000.0	3078100.0
+GART	497380000.0	153590000.0	363030000.0	301340000.0
+GARS	14525000.0	0.0	35874000.0	22116000.0
+PSMD14	416870000.0	577850000.0	409550000.0	320620000.0
+ATAD1	429390000.0	455220000.0	383550000.0	484670000.0
+PSMD10	52335000.0	25236000.0	32444000.0	40355000.0
+PSMD13	1450700000.0	1441200000.0	1525200000.0	1463400000.0
+PSMD12	16339000.0	14892000.0	22908000.0	29622000.0
+ENSBTAG00000039321	939690.0	0.0	0.0	9768400.0
+FTCD	2776600000.0	2757000000.0	3259800000.0	3388300000.0
+GIT1	1902600.0	0.0	1368700.0	0.0
+SERBP1	70643000.0	58520000.0	63639000.0	60842000.0
+PPP4C	40084000.0	147770000.0	127090000.0	154860000.0
+OCRL	2204200.0	0.0	2652100.0	0.0
+GANAB	1342100000.0	362290000.0	592930000.0	651410000.0
+NUP133	506790.0	0.0	3742200.0	4045600.0
+LRPAP1	91487000.0	84230000.0	35103000.0	65126000.0
+VAPB	997680000.0	1018000000.0	1556300000.0	1647900000.0
+VAPA	1386600000.0	1518300000.0	1349600000.0	1252800000.0
+SHROOM1	5030600.0	0.0	0.0	7964200.0
+NDUFAF6	42874000.0	55512000.0	57678000.0	38059000.0
+MTIF3	105690000.0	122720000.0	103820000.0	87694000.0
+MIOS	2457000.0	0.0	0.0	0.0
+SNTB2	20388000.0	14076000.0	18128000.0	16156000.0
+IGF2R	27998000.0	5516500.0	2374800.0	0.0
+CTH	409230000.0	431710000.0	319960000.0	371070000.0
+ARL6IP1	21143000.0	75315000.0	28387000.0	107280000.0
+SPART	2390600.0	0.0	0.0	0.0
+ABHD14B	14750000000.0	13104000000.0	19532000000.0	19336000000.0
+NECAP2	15456000.0	16744000.0	49493000.0	30865000.0
+ARF4	121490000.0	160450000.0	88446000.0	64683000.0
+FAHD1	819630000.0	809200000.0	778190000.0	756100000.0
+ENSBTAG00000009622	0.0	0.0	0.0	0.0
+AP3D1	1363000.0	0.0	0.0	0.0
+EIF4B	19344000.0	10687000.0	24139000.0	10856000.0
+ZSWIM2	33653000.0	58920000.0	34138000.0	52336000.0
+ENOPH1	306200000.0	350650000.0	429480000.0	443590000.0
+SULT1A1	40564000000.0	41927000000.0	45069000000.0	47894000000.0
+TCEA1	37826000.0	40868000.0	24264000.0	21920000.0
+COX4I1	158000000.0	167970000.0	170600000.0	185850000.0
+PRKAR1A	31080000.0	32496000.0	43949000.0	55932000.0
+MOB2	48613000.0	49291000.0	43029000.0	46282000.0
+SAR1A	271310000.0	293370000.0	211060000.0	290000000.0
+SAR1B	1734000000.0	1716700000.0	1811800000.0	1703200000.0
+NIPSNAP2	330440000.0	405490000.0	367500000.0	377650000.0
+NIPSNAP1	19276000000.0	18856000000.0	18877000000.0	18937000000.0
+PIPOX	625330000.0	653730000.0	645380000.0	575450000.0
+GAA	63738000.0	62018000.0	44322000.0	49582000.0
+FGL1	493960000.0	569280000.0	681940000.0	617400000.0
+METTL27	27892000.0	39372000.0	28430000.0	46040000.0
+METTL26	1687400000.0	1635700000.0	1902400000.0	1944000000.0
+SPP2	119260000.0	137280000.0	172700000.0	152690000.0
+DDAH1	2547900000.0	2490000000.0	2409000000.0	2902700000.0
+SPHK2	24051000.0	19238000.0	12814000.0	17246000.0
+IFIH1	1711500.0	0.0	4157300.0	3620000.0
+DPT	151390000.0	167460000.0	260330000.0	286890000.0
+IPO11	1149900.0	0.0	0.0	0.0
+EEF1A1	8212600000.0	8517700000.0	7258600000.0	7119400000.0
+HMGB1	1081100000.0	1489500000.0	1323400000.0	1028700000.0
+NADSYN1	113770000.0	6961900.0	109690000.0	110230000.0
+FYCO1	25519000.0	32137000.0	0.0	0.0
+RAB2A	772460000.0	719200000.0	756150000.0	790920000.0
+RAB2B	25114000.0	16463000.0	0.0	0.0
+SRBD1	1105900.0	0.0	0.0	0.0
+ABAT	1164400000.0	1258700000.0	1034100000.0	1102200000.0
+ARHGEF2	5098900.0	8141700.0	8172000.0	11913000.0
+NFX1	5866900.0	0.0	6979000.0	8153300.0
+WDR45B	21886000.0	27828000.0	23068000.0	25707000.0
+DPYD	667600000.0	61144000.0	619680000.0	572518000.0
+AASS	169070000.0	52588000.0	81150000.0	76897000.0
+RDH5	15451000000.0	14009000000.0	16861000000.0	16638000000.0
+PEX14	23261000.0	27303000.0	29377000.0	95545000.0
+DPYS	7830700000.0	8062815000.0	9949728000.0	9439800000.0
+CLIP1	2594500.0	0.0	2500000.0	0.0
+ERAP2	2604600.0	0.0	7113200.0	5801100.0
+TIMM50	588350000.0	686280000.0	763690000.0	843270000.0
+ENSBTAG00000047529	941830000.0	1089800000.0	1011300000.0	1196300000.0
+DHRS7B	626430000.0	670140000.0	913450000.0	926770000.0
+CD46	31723000.0	38202000.0	19874000.0	31461000.0
+DMTN	3362400.0	0.0	10056000.0	0.0
+HIKESHI	279860000.0	249990000.0	92320000.0	92610000.0
+FPGT	0.0	0.0	0.0	10602000.0
+RAB21	722400000.0	730850000.0	617560000.0	708770000.0
+CFH	13710300.0	14328000.0	0.0	0.0
+PNP	17400000000.0	16460000000.0	13607000000.0	14151000000.0
+CALR	1951500000.0	2309300000.0	2060400000.0	1938700000.0
+CYB5A	43743000000.0	40782000000.0	43377000000.0	44614000000.0
+CYB5B	767030000.0	881930000.0	1064100000.0	1331500000.0
+NGP	0.0	20004000.0	90822000.0	76152000.0
+PIK3CB	720850.0	0.0	0.0	0.0
+HNRNPUL2	105420000.0	0.0	72945000.0	81483000.0
+ACTR1A	45179000.0	31150000.0	20313000.0	14220000.0
+PNN	80190000.0	15072000.0	18783000.0	9707700.0
+CHID1	237290000.0	249810000.0	215450000.0	208540000.0
+EWSR1	5933000.0	0.0	0.0	4365900.0
+PCK2	12761000000.0	13602000000.0	11250000000.0	11005000000.0
+RPN1	728920000.0	757820000.0	718510000.0	740780000.0
+TRIM13	10152000.0	0.0	0.0	0.0
+PCK1	4050800000.0	3979100000.0	2518500000.0	2623000000.0
+NTAN1	258360000.0	222820000.0	312640000.0	263420000.0
+NQO2	6187900000.0	6361700000.0	6594700000.0	7359800000.0
+NQO1	904130000.0	1059600000.0	746650000.0	832030000.0
+PRPF8	5955400.0	0.0	0.0	0.0
+CYP4F2	101860000.0	81436000.0	86279000.0	119150000.0
+PRPF6	11063000.0	0.0	15397000.0	13579000.0
+SAO	104140000.0	36364000.0	83749000.0	68739000.0
+CD177	2571100.0	0.0	22693000.0	23694000.0
+ESRP2	31452000.0	25819000.0	24752000.0	37392000.0
+CNPY4	78288000.0	107650000.0	113610000.0	105110000.0
+CNPY3	167770000.0	194140000.0	207030000.0	200080000.0
+CNPY2	732560000.0	947190000.0	440440000.0	500820000.0
+UFD1	126730000.0	145240000.0	95194000.0	111810000.0
+HDGF	68326000.0	73505000.0	81632000.0	92286000.0
+PIP4K2A	10673000.0	10341000.0	9843900.0	12262000.0
+PIP4K2B	67126000.0	87265000.0	102820000.0	106500000.0
+ARG1	58005000000.0	53362000000.0	43686000000.0	39897000000.0
+MRPL39	87432000.0	74092000.0	71958000.0	67845000.0
+PPP2R5A	17275000.0	18111000.0	24305000.0	22724000.0
+TBL2	282570000.0	292460000.0	313330000.0	315720000.0
+THOC6	32239000.0	32733000.0	52646000.0	41078000.0
+THOC5	16276000.0	22840000.0	1433900.0	11719000.0
+FAM45A	74621000.0	71954000.0	70919000.0	179150000.0
+CSAD	186550000.0	164720000.0	226960000.0	269820000.0
+MGC127055	720940000.0	743040000.0	1062500000.0	1197800000.0
+HSD3B7	484000000.0	383950000.0	694740000.0	655210000.0
+UQCRFS1	2101200000.0	1259200000.0	1537600000.0	2022200000.0
+ABCE1	56426000.0	64061000.0	70844000.0	85626000.0
+UQCRC2	3275600000.0	3474600000.0	3228500000.0	3262500000.0
+XPNPEP1	132910000.0	128610000.0	103340000.0	110780000.0
+XPNPEP2	7451300.0	26296000.0	37848000.0	32488000.0
+UQCRC1	2145600000.0	2058200000.0	1880000000.0	2180500000.0
+NUP88	73984000.0	25002000.0	28142000.0	40247000.0
+COPS8	357370000.0	344330000.0	422080000.0	446890000.0
+DDX42	2739200.0	0.0	5311700.0	7086400.0
+RETSAT	262670000.0	264170000.0	399930000.0	387770000.0
+NSDHL	4573500000.0	4450900000.0	5438900000.0	5131100000.0
+COPS2	42431000.0	44761000.0	32396000.0	37426000.0
+COPS3	24286000.0	30803000.0	16373000.0	14887000.0
+PGAM1	18876000000.0	18124000000.0	21795000000.0	21035000000.0
+KHDRBS1	84419000.0	124780000.0	109860000.0	111030000.0
+NUBPL	107590000.0	94953000.0	147250000.0	117260000.0
+COPS5	156510000.0	172850000.0	189960000.0	222370000.0
+PPOX	67183000.0	52809000.0	96132000.0	86917000.0
+ENSBTAG00000034189	10268000000.0	8968500000.0	8618000000.0	8947000000.0
+ENSBTAG00000014988	196250000.0	171830000.0	228260000.0	291040000.0
+DDX46	19016000.0	10204000.0	12633000.0	13227000.0
+TKT	5540000000.0	5862400000.0	6042700000.0	5681300000.0
+TNS3	74044000.0	80977000.0	59513000.0	76181000.0
+TNS2	6043500.0	0.0	4824700.0	3555700.0
+SDF2L1	1032600000.0	1028900000.0	1094100000.0	1060300000.0
+FDFT1	281340000.0	279520000.0	90249000.0	98227000.0
+NLN	4985700.0	10045000.0	0.0	16247000.0
+NUDT8	155510000.0	169630000.0	175090000.0	161590000.0
+NUDT9	80772000.0	80986000.0	63533000.0	65679000.0
+TARS2	363880000.0	134640000.0	340030000.0	387030000.0
+DPYSL2	350000000.0	333720000.0	380520000.0	417180000.0
+HEXA	75049000.0	76646000.0	87869000.0	82747000.0
+DLD	800970000.0	857610000.0	865910000.0	916960000.0
+NUDT1	17234000.0	18426000.0	9825600.0	5332000.0
+NAXE	3306200000.0	3282600000.0	3872300000.0	4076900000.0
+NAXD	3051500000.0	3548400000.0	3703600000.0	3862000000.0
+NUDT5	584540000.0	741120000.0	808630000.0	728750000.0
+TK2	264070000.0	209520000.0	160100000.0	178690000.0
+IGFBP7	34315000.0	32681000.0	33873000.0	0.0
+EPS8L2	88511000.0	106760000.0	114870000.0	117520000.0
+LARS	46610000.0	9544000.0	24125000.0	19301000.0
+PROZ	7825600.0	14587000.0	2317800.0	2662100.0
+CYP8B1	667620000.0	666200000.0	795720000.0	855180000.0
+ATP5F1A	16991000000.0	16930000000.0	18130000000.0	17641000000.0
+ATP5F1B	25287000000.0	25673000000.0	24487000000.0	23471000000.0
+ATP5F1C	19468000000.0	16958000000.0	12184000000.0	11747000000.0
+CYP27A1	903790000.0	972780000.0	1208500000.0	1279300000.0
+BTD	9746600.0	8417500.0	10754000.0	10810000.0
+NUBP1	67987000.0	69186000.0	44779000.0	52540000.0
+SERPINA3-8	9561600.0	10454000.0	12435000.0	0.0
+DDRGK1	60868000.0	57669000.0	79324000.0	79485000.0
+GAS2	560420000.0	676450000.0	844630000.0	792560000.0
+PROC	31292000.0	29591000.0	53981000.0	73928000.0
+SSB	116850000.0	133570000.0	75391000.0	79500000.0
+EPHX1	18118000000.0	18535000000.0	18357000000.0	19284000000.0
+EPHX2	1752800000.0	1636800000.0	1997600000.0	1629300000.0
+AMPD2	33179000.0	0.0	54503000.0	70837000.0
+EIF2B4	34473000.0	29232000.0	20830000.0	78078000.0
+RPLP0	7631800000.0	7704600000.0	8061800000.0	8108800000.0
+EIF2B2	51383000.0	50709000.0	50670000.0	71148000.0
+EIF2B3	9873800.0	13407000.0	8899700.0	11460000.0
+UGT2A1	84579000.0	91930000.0	126060000.0	118080000.0
+EIF2B1	26539000.0	48843000.0	43243000.0	11837000.0
+PRKAR2A	551720000.0	590850000.0	585270000.0	612160000.0
+ENSBTAG00000030882	3667500000.0	3503400000.0	5493200000.0	5167500000.0
+PPA1	1526300000.0	1384000000.0	1400900000.0	1589300000.0
+QPRT	18252000000.0	15281000000.0	15265000000.0	16875000000.0
+MLF2	21617000.0	28837000.0	18581000.0	10090000.0
+ALCAM	202000000.0	2386500.0	56504000.0	72712000.0
+TPM4	425550000.0	440900000.0	478600000.0	559060000.0
+TPM3	6923500000.0	7730700000.0	8677400000.0	9023700000.0
+SNRPA1	88454000.0	86279000.0	72916000.0	113600000.0
+TRADD	163720000.0	158940000.0	181470000.0	187240000.0
+ETF1	21534000.0	18769000.0	17531000.0	19991000.0
+THYN1	743050000.0	758460000.0	590320000.0	689610000.0
+PRELP	16251000.0	17287000.0	29806000.0	22530000.0
+TAGLN	0.0	50117000.0	58610000.0	53232000.0
+ETFA	24348000000.0	25834000000.0	27056000000.0	27339000000.0
+PHACTR4	129860000.0	0.0	0.0	0.0
+CLIC4	3707900000.0	3647500000.0	3338500000.0	3064500000.0
+ETFB	33544000000.0	32129000000.0	27580000000.0	27678000000.0
+CLIC2	106450000.0	97886000.0	111930000.0	119620000.0
+CLIC1	1046200000.0	1090700000.0	1212300000.0	1473900000.0
+UGDH	10738000000.0	10468000000.0	11640000000.0	12174000000.0
+SEPHS2	32550000.0	42945000.0	39271000.0	53638000.0
+SEPHS1	10374000.0	8330600.0	4543400.0	5459800.0
+TPMT	670060000.0	619080000.0	485020000.0	577750000.0
+ASGR1	6113200000.0	5552300000.0	5884200000.0	6138800000.0
+ASGR2	331910000.0	394990000.0	236440000.0	215390000.0
+TMEM141	290730000.0	280140000.0	99230000.0	293620000.0
+DDX19A	31474000.0	39435000.0	40215000.0	54203000.0
+RPS4X	30491000.0	0.0	17782000.0	26412000.0
+ENSBTAG00000001219	20467950.0	0.0	73569800.0	79261900.0
+CASP3	359540000.0	415170000.0	387070000.0	358570000.0
+TJP2	38646000.0	11493000.0	15067000.0	9138400.0
+API5	109050000.0	113860000.0	34695000.0	47719000.0
+TJP1	5194900.0	0.0	18878000.0	9246000.0
+DLST	1060600000.0	1044700000.0	870820000.0	1065800000.0
+TCP1	736420000.0	669670000.0	776370000.0	793090000.0
+PPAT	20966000.0	29632000.0	13120000.0	18347000.0
+XAB2	1850500.0	740650.0	574350.0	619370.0
+KTN1	11530000.0	3380900.0	10220000.0	8887800.0
+ST6GAL1	49151000.0	41363000.0	39712000.0	39546000.0
+PRDX6	12893000000.0	12447000000.0	16189000000.0	15559000000.0
+PRDX5	87290000.0	84731000.0	63323000.0	57958000.0
+PRDX4	5654500000.0	6074600000.0	5717700000.0	6075400000.0
+PRDX3	16752000000.0	14909000000.0	18823000000.0	19283000000.0
+PRDX2	2919000000.0	3131000000.0	5360600000.0	5386800000.0
+PRDX1	1019300000.0	1025000000.0	1153700000.0	1309400000.0
+CLGN	285640000.0	36541000.0	189800000.0	57868000.0
+SMARCA2	0.0	0.0	0.0	0.0
+OTUB1	880850000.0	783440000.0	670730000.0	734620000.0
+RABL3	92779000.0	148300000.0	109850000.0	125170000.0
+PLPBP	1428800000.0	1633400000.0	1426900000.0	1238800000.0
+PDK1	10165000.0	7346100.0	0.0	8214400.0
+CD93	2157500.0	0.0	0.0	0.0
+CAMP	0.0	0.0	25802000.0	29210000.0
+POR	1831400000.0	2041900000.0	1397900000.0	1325800000.0
+ENSBTAG00000009760	7606100.0	9257700.0	18696000.0	18436000.0
+MPRIP	6427900.0	0.0	5016100.0	12238000.0
+TOR1A	305790000.0	317760000.0	307090000.0	368290000.0
+HNRNPA3	555720000.0	512000000.0	426800000.0	480530000.0
+KANK2	0.0	0.0	0.0	0.0
+SULT2A1	5171900000.0	5448700000.0	4024200000.0	4033200000.0
+RAB1B	1410200000.0	1280800000.0	1415700000.0	1410200000.0
+RAC2	443340000.0	376110000.0	295650000.0	281910000.0
+RAC1	4427500000.0	3665000000.0	2489400000.0	2750600000.0
+SBDS	880900000.0	756580000.0	784570000.0	691050000.0
+KANK1	7241100.0	3641500.0	8258200.0	0.0
+VCL	636050000.0	178120000.0	377750000.0	339450000.0
+OSTC	1780200.0	0.0	0.0	0.0
+VCP	2473900000.0	582630000.0	1617500000.0	1552000000.0
+OLA1	187830000.0	162030000.0	141560000.0	140470000.0
+AP2A1	358620000.0	382400000.0	270240000.0	294710000.0
+AP2A2	90317000.0	107570000.0	108100000.0	89056000.0
+LYPLAL1	120220000.0	134640000.0	97200000.0	122210000.0
+CYP7B1	83710000.0	79842000.0	170780000.0	171650000.0
+MYH7B	0.0	0.0	0.0	0.0
+DPH5	26919000.0	28648000.0	31727000.0	20566000.0
+C3H1orf50	97820000.0	80161000.0	130870000.0	110850000.0
+BCKDHA	440980000.0	514390000.0	539520000.0	462700000.0
+TARS	563280000.0	196900000.0	267150000.0	286050000.0
+TIMM44	31735000.0	42468000.0	23793000.0	19507000.0
+TUFM	2112500000.0	2329200000.0	1938600000.0	2046000000.0
+LAMP1	94050000.0	113870000.0	109610000.0	106580000.0
+LYVE1	2820200.0	11048000.0	9168800.0	10459000.0
+CKB	248510000.0	222580000.0	206250000.0	181090000.0
+PTGS1	22243000.0	32032000.0	25591000.0	43116000.0
+ERGIC1	279580000.0	265720000.0	344960000.0	403800000.0
+TXNDC9	36828000.0	43137000.0	35080000.0	29061000.0
+CLEC14A	1147200.0	0.0	0.0	0.0
+PAH	2009200000.0	2021500000.0	2947200000.0	2750700000.0
+TXNDC5	514210000.0	377910000.0	475450000.0	459490000.0
+CPPED1	2123400000.0	2127900000.0	2335000000.0	2350500000.0
+DCN	30091000.0	1749300.0	22663000.0	19056000.0
+GPS1	9079400.0	10621000.0	11080000.0	12702000.0
+CALM3	54934000.0	53263000.0	59773000.0	32618000.0
+SPG21	34331000.0	34918000.0	21860000.0	76026000.0
+ACSM1	25479000000.0	23804000000.0	22502000000.0	21557000000.0
+ACSM3	1540700000.0	1479900000.0	1722800000.0	1693200000.0
+ACSM5	99503000.0	97978000.0	123510000.0	102490000.0
+MGC127133	146480000.0	162640000.0	184810000.0	197220000.0
+CYP51A1	193900000.0	204580000.0	98390000.0	103590000.0
+ATP6V0D2	39309000.0	36270000.0	44932000.0	78547000.0
+ATP6V0D1	328800000.0	394380000.0	416620000.0	345290000.0
+WDR61	96838000.0	85716000.0	161860000.0	171090000.0
+ENSBTAG00000022570	97883000.0	85722000.0	107504000.0	82386000.0
+CUL1	7831300.0	0.0	5845300.0	5734400.0
+CUL2	6551300.0	0.0	7139700.0	1875700.0
+PSMG1	44397000.0	76276000.0	96889000.0	85022000.0
+TTN	2258100000.0	2239900000.0	828920000.0	246670000.0
+ENSBTAG00000038058	932560000.0	936800000.0	1342600000.0	1106800000.0
+SLC25A3	674180000.0	799750000.0	796660000.0	685070000.0
+TRIM25	726600000.0	665630000.0	563490000.0	381700000.0
+SLC25A1	6111300000.0	5989200000.0	5546300000.0	5159800000.0
+PRMT1	38184000.0	71853000.0	66501000.0	102770000.0
+SLC25A6	1571700000.0	1525300000.0	1145400000.0	1102700000.0
+SLC25A5	197760000.0	232660000.0	190940000.0	124690000.0
+SLC25A4	12674000000.0	12867000000.0	11576000000.0	10872000000.0
+HMGCR	16572000.0	14064000.0	0.0	0.0
+LZTFL1	96947000.0	109980000.0	68434000.0	70956000.0
+DNAJA2	88548000.0	102790000.0	51893000.0	50924000.0
+DNAJA3	59809000.0	67919000.0	48789000.0	43178000.0
+DNAJA1	141230000.0	192650000.0	147090000.0	195960000.0
+RBM47	11210000.0	14633000.0	0.0	7428900.0
+PTPN12	624050.0	8377000.0	8369500.0	0.0
+KIF5B	295630000.0	0.0	171830000.0	160930000.0
+KIF5C	0.0	0.0	0.0	4770800.0
+MASP1	1542100.0	0.0	0.0	0.0
+ARCN1	1913800000.0	2012700000.0	1135800000.0	1129900000.0
+UTRN	48054000.0	8243600.0	10727000.0	17688000.0
+GLT1D1	31583000.0	24851000.0	27436000.0	29563000.0
+TTC19	80077000.0	59244000.0	72898000.0	62614000.0
+DMGDH	1457193000.0	436060000.0	1146692000.0	622967000.0
+ACADS	68931000000.0	71536000000.0	74233000000.0	73983000000.0
+MRPL21	90246000.0	81185000.0	37264000.0	33540000.0
+MRPL23	242310000.0	226920000.0	142790000.0	216000000.0
+GBA	119930000.0	145960000.0	79123000.0	107700000.0
+DNAJC25	0.0	12489000.0	9635200.0	12724000.0
+HSPG2	1531800000.0	1207100000.0	1677600000.0	1758300000.0
+GAPDH	40004000000.0	41468000000.0	47204000000.0	50988000000.0
+DTD1	81331000.0	100120000.0	90354000.0	81955000.0
+ARHGAP4	1747200.0	0.0	0.0	0.0
+SEC16A	32502000.0	0.0	3670300.0	9809500.0
+NDRG2	1718900000.0	1822200000.0	1453300000.0	1298400000.0
+ACADL	1086800000.0	1096200000.0	633480000.0	704840000.0
+ARHGAP1	269310000.0	248150000.0	301200000.0	334680000.0
+PPM1F	60990000.0	39972000.0	69854000.0	77357000.0
+SRSF7	320880000.0	319090000.0	377610000.0	317350000.0
+THEM4	1664200000.0	1662600000.0	1430500000.0	1566500000.0
+SRSF1	552240000.0	619620000.0	761760000.0	752790000.0
+PPM1B	10557000.0	10798000.0	9338700.0	9056500.0
+PPM1A	34164000.0	35360000.0	39721000.0	33018000.0
+SRSF2	96292000.0	117700000.0	128640000.0	132220000.0
+C4BPA	84900000.0	0.0	37073000.0	31331000.0
+USP47	12889000.0	0.0	5614200.0	5946600.0
+ENSBTAG00000022205	13947000.0	19471000.0	0.0	21536000.0
+DNAJB11	24536000.0	15785000.0	8182300.0	8967700.0
+ENSBTAG00000008564	5944500000.0	5631500000.0	7811500000.0	8381700000.0
+PPP6C	323990000.0	325880000.0	422310000.0	396680000.0
+ZYX	23035000.0	0.0	0.0	28305000.0
+ANXA11	144010000.0	120460000.0	164080000.0	193600000.0
+ANXA13	12053500000.0	11955400000.0	11521700000.0	10331700000.0
+CISD1	27325000.0	0.0	25938000.0	24678000.0
+UMPS	118310000.0	167690000.0	142040000.0	135130000.0
+MRPL4	64667000.0	61351000.0	46439000.0	43640000.0
+ENSBTAG00000025760	433860000.0	465000000.0	379400000.0	498370000.0
+MRPL3	70254000.0	105380000.0	73532000.0	61234000.0
+SCRN2	61118000.0	45218000.0	33133000.0	42196000.0
+PTPN6	21690000.0	22573000.0	21607000.0	28732000.0
+ATP5PO	10508000000.0	12638000000.0	7817200000.0	9343900000.0
+BTF3	231020000.0	272230000.0	133390000.0	174200000.0
+ACAD8	3418900000.0	3924400000.0	3661700000.0	3674700000.0
+ACAD9	72234000.0	55974000.0	98525000.0	118870000.0
+CYP2E1	5054000000.0	4970300000.0	8024300000.0	7904500000.0
+NPTXR	0.0	0.0	0.0	6913000.0
+BAG2	61169000.0	46480000.0	108600000.0	142740000.0
+BAG6	971060.0	0.0	2253300.0	1673500.0
+EPS15L1	14621000.0	30756000.0	21095000.0	31221000.0
+MYO1F	2003700.0	0.0	2608300.0	2392000.0
+MYO1E	0.0	0.0	0.0	0.0
+MYO1C	401100000.0	194420000.0	399030000.0	536770000.0
+MYO1B	116010000.0	4716900.0	79684000.0	91522000.0
+MSRB3	53132000.0	62502000.0	99474000.0	120170000.0
+RPS7	3306100000.0	3869000000.0	1828400000.0	2104200000.0
+RPS5	7660400000.0	6350700000.0	4476300000.0	4348200000.0
+RPS3	6454500000.0	6883100000.0	4367300000.0	4214300000.0
+RPS2	7380300000.0	8033500000.0	5052700000.0	4778500000.0
+ARRB1	31677000.0	33798000.0	44635000.0	45930000.0
+VDAC3	2416300000.0	2620700000.0	2825800000.0	3170700000.0
+VDAC2	7401700000.0	6412100000.0	8102000000.0	9155100000.0
+VDAC1	14275000000.0	13944000000.0	19133000000.0	16347000000.0
+CHMP6	314150000.0	237550000.0	133100000.0	223490000.0
+RPS9	3602400000.0	4145000000.0	3152000000.0	3421600000.0
+RPS8	5944600000.0	5776400000.0	5232100000.0	5474400000.0
+ADI1	4991580000.0	4959200000.0	5282930000.0	5221920000.0
+ATXN1L	120110000.0	311190000.0	199660000.0	198490000.0
+GMFB	254840000.0	231620000.0	306990000.0	194550000.0
+GPNMB	76137000.0	68110000.0	48446000.0	22278000.0
+HPF1	6007900.0	3765300.0	9903600.0	8534800.0
+PSMA2	2967200000.0	2848900000.0	3539400000.0	3108000000.0
+PSMA3	5654800000.0	5321000000.0	5369500000.0	4505600000.0
+PSMA1	5812500000.0	5722600000.0	5271300000.0	5751300000.0
+PSMA6	6376500000.0	6197700000.0	5663900000.0	5489800000.0
+PSMA7	4858000000.0	5176800000.0	5317400000.0	5149600000.0
+PSMA4	1462600000.0	1548400000.0	1299000000.0	1233900000.0
+PSMA5	4005100000.0	3761300000.0	3167700000.0	3074600000.0
+DSG2	14205000.0	14316000.0	21521000.0	23482000.0
+C2	4137100.0	0.0	7958000.0	9038700.0
+C6	35197000.0	3930900.0	28456000.0	25008000.0
+ENSBTAG00000038540	6037600000.0	6991200000.0	6994300000.0	6924400000.0
+GALT	131760000.0	98313000.0	126220000.0	125370000.0
+HMGCS1	811210000.0	739910000.0	250640000.0	247690000.0
+HMGCS2	26672000000.0	26273000000.0	26642000000.0	28815000000.0
+PDHA1	159230000.0	204510000.0	138880000.0	198250000.0
+COL4A3BP	1236600.0	0.0	5634100.0	6234400.0
+SEC23A	432950000.0	159330000.0	176530000.0	175370000.0
+MGLL	7309600000.0	9316000000.0	3586200000.0	3959700000.0
+SRI	221440000.0	249120000.0	204920000.0	191750000.0
+SORD	31456000000.0	29969000000.0	30798000000.0	33068000000.0
+GALE	1929300000.0	1911900000.0	1859800000.0	1826400000.0
+LGALS9	497660000.0	577400000.0	865480000.0	941970000.0
+LGALS8	791589000.0	857146000.0	1210657000.0	1443145000.0
+CS	454330000.0	482270000.0	366100000.0	361890000.0
+GALM	2995100000.0	3053400000.0	3795200000.0	3753300000.0
+FSCN1	162920000.0	134280000.0	154940000.0	141710000.0
+CYP4F22	21293000.0	18918000.0	0.0	0.0
+TDH	3134900000.0	3274100000.0	2449800000.0	2033700000.0
+MYL12B	194720000.0	194050000.0	220490000.0	199510000.0
+RPSA	1883000000.0	1811000000.0	1693500000.0	1601100000.0
+TSTA3	333430000.0	234470000.0	234540000.0	196010000.0
+EIF2AK2	377520000.0	454090000.0	337400000.0	367590000.0
+TAPBP	55613000.0	60652000.0	59451000.0	59418000.0
+HNRNPU	602190000.0	380310000.0	389530000.0	426790000.0
+COL1A2	85146000.0	2580200.0	9872600.0	12740000.0
+COL1A1	80455000.0	0.0	15069000.0	14257000.0
+TRNT1	29033000.0	32015000.0	39030000.0	26684000.0
+CSNK2B	40548000.0	39972000.0	25343000.0	38327000.0
+IDO2	477960000.0	480120000.0	579860000.0	631290000.0
+TMPO	146650000.0	89874000.0	118910000.0	48078000.0
+C3H1orf123	169640000.0	188710000.0	224450000.0	163440000.0
+PSMD11	239720000.0	243480000.0	234780000.0	219520000.0
+FCGR3A	0.0	16975000.0	19903000.0	20139000.0
+ECM1	25680000.0	0.0	8603400.0	8855500.0
+ITGAV	44244000.0	51635000.0	52070000.0	42804000.0
+FMR1	433990.0	3291000.0	3177000.0	3237800.0
+ALDH1A1	30178000000.0	31184000000.0	41013000000.0	42838000000.0
+GCDH	1128600000.0	1089700000.0	1356800000.0	1469800000.0
+ALDH1A3	18077000.0	14701000.0	15963000.0	13868000.0
+AP3B1	37226000.0	37750000.0	22788000.0	15628000.0
+PCYOX1	391690000.0	424440000.0	552560000.0	528080000.0
+RPL24	1891900000.0	2154400000.0	1423100000.0	1277900000.0
+PPP6R3	8449300.0	0.0	7997300.0	7090500.0
+RPL26	489060000.0	707860000.0	126040000.0	0.0
+RPL21	1612900000.0	1758200000.0	620210000.0	557770000.0
+ATG3	8221400.0	7295900.0	0.0	0.0
+ATG7	4286900.0	0.0	0.0	0.0
+COG1	2839900.0	0.0	12423000.0	12215000.0
+APMAP	228320000.0	217220000.0	204720000.0	201980000.0
+AADAT	167050000.0	174026100.0	114700000.0	122140000.0
+USE1	53074000.0	90766000.0	81227000.0	46430000.0
+PIGR	611920.0	0.0	899890.0	0.0
+AADAC	922300000.0	826340000.0	906140000.0	761490000.0
+HPD	10018000000.0	10950000000.0	7455200000.0	7158900000.0
+PPP1CB	254640000.0	235540000.0	216490000.0	208460000.0
+PPP1CC	53250000.0	39216000.0	80397000.0	51641000.0
+RHPN2	29363780.0	48759000.0	108390000.0	98062000.0
+SRRM1	29011000.0	26813000.0	40368000.0	39168000.0
+ATXN2	11835000.0	15182000.0	0.0	0.0
+RDH14	233570000.0	234340000.0	282620000.0	312340000.0
+PDK2	29389000.0	17428000.0	0.0	7751000.0
+RDH10	87753000.0	86810000.0	117240000.0	121830000.0
+RDH11	1385200000.0	1273200000.0	1271500000.0	1381100000.0
+RDH13	112950000.0	95914000.0	134380000.0	127930000.0
+COL6A1	560920000.0	277920000.0	399810000.0	435970000.0
+WBP2	25610000.0	67853000.0	63837000.0	77502000.0
+COL6A3	237820000.0	47933000.0	151580000.0	283110000.0
+COL6A2	190400000.0	54767000.0	243030000.0	190320000.0
+ALPL	4463900.0	0.0	0.0	3395600.0
+PECR	20885000000.0	20396000000.0	19793000000.0	19412000000.0
+ENSBTAG00000005501	192970000.0	248760000.0	246990000.0	242910000.0
+PUF60	20906000.0	17975000.0	0.0	18605000.0
+FBP1	65045000000.0	66747000000.0	51680000000.0	52391000000.0
+PFKP	6073600.0	0.0	2665000.0	3286100.0
+PLIN2	583580000.0	237620000.0	47183000.0	133320000.0
+PLIN3	2621400000.0	2364200000.0	1343500000.0	1313500000.0
+ENOSF1	470090000.0	558310000.0	700980000.0	600480000.0
+ABHD6	49025000.0	49732000.0	44783000.0	35342000.0
+CIAPIN1	175310000.0	237340000.0	108930000.0	115050000.0
+CLEC16A	15582000.0	0.0	11157000.0	12479000.0
+HSP90AB1	1288000000.0	375310000.0	616010000.0	483650000.0
+ABHD4	67417000.0	86449000.0	35660000.0	49656000.0
+PTP4A2	345460000.0	410860000.0	287700000.0	260480000.0
+DNAJC12	94857000.0	77765000.0	169670000.0	199250000.0
+UBR4	161100000.0	122210000.0	141580000.0	135280000.0
+EIF3CL	71990000.0	18834000.0	33011000.0	35526000.0
+TWF1	58576000.0	50139000.0	30358000.0	37931000.0
+DNAJC10	19480000.0	13999000.0	16427000.0	19315000.0
+MRPS9	102060000.0	115400000.0	71450000.0	64029000.0
+MRPS7	37575000.0	38519000.0	30494000.0	19420000.0
+DNAJC11	34957000.0	42931000.0	40547000.0	38152000.0
+RBP4	15649000000.0	16417000000.0	16983000000.0	19977000000.0
+PPIB	35111000000.0	35247000000.0	21494000000.0	22088000000.0
+ABHD1	102820000.0	100310000.0	23319000.0	24334000.0
+NUCB1	61629000.0	56886000.0	34321000.0	54244000.0
+EPRS	297260000.0	233970000.0	153870000.0	173470000.0
+HSDL2	2700200000.0	3325500000.0	2145400000.0	2349900000.0
+KRAS	1022200000.0	859850000.0	1002800000.0	1027600000.0
+MLYCD	331840000.0	347300000.0	306240000.0	305100000.0
+PKN1	4017400.0	0.0	3929600.0	5226400.0
+PPP2CA	134260000.0	130140000.0	232500000.0	147620000.0
+ARPC1B	808730000.0	770950000.0	983770000.0	1083900000.0
+EIF4G1	5608200.0	0.0	0.0	0.0
+ACSL1	7626700000.0	7685100000.0	2863200000.0	3067900000.0
+NDUFAF7	5012500.0	6976900.0	3652000.0	5200400.0
+ACSL5	5566400000.0	5816200000.0	5540400000.0	6121100000.0
+TERF2	0.0	941980000.0	121580000.0	391660000.0
+GRB2	381910000.0	409490000.0	491130000.0	529430000.0
+EEF1G	1995500000.0	1966100000.0	1907700000.0	2018700000.0
+ARPC1A	327440000.0	270300000.0	358730000.0	399340000.0
+PPP2CB	1057400000.0	1089200000.0	1125600000.0	1277800000.0
+RPL8	6211500000.0	6340000000.0	3803200000.0	3121200000.0
+RPL9	2897700000.0	2015600000.0	2735300000.0	2667800000.0
+RPL6	2202400000.0	2290300000.0	4190000000.0	4310100000.0
+RPL7	8624500000.0	9798800000.0	7157600000.0	6692500000.0
+HP	13151000000.0	12322000000.0	2146200000.0	2141400000.0
+RPL5	6427900000.0	7132100000.0	3164600000.0	3566500000.0
+RPL3	331680000.0	347140000.0	143950000.0	175910000.0
+NHP2	38657000.0	41178000.0	21339000.0	24876000.0
+SSU72	43922000.0	41430000.0	24257000.0	24618000.0
+NCKAP1	780440.0	0.0	1682900.0	1761400.0
+CHD5	1631900.0	0.0	0.0	0.0
+UROC1	1221900000.0	1193300000.0	1388200000.0	1373200000.0
+CHD9	0.0	0.0	0.0	998660.0
+TMPRSS11D	0.0	74001000.0	0.0	0.0
+ABHD10	312960000.0	264430000.0	226010000.0	235120000.0
+CAP1	1540500000.0	1750500000.0	1717600000.0	1746200000.0
+PRKCA	1232200.0	0.0	8318000.0	9213500.0
+SKIV2L	40142000.0	0.0	8704600.0	8287200.0
+ENSBTAG00000005315	3878900000.0	3929100000.0	3127200000.0	2912600000.0
+RAB39A	227550000.0	191740000.0	283160000.0	241600000.0
+FN3K	25930000.0	20510000.0	35652000.0	28899000.0
+MRPL11	266650000.0	288740000.0	153330000.0	185230000.0
+MRPL12	4542800000.0	4861300000.0	3849900000.0	3673300000.0
+MRPL13	47938000.0	39841000.0	29916000.0	33935000.0
+RAB3GAP2	8457000.0	29067000.0	7494600.0	6378100.0
+MRPL15	85552000.0	94379000.0	36758000.0	29568000.0
+RCN1	156720000.0	176070000.0	133240000.0	239390000.0
+RAB3GAP1	1707300.0	0.0	3354200.0	0.0
+ARPC3	568290000.0	510360000.0	300790000.0	312800000.0
+ARPC2	1148800000.0	1556800000.0	1492100000.0	1351700000.0
+UAP1	82998000.0	105080000.0	101830000.0	49927000.0
+DNAJC30	36364000.0	0.0	0.0	0.0
+ARPC5	548050000.0	536170000.0	603620000.0	633550000.0
+ARPC4	306910000.0	276120000.0	214230000.0	167730000.0
+POLR2E	141060000.0	171400000.0	84956000.0	80430000.0
+DCUN1D1	103270000.0	67983000.0	91611000.0	144330000.0
+DAG1	5326200.0	0.0	9049100.0	714880.0
+POLR2C	42211000.0	46081000.0	25492000.0	29762000.0
+POLR2B	3372400000.0	0.0	3505700000.0	1117500000.0
+RHOC	55809000.0	70109000.0	91305000.0	70828000.0
+RHOB	405230000.0	402050000.0	394730000.0	400620000.0
+AKR7A2	6478300000.0	8101500000.0	8029600000.0	7370800000.0
+ITPR1	17468000.0	12715000.0	15062000.0	0.0
+RHOG	1205300000.0	1106500000.0	944010000.0	1231100000.0
+ETHE1	21489000000.0	21463000000.0	19459000000.0	19774000000.0
+MPG	54340000.0	68660000.0	46314000.0	41844000.0
+KDSR	104270000.0	117490000.0	204820000.0	163670000.0
+TLK1	96156000.0	0.0	106110000.0	123330000.0
+MPO	12982000.0	10359000.0	25316000.0	27526000.0
+MTTP	984650000.0	343240000.0	600750000.0	524100000.0
+AIFM2	132490000.0	159500000.0	137250000.0	131560000.0
+EBF3	0.0	0.0	0.0	0.0
+AIFM1	4461000000.0	4171600000.0	4368900000.0	4180600000.0
+AGO1	18787000.0	16087000.0	10880000.0	0.0
+A1CF	286450000.0	298870000.0	280740000.0	314740000.0
+AGO2	2318400.0	0.0	3820000.0	3249500.0
+GRPEL1	525850000.0	497990000.0	671100000.0	608310000.0
+GAMT	14111000000.0	14971000000.0	13284000000.0	14177000000.0
+VBP1	96717000.0	104130000.0	128710000.0	93392000.0
+FAM120B	1652300.0	0.0	0.0	0.0
+FAM120C	6874300.0	0.0	0.0	0.0
+LAP3	4313500000.0	4709500000.0	4713700000.0	5174300000.0
+FAM120A	186910000.0	248640000.0	120780000.0	174160000.0
+MAPK14	168320000.0	169410000.0	248300000.0	203560000.0
+CD302	48548000.0	70347000.0	52364000.0	0.0
+GADL1	23780000.0	22292000.0	0.0	101470000.0
+HPGD	90565000.0	84042000.0	92608000.0	88222000.0
+AKR1B10	7053000000.0	7605400000.0	6613500000.0	7569800000.0
+OGFOD3	125060000.0	162980000.0	166610000.0	176450000.0
+IQUB	74398000.0	69742000.0	66001000.0	42149000.0
+PM20D1	20845000.0	32134000.0	15806000.0	0.0
+CACNB1	129970000.0	118150000.0	0.0	86058000.0
+REPS1	2136200.0	0.0	991870.0	1165600.0
+ACMSD	605200000.0	629570000.0	603560000.0	501760000.0
+NECTIN2	37054000.0	33012000.0	32052000.0	42192000.0
+NEURL1	12631000.0	14777000.0	0.0	0.0
+BCNT2	16510000.0	20111000.0	9740600.0	9387100.0
+UGT2B10	133900000.0	160980000.0	147790000.0	158370000.0
+GPN1	6127900.0	6759500.0	6189100.0	3103600.0
+TRIM32	2453500.0	0.0	3858800.0	4300900.0
+S100A9	159916000.0	167840000.0	722544000.0	677140000.0
+RPL4	503110000.0	498670000.0	479900000.0	541650000.0
+DNPEP	327140000.0	362000000.0	432590000.0	446150000.0
+RAP2C	367160000.0	397900000.0	510240000.0	544520000.0
+OLFML3	6979500.0	5727800.0	7857400.0	9075400.0
+FAM49A	23125000.0	19038000.0	24864000.0	30013000.0
+FAM49B	332910000.0	373670000.0	464810000.0	520740000.0
+GGA1	2038600.0	4106200.0	0.0	0.0
+USO1	360240000.0	19256000.0	80705000.0	81182000.0
+PLCD1	15003000.0	0.0	45760000.0	35687000.0
+ADO	65541000.0	56317000.0	40298000.0	44547000.0
+ADK	5012100000.0	5207200000.0	3258900000.0	3645000000.0
+HIST1H1C	416590000.0	558070000.0	868010000.0	874670000.0
+ADH6	13153000000.0	12759000000.0	12496000000.0	12672000000.0
+ADH5	3385900000.0	3437600000.0	3446000000.0	3307300000.0
+ADH4	16648230000.0	15567350000.0	20766110000.0	19670130000.0
+TACC2	0.0	0.0	0.0	0.0
+ENSBTAG00000046172	17562566000.0	17726470000.0	20585193000.0	20388383000.0
+SQOR	1109100000.0	995630000.0	1069900000.0	1068600000.0
+PRKACA	1356500000.0	1298900000.0	1662200000.0	1702400000.0
+PSMB9	94016000.0	81369000.0	124750000.0	113780000.0
+PRKACB	60229000.0	63793000.0	73864000.0	74002000.0
+PSMB7	621070000.0	734620000.0	480310000.0	506410000.0
+PSMB6	3867800000.0	3900300000.0	4740600000.0	4743000000.0
+PSMB5	1470300000.0	1744300000.0	1850700000.0	2042800000.0
+PSMB4	1792590000.0	2091992000.0	1976451000.0	1847886000.0
+PSMB3	826850000.0	721800000.0	1006000000.0	1044700000.0
+PSMB2	1468500000.0	1705200000.0	1423500000.0	1401400000.0
+PSMB1	1593440000.0	1660400000.0	1412110000.0	1591540000.0
+HDHD3	2376200000.0	2513300000.0	2301600000.0	2589600000.0
+HDHD2	588470000.0	556730000.0	593720000.0	518690000.0
+CAB39	29769000.0	35133000.0	57624000.0	47219000.0
+HDLBP	361680000.0	386800000.0	256100000.0	189210000.0
+SERPINA3	41762000.0	30834000.0	29662000.0	38854000.0
+HSPBP1	21754000.0	20353000.0	15673000.0	16147000.0
+CORO7	8290000.0	0.0	12469000.0	6888300.0
+BCL2L13	39425000.0	39254000.0	131240000.0	97630000.0
+HADHB	5024500000.0	5163300000.0	4878000000.0	4515400000.0
+ENSBTAG00000046008	51754000.0	50646000.0	52889000.0	61060000.0
+HADHA	7810500000.0	4347400000.0	4992200000.0	4992900000.0
+SAE1	50441000.0	31539000.0	56244000.0	55157000.0
+NUP43	40144000.0	0.0	18299000.0	41895000.0
+STBD1	1412100000.0	1594000000.0	1916600000.0	1690800000.0
+IDNK	111980000.0	110290000.0	194670000.0	171260000.0
+ADRM1	60952000.0	63651000.0	43783000.0	35432000.0
+HSD11B1	15999000000.0	18812000000.0	24408000000.0	24846000000.0
+TRAF2	18016000.0	25564000.0	19719000.0	18226000.0
+RMDN2	75627000.0	71334000.0	86780000.0	102600000.0
+PGRMC2	4020600000.0	3782400000.0	4559000000.0	4159300000.0
+PGRMC1	3066800000.0	2925700000.0	4196400000.0	3989600000.0
+RMDN1	443570000.0	465580000.0	303760000.0	271800000.0
+HOOK3	9239800.0	0.0	3235200.0	5034600.0
+NUP160	2633300.0	0.0	5888200.0	4537400.0
+HOOK1	71413000.0	69324000.0	71123000.0	63497000.0
+TMPRSS6	0.0	0.0	0.0	0.0
+CRYM	196840000.0	155750000.0	233910000.0	265910000.0
+ESD	7936900000.0	7056600000.0	9379200000.0	8519000000.0
+ADHFE1	583620000.0	496090000.0	618710000.0	564830000.0
+LRRC57	207920000.0	291920000.0	214080000.0	310120000.0
+LRRC59	3126700000.0	3262700000.0	2835500000.0	2633600000.0
+ABCC10	0.0	0.0	65516000.0	361800000.0
+KANK3	8741400.0	3194000.0	5812100.0	0.0
+COL14A1	15576000.0	0.0	4771100.0	4805800.0
+RPL30	0.0	0.0	19699000.0	22331000.0
+GNA14	48256000.0	66958000.0	157900000.0	178910000.0
+GNA11	407040000.0	420150000.0	455630000.0	590420000.0
+SDHA	4802000000.0	4858500000.0	4538400000.0	4066700000.0
+ENSBTAG00000030683	41010000.0	46953000.0	69939000.0	52268000.0
+SDHB	11770000000.0	11061000000.0	10321000000.0	9857500000.0
+PPCS	737630000.0	802950000.0	1117000000.0	1106600000.0
+SMARCC2	3550500.0	0.0	13419000.0	15091000.0
+MOV10	56302000.0	3591100.0	20630000.0	22509000.0
+AP1M1	35774000.0	24730000.0	40947000.0	41312000.0
+PSPC1	16356000.0	17913000.0	8598400.0	16224000.0
+MOCS3	14652000.0	15071000.0	10805000.0	14613000.0
+MOCS2	32885000.0	30252000.0	23969000.0	24408000.0
+MOCS1	546569000.0	486513000.0	449597000.0	482304000.0
+DBN1	1536100.0	0.0	0.0	0.0
+EEF2K	2474600.0	0.0	0.0	2571700.0
+ENSBTAG00000017938	42553000000.0	41638000000.0	56945000000.0	51798000000.0
+OGDH	572860000.0	362400000.0	328810000.0	259620000.0
+BLOC1S3	0.0	0.0	0.0	28403000.0
+ENSBTAG00000039356	295910000.0	3225200000.0	415370000.0	468280000.0
+COMMD2	52625000.0	65378000.0	61707000.0	52705000.0
+COMMD1	34718000.0	40083000.0	32176000.0	35737000.0
+MIB1	4806300.0	0.0	3067800.0	3299700.0
+COMMD5	198370000.0	250070000.0	185920000.0	142720000.0
+FAM114A1	23108000.0	22437000.0	9772100.0	9173300.0
+GRWD1	9316900.0	8386000.0	8337600.0	11229000.0
+FAM114A2	25211000.0	10251000.0	14594000.0	12670000.0
+METTL13	3743500.0	0.0	0.0	4329500.0
+NADK2	1701000000.0	1772300000.0	1242900000.0	1300600000.0
+C8H9orf64	346060000.0	327780000.0	344780000.0	390110000.0
+TMED2	276960000.0	218240000.0	173820000.0	269370000.0
+CAMK2D	101300000.0	103830000.0	126520000.0	136190000.0
+PTGR1	26467000000.0	27938000000.0	31029000000.0	31360000000.0
+PTGR2	1585200000.0	1528200000.0	1701900000.0	1635600000.0
+DNAH17	35157000.0	284380000.0	33579000.0	507680000.0
+MTUS2	0.0	0.0	0.0	85589000.0
+MACROD1	2471500000.0	2515700000.0	2814700000.0	2886000000.0
+COQ8A	94987000.0	105360000.0	125550000.0	98009000.0
+ENSBTAG00000032350	6921800000.0	7030200000.0	6886100000.0	7392500000.0
+CYP3A4	28068000.0	24441000.0	52335000.0	45746000.0
+CYP3A5	7547479220.0	7316867000.0	7748681000.0	8006019000.0
+UBE4B	447870.0	0.0	0.0	0.0
+UBE4A	34729000.0	0.0	24102000.0	31291000.0
+AKAP2	27555000.0	31901000.0	32028000.0	33317000.0
+TUBB4B	6402400000.0	6294500000.0	5310800000.0	5229800000.0
+TUBB4A	1015900000.0	1067800000.0	725820000.0	698060000.0
+AKAP9	14737000.0	0.0	0.0	0.0
+EIF2A	61565000.0	52591000.0	39419000.0	45453000.0
+MTREX	1563800.0	0.0	16619000.0	3245000.0
+ENSBTAG00000048013	822620000.0	884950000.0	892850000.0	824140000.0
+STARD4	87426000.0	59953000.0	32965000.0	40643000.0
+STARD5	116670000.0	104470000.0	99799000.0	115070000.0
+CAPZB	3465600000.0	3391900000.0	3682800000.0	3786000000.0
+ENSBTAG00000047632	1707400.0	0.0	0.0	0.0
+C5H12orf10	9397100.0	0.0	0.0	8583000.0
+NTN4	17052000.0	20906000.0	23420000.0	25406000.0
+HSP90B1	12420000000.0	2478500000.0	4233600000.0	4323400000.0
+TANGO2	44111000.0	0.0	0.0	0.0
+PTGDS	15234000.0	13459000.0	22534000.0	26790000.0
+STIP1	185440000.0	153580000.0	125550000.0	152890000.0
+HIP1R	82220000.0	11445000.0	20322000.0	18058000.0
+PIKFYVE	0.0	0.0	0.0	0.0
+PEPD	35231000.0	35771000.0	34546000.0	41942000.0
+AHSA1	21990000.0	21023000.0	28595000.0	17030000.0
+H3F3A	1168800000.0	1257500000.0	711530000.0	656330000.0
+MRI1	881900000.0	899840000.0	1091600000.0	1179000000.0
+GTF2I	16687000.0	3546900.0	15558000.0	189740000.0
+ATP1A2	67133000.0	0.0	15581000.0	39434000.0
+NMRAL1	5569240000.0	6200920000.0	7314650000.0	7748610000.0
+UCK1	0.0	50735000.0	31593000.0	0.0
+PRPF39	0.0	0.0	0.0	1886100.0
+DSP	194160000.0	129820000.0	148260000.0	226090000.0
+SAMM50	0.0	26456000.0	20102000.0	20843000.0
+RNF40	48980000.0	43994000.0	105910000.0	100480000.0
+GSTO1	62996000.0	59545000.0	49517000.0	62363000.0
+DNAJC9	23409000.0	23764000.0	14316000.0	16816000.0
+GLYATL3	2073500000.0	2214600000.0	2183300000.0	2218300000.0
+ENSBTAG00000023978	20829000.0	20188000.0	12135000.0	26991000.0
+DNAJC3	173330000.0	177280000.0	182330000.0	175750000.0
+EML2	0.0	25028000.0	0.0	15575000.0
+TTC36	246340000.0	284180000.0	666360000.0	612860000.0
+GOSR2	104990000.0	100350000.0	80462000.0	113490000.0
+GFPT2	49734000.0	0.0	70280000.0	116000000.0
+TTC38	55043000.0	60633000.0	49663000.0	52739000.0
+ECHDC3	590930000.0	474040000.0	328390000.0	339840000.0
+ECHDC2	7802500000.0	8424700000.0	8855900000.0	8904700000.0
+ACP6	11703000.0	12264000.0	7557300.0	10371000.0
+ACP1	857533000.0	779677000.0	1197444000.0	1224882000.0
+RAP1B	403940000.0	411310000.0	455550000.0	447420000.0
+RAP1A	2903300000.0	2640500000.0	3437400000.0	3697100000.0
+ENSBTAG00000016551	16328000.0	33599000.0	0.0	15775000.0
+ACO1	2465000000.0	1470700000.0	1202000000.0	1146700000.0
+CHDH	85069000.0	69677000.0	95955000.0	97113000.0
+RHOA	5239900000.0	5109700000.0	4933500000.0	5240400000.0
+NCOA2	0.0	0.0	0.0	0.0
+ACO2	2661300000.0	939700000.0	972870000.0	993890000.0
+SPCS2	5684700.0	8702100.0	29550000.0	18156000.0
+FAM91A1	2727600.0	0.0	0.0	0.0
+NT5C3A	101360000.0	85581000.0	85376000.0	105570000.0
+ACAT1	8787800000.0	8410200000.0	3810400000.0	4089000000.0
+ACAT2	24303000000.0	25055000000.0	29217000000.0	28229000000.0
+CXHXorf38	37401000.0	28561000.0	38271000.0	36145000.0
+F11R	52302000.0	107690000.0	143020000.0	105760000.0
+HMGB2	314160000.0	338410000.0	226370000.0	385350000.0
+MECR	215380000.0	233960000.0	85610000.0	88874000.0
+DDB1	156980000.0	49841000.0	105300000.0	102380000.0
+IVD	2247400000.0	2419500000.0	1558500000.0	1558200000.0
+AUH	1987800000.0	1969600000.0	2032300000.0	1901300000.0
+MCAT	0.0	10209000.0	8928000.0	8429800.0
+SLC27A4	21869000.0	22144000.0	21744000.0	19533000.0
+SLC27A6	26640000.0	32492000.0	35755000.0	42067000.0
+SLC27A2	189020000.0	197120000.0	163280000.0	180080000.0
+CAPZA2	530420000.0	702340000.0	857540000.0	792770000.0
+CAPZA1	3598100000.0	3548100000.0	4179400000.0	4777900000.0
+TBCK	734480.0	0.0	649440.0	1094800.0
+RAB33B	153520000.0	102720000.0	76654000.0	89618000.0
+AK3	7759100000.0	7288600000.0	6306400000.0	6348000000.0
+AK2	27980000000.0	28630000000.0	25068000000.0	26240000000.0
+TBCE	654780000.0	877120000.0	757840000.0	492860000.0
+TBCD	19009000.0	0.0	21910000.0	21921000.0
+TBCB	324000000.0	325710000.0	278390000.0	267510000.0
+AK4	395180000.0	414330000.0	248640000.0	258250000.0
+HSPE1	23608000.0	80792000.0	59368000.0	31225000.0
+SARS	430650000.0	443220000.0	419060000.0	481080000.0
+PRKD2	2163800.0	0.0	0.0	0.0
+ERBB2	4884000.0	0.0	0.0	0.0
+CTTN	43436000.0	47242000.0	43085000.0	48554000.0
+DHFR	1740200000.0	1477000000.0	1762900000.0	2165600000.0
+ERC1	38037000.0	0.0	21255000.0	28060000.0
+BAX	43360000.0	36864000.0	50065000.0	49676000.0
+PLCG2	7212300.0	2835900.0	4744600.0	5089900.0
+ATPAF1	114410000.0	117340000.0	107900000.0	98351000.0
+EPS8	13950000.0	9986100.0	8169700.0	10896000.0
+LARS2	12105000.0	206510000.0	52200000.0	87478000.0
+EIF2S1	1611500000.0	1743600000.0	1535300000.0	1527700000.0
+EIF2S3	193160000.0	166960000.0	154030000.0	152370000.0
+DDX17	305970000.0	328530000.0	263060000.0	308100000.0
+PMPCB	256030000.0	240290000.0	208780000.0	198080000.0
+PMPCA	216970000.0	187260000.0	213870000.0	207170000.0
+SELENOO	22288000.0	19184000.0	39833000.0	42724000.0
+IDH2	1441805000.0	1491810000.0	965194000.0	1065233000.0
+PSMC1	284570000.0	244550000.0	282010000.0	294600000.0
+ATP6V1B2	136720000.0	127610000.0	139710000.0	142370000.0
+PSMC3	182230000.0	199400000.0	188850000.0	184930000.0
+PSMC4	365710000.0	359000000.0	339610000.0	324770000.0
+PSMC5	160340000.0	159690000.0	115220000.0	145500000.0
+PSMC6	397980000.0	363550000.0	283000000.0	296940000.0
+ENSBTAG00000015330	629930000.0	567720000.0	527870000.0	569780000.0
+ENSBTAG00000015557	1865100.0	0.0	3106200.0	0.0
+ENSBTAG00000044081	749530000.0	568590000.0	694880000.0	792730000.0
+SH3GLB2	8463300.0	7493500.0	0.0	159370000.0
+STS	54453000.0	35884000.0	122800000.0	140690000.0
+SEC61B	489200.0	0.0	0.0	0.0
+LACTB2	4347400000.0	4472700000.0	3501800000.0	3695700000.0
+LSM1	13156000.0	18146000.0	15418000.0	0.0
+TFG	231060000.0	187190000.0	206190000.0	176890000.0
+FN3KRP	1229600000.0	1059100000.0	1035000000.0	1063000000.0
+NCLN	152080000.0	177940000.0	127820000.0	131990000.0
+EEA1	9109400.0	6243800.0	4219000.0	0.0
+NCL	585560000.0	850620000.0	516610000.0	488000000.0
+ENSBTAG00000039362	312730000.0	274800000.0	427180000.0	382030000.0
+LIN7C	347900000.0	370150000.0	380120000.0	432210000.0
+OMA1	18137000.0	27609000.0	16932000.0	0.0
+ENSBTAG00000047986	54980000.0	49961000.0	72129000.0	102000000.0
+KDM1A	3210100.0	0.0	0.0	1443000.0
+IDI1	1732100000.0	1754300000.0	1558100000.0	1603100000.0
+SPTB	3261100.0	0.0	0.0	0.0
+DHTKD1	371470000.0	35336000.0	150570000.0	166320000.0
+OSBPL1A	2996500.0	0.0	1741200.0	0.0
+LRRC47	55696000.0	45239000.0	47743000.0	57702000.0
+ENSBTAG00000005217	148730000.0	174280000.0	78814000.0	83895000.0
+EIF3H	8211300.0	16216000.0	15633000.0	15753000.0
+EIF3I	1447300000.0	1183800000.0	1070900000.0	1090900000.0
+EIF3J	67464000.0	67117000.0	98300000.0	82445000.0
+EIF3K	322890000.0	350900000.0	305450000.0	291250000.0
+EIF3L	33837000.0	28365000.0	60974000.0	56500000.0
+TSFM	241410000.0	263770000.0	250870000.0	217000000.0
+DHRS7	42224000000.0	40914000000.0	51544000000.0	57261000000.0
+DHRS4	46148000000.0	52276000000.0	49870000000.0	47558000000.0
+EIF3D	115940000.0	103310000.0	94832000.0	113740000.0
+DHRS3	259230000.0	220010000.0	260220000.0	245840000.0
+EIF3F	28659000.0	30321000.0	9737800.0	49975000.0
+EIF3G	44380000.0	38629000.0	49336000.0	33630000.0
+RARS	421020000.0	461190000.0	388120000.0	442580000.0
+FADD	635820000.0	584640000.0	484590000.0	569950000.0
+ARMC10	590670000.0	646110000.0	781230000.0	728820000.0
+SMUG1	46233000.0	0.0	32933000.0	16841000.0
+NAAA	202390000.0	236140000.0	250890000.0	311820000.0
+DAAM1	177360000.0	153410000.0	137490000.0	133140000.0
+PCYT2	43546000.0	75507000.0	52121000.0	62600000.0
+ENSBTAG00000040409	72780000.0	63350000.0	22978000.0	39084000.0
+FCHSD1	18867000.0	0.0	69529000.0	59822000.0
+IMPA2	668170000.0	508980000.0	629650000.0	727880000.0
+GUK1	600500000.0	622230000.0	819250000.0	810160000.0
+TPR	4377200.0	0.0	0.0	0.0
+PHGDH	3016500000.0	3308700000.0	3191200000.0	3583800000.0
+HRG	41582000.0	57145000.0	83441000.0	79804000.0
+NTPCR	55046000.0	58638000.0	24581000.0	17952000.0
+VAT1	384930000.0	340080000.0	287610000.0	368870000.0
+MTCH2	9909400000.0	9516700000.0	11007000000.0	10783000000.0
+FN1	272520000.0	307450000.0	376280000.0	419020000.0
+PTGES3	535710000.0	507650000.0	380220000.0	369770000.0
+PTGES2	768370000.0	715060000.0	474010000.0	524950000.0
+ECHS1	1.042e+11	93904000000.0	92745000000.0	95872000000.0
+TIAL1	40850000.0	40639000.0	26974000.0	36134000.0
+CAVIN2	283650000.0	337430000.0	314580000.0	277880000.0
+CAVIN1	6458400.0	12604000.0	18334000.0	20531000.0
+FUBP3	55878000.0	36324000.0	41284000.0	45286000.0
+FUBP1	53941000.0	98845000.0	75181000.0	65423000.0
+CCAR1	2987600.0	0.0	0.0	0.0
+CCAR2	168770000.0	5344800.0	86653000.0	72024000.0
+MTDH	536590000.0	498300000.0	553010000.0	457660000.0
+AP2B1	210690000.0	89798000.0	139700000.0	106940000.0
+EXOSC4	16148000.0	27943000.0	0.0	15291000.0
+EXOSC5	21642000.0	0.0	0.0	0.0
+HCCS	31635000.0	50132000.0	27857000.0	23881000.0
+GFER	131060000.0	131770000.0	219950000.0	214240000.0
+NCOR2	103210000.0	174110000.0	80200000.0	33893000.0
+CEACAM1	3017300.0	0.0	0.0	0.0
+NID2	51885000.0	0.0	16227000.0	20924000.0
+NID1	34640000.0	0.0	31044000.0	38118000.0
+ENSBTAG00000015047	2372900000.0	2309800000.0	2608400000.0	2341200000.0
+PLEK2	94573000.0	591440000.0	17434000.0	18573000.0
+PALM3	27516000.0	0.0	3049500.0	2271200.0
+FARP1	36974800.0	35813000.0	33092100.0	41041100.0
+MBNL1	21421000.0	20153000.0	19394000.0	18543000.0
+AGMAT	24908000000.0	28509000000.0	25680000000.0	22034000000.0
+F10	1728500.0	0.0	26107000.0	14858000.0
+EXOG	12691000.0	16761000.0	14969000.0	19034000.0
+MARC2	26408000000.0	26152000000.0	24338000000.0	24444000000.0
+RALY	468740000.0	517820000.0	508230000.0	535050000.0
+SRRT	54387000.0	0.0	37105000.0	34403000.0
+SARDH	1019100000.0	299440000.0	829370000.0	740770000.0
+VPS53	3957300.0	0.0	0.0	0.0
+ALKBH7	74969000.0	0.0	90221000.0	67076000.0
+RALB	632920000.0	666750000.0	536810000.0	533570000.0
+RALA	220130000.0	242390000.0	221350000.0	283720000.0
+KRT75	1814600.0	0.0	0.0	0.0
+TMEM126A	131110000.0	118470000.0	113320000.0	161960000.0
+PSMB10	377950000.0	502400000.0	659040000.0	377810000.0
+MOCOS	3352900.0	0.0	2758400.0	1651800.0
+SCYL1	3084200.0	0.0	0.0	3542400.0
+STXBP3	36608000.0	35304000.0	37045000.0	40702000.0
+STXBP2	200370000.0	203900000.0	201790000.0	195670000.0
+HAAO	17254000000.0	16903000000.0	19520000000.0	19763000000.0
+FASN	47526000.0	8601000.0	11537000.0	12080000.0
+SKP1	0.0	34787000.0	31102000.0	35879000.0
+DNAJB2	0.0	12936000.0	42789000.0	31512000.0
+DNAJB1	152920000.0	307470000.0	324330000.0	274000000.0
+H1FX	360370000.0	358920000.0	427780000.0	491390000.0
+CRYBG1	0.0	0.0	4198700.0	4369300.0
+OXSM	20866000.0	24353000.0	16970000.0	9761600.0
+CRYBG2	1329700.0	0.0	0.0	0.0
+AMDHD1	1158900000.0	1139600000.0	1079200000.0	1107900000.0
+AMDHD2	33673000.0	28868000.0	27764000.0	32253000.0
+HNRNPAB	651040000.0	793750000.0	568680000.0	491010000.0
+TTC23	6096600.0	0.0	0.0	0.0
+CARS	50824000.0	3450600.0	20045000.0	20439000.0
+HNRNPA0	162760000.0	164640000.0	135370000.0	138070000.0
+HNRNPA1	2463000000.0	2315400000.0	2085600000.0	2012100000.0
+ENO1	13938000000.0	13450000000.0	15301000000.0	15022000000.0
+PDF	395910000.0	370490000.0	339520000.0	327050000.0
+RACK1	7092700000.0	6367200000.0	8286400000.0	8317400000.0
+ENSBTAG00000017949	1008400000.0	875160000.0	366020000.0	491960000.0
+LLGL2	92597000.0	99576000.0	141280000.0	146720000.0
+LRRFIP1	29188000.0	40244000.0	49768000.0	72301000.0
+ACOX2	3829100000.0	3623500000.0	2174300000.0	2234100000.0
+ACOX3	4737600.0	6265800.0	7690800.0	7903200.0
+ACOX1	22954000.0	0.0	0.0	0.0
+CDK1	22698000.0	25113000.0	0.0	0.0
+CDK3	50570000.0	52637000.0	16385000.0	17364000.0
+SGSH	365980000.0	324970000.0	312780000.0	371550000.0
+IGLL1	37245000000.0	38150000000.0	49997000000.0	46525000000.0
+SRP68	72867000.0	68806000.0	47762000.0	58661000.0
+ANKFY1	22928000.0	2259300.0	9643300.0	13949000.0
+RAP2B	43747000.0	41451000.0	39737000.0	52425000.0
+LCN2	473030000.0	495830000.0	2190100000.0	2312300000.0
+PHB2	14570000000.0	15835000000.0	15572000000.0	13504000000.0
+PNPT1	108830000.0	10909000.0	46601000.0	42147000.0
+MSH3	624170.0	0.0	0.0	0.0
+SF3B1	30652000.0	0.0	12178000.0	6331600.0
+PRKAA2	22386000.0	29186000.0	24713000.0	26486000.0
+SF3B3	37779000.0	0.0	33052000.0	30302000.0
+SF3B2	12148000.0	0.0	3880900.0	4523900.0
+LIMS2	68681000.0	49389000.0	72408000.0	56323000.0
+LIMS1	176630000.0	167430000.0	156540000.0	185710000.0
+SORBS3	1780700.0	0.0	10256000.0	0.0
+SORBS2	8050700.0	0.0	25840000.0	27677000.0
+ELAC2	8743400.0	0.0	0.0	3576000.0
+SUN2	5359700.0	0.0	4328700.0	3597200.0
+ENSBTAG00000008248	27859000.0	19503000.0	21237000.0	22628000.0
+HSPD1	24779000000.0	26310000000.0	21343000000.0	21390000000.0
+OGN	277950000.0	268390000.0	407830000.0	450630000.0
+ARHGDIB	813150000.0	870900000.0	830500000.0	873750000.0
+MTX2	235680000.0	268430000.0	184300000.0	215350000.0
+MTX1	253650000.0	303580000.0	215260000.0	262030000.0
+ARHGDIA	6133000000.0	6163900000.0	4854200000.0	5586900000.0
+NANS	1369400000.0	1584200000.0	1064400000.0	1174000000.0
+PACSIN3	511050000.0	611490000.0	767040000.0	762130000.0
+PACSIN2	203080000.0	213090000.0	214120000.0	179250000.0
+COPA	285410000.0	196510000.0	207530000.0	232740000.0
+LIAS	68705000.0	85871000.0	89511000.0	98811000.0
+COPE	1925000000.0	1786300000.0	1469000000.0	1494500000.0
+SUPT16H	4967400.0	0.0	4353500.0	3144500.0
+PRKCB	5692800.0	0.0	0.0	0.0
+ENDOG	1192000000.0	979650000.0	1206600000.0	1323000000.0
+PRKCD	5263100.0	7262400.0	8195900.0	0.0
+CES1	19811000000.0	19203000000.0	27937000000.0	28072000000.0
+CES3	3299300000.0	2830800000.0	2799400000.0	2828600000.0
+CES2	2073500000.0	2364800000.0	1944500000.0	2248600000.0
+LMAN1	454230000.0	626990000.0	594030000.0	543510000.0
+LMAN2	3057800000.0	2646800000.0	4289300000.0	4657600000.0
+LMNA	2285600000.0	2570700000.0	2084900000.0	2261600000.0
+BDH2	2082010000.0	2178410000.0	2430930000.0	2244640000.0
+PM20D2	2923200.0	3977800.0	1970400.0	0.0
+DDX23	864940.0	0.0	0.0	0.0
+DDX21	31296000.0	21035000.0	12854000.0	9692300.0
+BOLA-DQB	73582000.0	85353000.0	114110000.0	106780000.0
+PFKFB1	0.0	4961200.0	19186000.0	47082000.0
+ASPG	4961100.0	4155000.0	4491200.0	4560700.0
+SCRIB	60499000.0	62792000.0	47001000.0	0.0
+GSTP1	4371300000.0	4057500000.0	6520900000.0	7469500000.0
+VTI1B	43362000.0	44407000.0	40074000.0	45530000.0
+ATP6V1C1	29188000.0	21534000.0	19369000.0	19734000.0
+SCIN	2994700.0	0.0	18311000.0	22510000.0
+FKBP15	7023100.0	0.0	3679400.0	0.0
+ADD3	20047000.0	28667000.0	26452000.0	48150000.0
+ACTG1	51480000000.0	50208000000.0	31538000000.0	32135000000.0
+ADD1	35651000.0	38069000.0	46936000.0	44303000.0
+FKBP11	2676300000.0	2445100000.0	1980400000.0	2091500000.0
+FAM3C	88594000.0	108460000.0	42139000.0	36101000.0
+PPP4R1	6162100.0	0.0	0.0	0.0
+PPIL1	22931000.0	35736000.0	10862000.0	0.0
+TPI1	36701000000.0	40003000000.0	37378000000.0	39558000000.0
+KCNB2	0.0	0.0	0.0	0.0
+TMED10	2685000000.0	2666900000.0	2134500000.0	2018500000.0
+OCIAD2	28912000.0	28398000.0	32504000.0	57851000.0
+PPP1R7	54315000.0	52746000.0	51403000.0	55323000.0
+OCIAD1	1036700000.0	998950000.0	999460000.0	954180000.0
+MAP3K2	0.0	0.0	0.0	0.0
+CCDC93	47566000.0	0.0	58470000.0	61652000.0
+NUP210	1219000.0	0.0	0.0	0.0
+PRTN3	28744000.0	39149000.0	117300000.0	126050000.0
+CTSH	777800000.0	866650000.0	641140000.0	571210000.0
+FMO3	3652900000.0	3466200000.0	4860800000.0	4801900000.0
+IARS	39339000.0	0.0	89708000.0	88815000.0
+HAL	231170000.0	278770000.0	125930000.0	140100000.0
+FMO4	17259000.0	28182000.0	23173000.0	26257000.0
+FMO5	199550000.0	205290000.0	468920000.0	488670000.0
+CTSA	542370000.0	680410000.0	589350000.0	522960000.0
+IDH1	4895100000.0	5051800000.0	4142000000.0	4384300000.0
+CTSC	3415900000.0	3569300000.0	3433600000.0	3413600000.0
+CTSD	6722100000.0	6930900000.0	6482600000.0	7143000000.0
+SH3GLB1	53229000.0	39615000.0	36921000.0	35230000.0
+CTSF	156090000.0	168280000.0	175310000.0	125690000.0
+RPL14	4248200000.0	4059900000.0	2532100000.0	2681500000.0
+RPL15	1729500000.0	1419100000.0	1279500000.0	1825300000.0
+CTSZ	18597000000.0	15600000000.0	13075000000.0	12682000000.0
+RPL17	3220600000.0	3574000000.0	1477300000.0	1384600000.0
+RPL10	3494500000.0	3467800000.0	2360700000.0	2117300000.0
+RPL11	4142800000.0	4254700000.0	3891500000.0	3549500000.0
+RPL12	3879600000.0	3666700000.0	1366500000.0	1219100000.0
+RPL13	6369100000.0	6873200000.0	4947700000.0	4429700000.0
+CTSS	641050000.0	599690000.0	792220000.0	744280000.0
+RPL18	3998000000.0	3785600000.0	3712300000.0	3291700000.0
+RPL19	3935200000.0	3942300000.0	3489600000.0	3164300000.0
+CTSW	510450000.0	540710000.0	266270000.0	121860000.0
+PCYT1A	197660000.0	224690000.0	51222000.0	49702000.0
+SMPDL3A	91053000.0	83964000.0	92986000.0	106940000.0
+INPP5D	2991900.0	0.0	0.0	2627600.0
+EMILIN1	182650000.0	51722000.0	172360000.0	195170000.0
+NME2	393490000.0	605370000.0	415900000.0	404870000.0
+RAI14	8185500.0	0.0	0.0	0.0
+LXN	33168000.0	54613000.0	36866000.0	33389000.0
+ENSBTAG00000000258	337270000.0	377260000.0	496440000.0	516970000.0
+ENSBTAG00000040418	1636300000.0	1573800000.0	2015500000.0	2007900000.0
+JDP2	0.0	0.0	0.0	0.0
+EPB42	3341000.0	0.0	2289800.0	2726300.0
+EPB41	151290000.0	90069000.0	93820000.0	104110000.0
+GATD3A	24278000000.0	24001000000.0	25014000000.0	24407000000.0
+MATR3	387950000.0	301490000.0	191690000.0	319400000.0
+PRPF3	0.0	7330700.0	0.0	5101100.0
+RGN	1.7487e+11	1.6771e+11	2.3475e+11	2.1956e+11
+ENSBTAG00000046076	0.0	30337000.0	33009000.0	16256000.0
+AHNAK	62954000.0	91922000.0	97251000.0	103110000.0
+ECH1	19804000000.0	21642000000.0	15686000000.0	16246000000.0
+ALDH16A1	1068100000.0	366670000.0	438640000.0	426760000.0
+CLUH	161810000.0	62928000.0	0.0	8364500.0
+ENSBTAG00000035915	42196000.0	42411000.0	49850000.0	44367000.0
+PDCL3	6776900.0	0.0	20900000.0	0.0
+ERP29	2794700000.0	2950700000.0	2772100000.0	2875200000.0
+PSMB8	47861000.0	29808000.0	21432000.0	47341000.0
+KATNAL2	151030000.0	26771000.0	15252000.0	59065000.0
+PHKA2	4373200.0	0.0	0.0	3915600.0
+UBA6	9560000.0	0.0	5302100.0	3196000.0
+UBA7	64562000.0	5941900.0	28619000.0	25812000.0
+SFPQ	303710000.0	200690000.0	175190000.0	149360000.0
+UBA5	18137000.0	20711000.0	16059000.0	27229000.0
+UBA2	48708000.0	21750000.0	33962000.0	38280000.0
+UBA3	24477000.0	21789000.0	28129000.0	26848000.0
+UBA1	773630000.0	238450000.0	884200000.0	623960000.0
+DECR1	32666622000.0	32417000000.0	32263000000.0	32639000000.0
+UBE2K	282550000.0	256750000.0	197150000.0	219670000.0
+NAA15	28066000.0	25629000.0	31917000.0	19460000.0
+UBE2M	452720000.0	381780000.0	433450000.0	460150000.0
+GNAQ	190540000.0	217270000.0	201800000.0	207460000.0
+GNAS	79493000.0	96616000.0	66508000.0	85022000.0
+MOGS	157710000.0	0.0	84042000.0	75009000.0
+HYOU1	263610000.0	15443000.0	113430000.0	108030000.0
+PTCD3	20875000.0	0.0	28354000.0	24777000.0
+GNAZ	7877300.0	9050100.0	12153000.0	11709000.0
+GULO	342660000.0	304250000.0	689650000.0	704580000.0
+UBE2Z	56872000.0	36546000.0	38106000.0	30645000.0
+FGGY	27503000.0	42423000.0	46648000.0	55187000.0
+UBE2S	36018000.0	29085000.0	0.0	0.0
+AGFG2	75815000.0	106240000.0	106730000.0	118310000.0
+AGFG1	57023000.0	47889000.0	68141000.0	73310000.0
+FARS2	19744000.0	17685000.0	0.0	0.0
+ASNA1	773440000.0	681330000.0	843850000.0	786840000.0
+LIPT1	17492000.0	14103000.0	10373000.0	10837000.0
+SEC14L3	127310000.0	129660000.0	112920000.0	120980000.0
+SEC14L2	984900000.0	1094500000.0	560070000.0	672510000.0
+RPL18A	2324000000.0	2565700000.0	2196100000.0	1974000000.0
+ILK	182480000.0	226830000.0	196530000.0	231450000.0
+SEC14L4	199170000.0	163940000.0	110170000.0	118640000.0
+ATP5PB	12820000000.0	11176000000.0	11918000000.0	12535000000.0
+KRT7	314600000.0	217320000.0	295580000.0	286440000.0
+GLUL	293030000.0	288230000.0	354270000.0	405070000.0
+KRT8	18233000000.0	17934000000.0	20363000000.0	21236000000.0
+NLRX1	77299000.0	0.0	81727000.0	84947000.0
+VPS45	15508000.0	11005000.0	9874800.0	13410000.0
+SRPRB	1016100000.0	1065000000.0	1279300000.0	1375400000.0
+RBM8A	74197000.0	125190000.0	77868000.0	54192000.0
+SRPRA	190710000.0	226460000.0	142170000.0	129120000.0
+TALDO1	7582400000.0	6507700000.0	5879900000.0	7114500000.0
+PGLYRP1	663080000.0	787700000.0	1130900000.0	1184200000.0
+EHHADH	13963000000.0	6189600000.0	10016000000.0	9594100000.0
+CAST	20281000.0	0.0	28188000.0	25237000.0
+VCPIP1	10327000.0	0.0	0.0	4287000.0
+ARL3	234110000.0	209430000.0	316550000.0	285210000.0
+ENSBTAG00000003523	33756000.0	23727000.0	78845000.0	66920000.0
+EPB41L2	86358000.0	0.0	57522000.0	66166000.0
+EPB41L5	9423300.0	13086000.0	12743000.0	10754000.0
+THRAP3	18137000.0	8054300.0	7085900.0	9484700.0
+ACSS3	2699900000.0	2846900000.0	2387700000.0	2533100000.0
+ACSS2	27423000.0	0.0	27983000.0	15104000.0
+NDUFA8	1531000000.0	1667300000.0	1335900000.0	1981500000.0
+NDUFA9	2293400000.0	2357600000.0	2591500000.0	2678400000.0
+UAP1L1	27004000.0	21346000.0	21899000.0	20449000.0
+VPS4A	60431000.0	65159000.0	65855000.0	78673000.0
+VPS4B	40045000.0	30555000.0	50786000.0	38584000.0
+TARDBP	106330000.0	95081000.0	115350000.0	94660000.0
+RAB9A	432190000.0	484800000.0	317400000.0	324330000.0
+CYP1A1	149550000.0	129750000.0	244960000.0	216540000.0
+CYP1A2	2177100000.0	2196200000.0	2350000000.0	2187000000.0
+MTR	34685000.0	11951000.0	15125000.0	14127000.0
+LGMN	3619800000.0	3529000000.0	4623100000.0	5256100000.0
+GSTM1	25500200000.0	24900500000.0	32739000000.0	35628000000.0
+GSTM3	19779000000.0	21608000000.0	27427000000.0	29564000000.0
+AGXT	7129300000.0	7491900000.0	7986200000.0	7641600000.0
+FARSB	182730000.0	189830000.0	144080000.0	132310000.0
+PALLD	8679300.0	0.0	8171400.0	0.0
+STX12	152630000.0	170780000.0	112460000.0	153720000.0
+BLMH	76783000.0	78981000.0	103480000.0	95359000.0
+STX17	73252000.0	59136000.0	42960000.0	50284000.0
+EFHD2	808170000.0	795930000.0	1392700000.0	1440200000.0
+ECPAS	2819100.0	0.0	2187500.0	2767300.0
+SAT2	23647000.0	20440000.0	0.0	24250000.0
+COLGALT1	51908000.0	65978000.0	38164000.0	34711000.0
+CUTC	544350000.0	580280000.0	499070000.0	541680000.0
+GPRIN3	1549000.0	21820000.0	0.0	8729200.0
+EIF5	154010000.0	151970000.0	126210000.0	154450000.0
+EIF6	757590000.0	754530000.0	749640000.0	723560000.0
+PDCD6	189920000.0	203270000.0	130340000.0	91371000.0
+INSR	0.0	0.0	0.0	3701900.0
+HIST2H2BE	395700000.0	507480000.0	383010000.0	392640000.0
+GNE	149300000.0	229290000.0	126710000.0	115170000.0
+LTA4H	231960000.0	227620000.0	272880000.0	291150000.0
+SPTBN5	62616000.0	75120000.0	62204000.0	59634000.0
+SPTBN1	1066100000.0	618950000.0	538410000.0	514710000.0
+RNF170	52684000.0	43726000.0	43482000.0	0.0
+CBR4	1895000000.0	1597400000.0	1625500000.0	1595900000.0
+CBR1	45169000000.0	44583000000.0	51518000000.0	52021000000.0
+NSF	33267000.0	0.0	40164000.0	38914000.0
+TLN1	1353100000.0	1035300000.0	807240000.0	824130000.0
+DPP8	2329600.0	0.0	0.0	0.0
+DPP9	9858600.0	0.0	0.0	0.0
+GBE1	820100000.0	388300000.0	423290000.0	506750000.0
+DPP3	889540000.0	704960000.0	691810000.0	788880000.0
+SUOX	1001300000.0	1052500000.0	1037200000.0	1192300000.0
+FDPS	6532500000.0	7222300000.0	10255000000.0	9408800000.0
+DPP7	36044000.0	55035000.0	54175000.0	51587000.0
+PCNA	1196200000.0	1183200000.0	676130000.0	570480000.0
+ANXA3	6227200000.0	6986200000.0	7616800000.0	9010800000.0
+ANXA2	12392000000.0	13715000000.0	15879000000.0	16667000000.0
+ANXA5	3831200000.0	3899000000.0	5371000000.0	5123200000.0
+ANXA4	57509000000.0	61393000000.0	65991000000.0	71300000000.0
+ANXA7	501658000.0	493602000.0	493771000.0	546609000.0
+ANXA6	28930820000.0	31134100000.0	17575962000.0	18065563000.0
+ANXA9	873130000.0	778370000.0	1477100000.0	1120300000.0
+MCM7	28289000.0	0.0	16851000.0	15345000.0
+MCM6	51609000.0	0.0	5192100.0	8313100.0
+MCM5	33963000.0	87058000.0	348180000.0	307680000.0
+GCLM	451700000.0	494290000.0	478850000.0	476610000.0
+MCM3	40561000.0	0.0	30498000.0	51654000.0
+MCM2	35871000.0	0.0	15951000.0	4519800.0
+MESD	111960000.0	100020000.0	95917000.0	100560000.0
+SAMHD1	8304200.0	0.0	8626300.0	23533000.0
+AMACR	1741500000.0	1704500000.0	1293400000.0	1431100000.0
+DNPH1	54309000.0	82524000.0	36791000.0	84126000.0
+RPA1	15562000.0	16349000.0	14598000.0	13098000.0
+RPA2	51733000.0	44246000.0	43839000.0	52806000.0
+NDUFS1	561530000.0	436080000.0	364380000.0	345850000.0
+NDUFS2	154630000.0	147360000.0	149270000.0	166000000.0
+NDUFS3	2121800000.0	1951700000.0	2142600000.0	2222400000.0
+COQ9	1663063000.0	1696043000.0	1470893000.0	1294859000.0
+ENSBTAG00000024700	71916000.0	83590000.0	65987000.0	67174000.0
+NDUFS7	532520000.0	435100000.0	210290000.0	51955000.0
+COQ5	581520000.0	521600000.0	494730000.0	446930000.0
+CGNL1	112190000.0	53094000.0	90884000.0	88675000.0
+COQ7	438900000.0	485280000.0	324680000.0	310660000.0
+AHCY	28662000000.0	28293000000.0	30398000000.0	34027000000.0
+COQ3	498400000.0	528560000.0	400750000.0	454190000.0
+M6PR	106230000.0	97835000.0	120750000.0	175820000.0
+AOC1	109010000.0	24364000.0	77766000.0	73010000.0
+AOC3	812360000.0	89551000.0	583060000.0	584640000.0
+PEX11G	135580000.0	112890000.0	171920000.0	169500000.0
+PARS2	0.0	0.0	0.0	0.0
+BHLHE22	0.0	0.0	71158000.0	0.0
+AOX1	1953100000.0	716570000.0	2251900000.0	2376600000.0
+CHMP2A	66669000.0	67094000.0	60484000.0	37740000.0
+DHX15	58899000.0	6545100.0	23096000.0	25348000.0
+HIBADH	8889900000.0	8918900000.0	5910600000.0	5851400000.0
+ZFYVE1	1341600.0	0.0	0.0	0.0
+NHLRC3	46149000.0	57803000.0	48254000.0	58503000.0
+NHLRC2	4883300.0	0.0	0.0	0.0
+PPT1	470770000.0	513060000.0	475800000.0	483950000.0
+CPT2	4147000000.0	4138600000.0	3426100000.0	3578900000.0
+DSC2	241120000.0	230170000.0	229060000.0	239900000.0
+DDX31	91006000.0	65068000.0	35418000.0	59505000.0
+NDUFB11	49711000.0	74042000.0	26878000.0	23153000.0
+NDUFB10	2443300000.0	2292600000.0	2145700000.0	2451000000.0
+PYGB	5038500.0	0.0	0.0	0.0
+PITRM1	4401000.0	0.0	0.0	0.0
+GOT2	15168000000.0	15711000000.0	17377000000.0	16890000000.0
+LYN	9120000.0	9320000.0	15355000.0	16437000.0
+GOT1	3939400000.0	3894500000.0	3347300000.0	3298500000.0
+PYGL	10260000000.0	7764600000.0	8177400000.0	8027400000.0
+PYGM	0.0	641520000.0	342240000.0	326890000.0
+PFAS	116970000.0	5426000.0	46715000.0	55055000.0
+ENSBTAG00000017021	14312000.0	0.0	0.0	0.0
+SOD2	1335700000.0	1396400000.0	1474900000.0	1534700000.0
+SOD3	651200000.0	822230000.0	948790000.0	899470000.0
+VWA8	341790300.0	175610000.0	302330000.0	298046300.0
+SOD1	3476600000.0	3398000000.0	2284900000.0	2682900000.0
+ENSBTAG00000017759	124570000.0	74164000.0	222560000.0	165920000.0
+SAFB	66893000.0	50901000.0	43734000.0	42652000.0
+RANGAP1	7067200.0	7009300.0	9361700.0	7900600.0
+EMC10	57073000.0	39983000.0	69614000.0	64358000.0
+ENSBTAG00000013274	223280000.0	232510000.0	154660000.0	172040000.0
+QTRT1	0.0	0.0	0.0	0.0
+CGN1	41303000.0	30008000.0	46164000.0	56803000.0
+DOHH	27498000.0	33151000.0	35121000.0	27837000.0
+OTUD6B	89678000.0	76788000.0	51341000.0	77433000.0
+FBXL8	11310000.0	14429000.0	8266600.0	6405100.0
+H2AFV	34890000.0	45036000.0	56157000.0	51847000.0
+SNRNP200	21724000.0	13020000.0	21837000.0	15255000.0
+H2AFY	103830000.0	117450000.0	109050000.0	119900000.0
+ZADH2	8863900000.0	8843300000.0	9978500000.0	10337000000.0
+NIPSNAP3A	1325900000.0	1362400000.0	2047200000.0	1620400000.0
+DDX5	53475000.0	50959000.0	37654000.0	40410000.0
+C2H2orf72	769520000.0	825430000.0	1014000000.0	1080100000.0
+SERPING1	108060000.0	96561000.0	191090000.0	215290000.0
+DDX1	306970000.0	4202400.0	68413000.0	94384000.0
+ENSBTAG00000025929	4945200000.0	4806800000.0	4763500000.0	4842400000.0
+UPF1	77443000.0	29656000.0	19780000.0	31133000.0
+H2AFJ	579290000.0	540270000.0	643320000.0	691320000.0
+NIT2	3787900000.0	3926500000.0	5231900000.0	5395100000.0
+NIT1	1914900000.0	1826900000.0	2278000000.0	2208000000.0
+ENSBTAG00000031788	12251000.0	12424000.0	18979000.0	43093000.0
+TYSND1	5808300.0	0.0	4561700.0	0.0
+ENSBTAG00000031785	8269900000.0	10404000000.0	7464800000.0	6968900000.0
+NFKBIA	7862600.0	23052000.0	20722000.0	29700000.0
+CLTA	40441000.0	27067000.0	56439000.0	62688000.0
+PPP1R21	12882000.0	0.0	7442800.0	5347900.0
+CLTC	836140000.0	1051100000.0	516710000.0	577210000.0
+CLTB	0.0	17690000.0	36525000.0	28991000.0
+ENSBTAG00000047121	573270000.0	576240000.0	730850000.0	594070000.0
+MMS19	13350000.0	0.0	7990600.0	8650500.0
+RMDN3	103650000.0	102940000.0	69490000.0	80083000.0
+SFN	2360700000.0	2952100000.0	235350000.0	2126500000.0
+CRYZ	21334000000.0	23920000000.0	31852000000.0	34523000000.0
+HARS	252340000.0	241990000.0	248210000.0	291880000.0
+UBE3A	7016600.0	0.0	3453700.0	0.0
+IBA57	583430000.0	616490000.0	637590000.0	648760000.0
+UBXN4	213830000.0	164540000.0	191520000.0	132110000.0
+MYD88	51357000.0	56938000.0	59210000.0	62204000.0
+ENSBTAG00000039237	4651500000.0	5692400000.0	6623100000.0	6332400000.0
+MPDZ	53991000.0	40869000.0	24504000.0	26572000.0
+TOP2A	781230.0	0.0	0.0	0.0
+NACA	228680000.0	236110000.0	324470000.0	381610000.0
+FAF1	7673300.0	0.0	0.0	4751500.0
+PGM5	0.0	0.0	0.0	0.0
+FAF2	40872000.0	62389000.0	27656000.0	41586000.0
+PGM1	4440800000.0	4537800000.0	4827600000.0	4844900000.0
+PGM2	1469200000.0	1543700000.0	1479500000.0	1498000000.0
+PGM3	18637000.0	19628000.0	18628000.0	26373000.0
+MIA3	12156000.0	0.0	5733200.0	0.0
+SART3	6301200.0	0.0	14114000.0	12604000.0
+SART1	3263400.0	0.0	0.0	0.0
+VPS41	1267800.0	0.0	3822500.0	3939900.0
+SLC25A42	772200000.0	811080000.0	866880000.0	798000000.0
+BCAM	20884000.0	8829400.0	21085000.0	21786000.0
+SEC23B	33867000.0	4725400.0	1743000.0	3546800.0
+GLOD4	7264400000.0	7997780000.0	7767330000.0	7859090000.0
+GCH1	62330000.0	102280000.0	42598000.0	43051000.0
+ENSBTAG00000004632	66761000.0	61788000.0	54623000.0	57342000.0
+DBT	824520000.0	907080000.0	970660000.0	905350000.0
+ECI2	11998000000.0	10503000000.0	13667000000.0	12394000000.0
+ECI1	49053000000.0	50408000000.0	50309000000.0	52872000000.0
+HTT	0.0	0.0	0.0	0.0
+NUP155	5398100.0	0.0	6560200.0	11867000.0
+IPO7	558980.0	0.0	3549600.0	0.0
+IPO4	1282600.0	0.0	0.0	0.0
+IPO5	207010000.0	15104000.0	134650000.0	131320000.0
+ACTR3	589490000.0	577080000.0	690190000.0	496180000.0
+ACTR2	339810000.0	375250000.0	353270000.0	398350000.0
+NRBP1	13467000.0	10765000.0	8163100.0	12121000.0
+VPS11	4068100.0	0.0	0.0	7676800.0
+ENSBTAG00000047815	4144800000.0	4195600000.0	5895500000.0	6026800000.0
+SDCBP	70516000.0	44222000.0	88539000.0	34817000.0
+CARS2	24571000.0	21477000.0	27373000.0	26183000.0
+CASK	15213000.0	0.0	18538000.0	0.0
+ENSBTAG00000009029	75577000.0	89719000.0	52020000.0	56676000.0
+RAB8B	201540000.0	194470000.0	360960000.0	273410000.0
+TNPO3	5451400.0	0.0	2109700.0	2213100.0
+RAB8A	485730000.0	599500000.0	837160000.0	524010000.0
+NAA25	0.0	0.0	0.0	0.0
+ENSBTAG00000032899	630520000.0	606760000.0	938120000.0	930280000.0
+POLDIP2	468910000.0	514350000.0	448140000.0	450470000.0
+MARS2	20453000.0	14362000.0	27635000.0	20742000.0
+SCPEP1	38589000.0	38425000.0	33093000.0	28333000.0
+MAPK3	16307000.0	18497000.0	13223000.0	12973000.0
+MAPK1	32167000.0	360170000.0	365250000.0	555200000.0
+ALDH18A1	19420000.0	0.0	11583000.0	12943000.0
+DUSP3	36057000.0	40290000.0	11706000.0	13104000.0
+SHPK	472510000.0	478650000.0	678080000.0	691770000.0
+DAZAP1	185500000.0	236050000.0	160090000.0	103110000.0
+PHYHD1	156520000.0	204840000.0	302510000.0	294870000.0
+COPS6	495700000.0	443710000.0	459260000.0	530150000.0
+RDX	805490000.0	654060000.0	490460000.0	551000000.0
+FERMT2	113130000.0	67171000.0	78370000.0	81067000.0
+COPS4	32884000.0	41763000.0	31851000.0	37734000.0
+GGCT	233070000.0	204120000.0	196030000.0	192620000.0
+VKORC1	61907000.0	59484000.0	75052000.0	83794000.0
+BCAP31	592330000.0	727100000.0	1673600000.0	1411300000.0
+VPS35	286760000.0	111630000.0	210500000.0	194850000.0
+WDR91	14384000.0	20024000.0	12884000.0	19905000.0
+GLB1	18835000.0	21894000.0	17772000.0	20107000.0
+DECR2	8421500000.0	7468100000.0	9069000000.0	8870000000.0
+STAT5B	4568300.0	0.0	9181900.0	8121500.0
+DGUOK	305470000.0	246800000.0	279560000.0	208370000.0
+CSE1L	25854000.0	0.0	29781000.0	23297000.0
+XYLB	2292200000.0	2565300000.0	2974100000.0	3121500000.0
+TBC1D17	4090500.0	0.0	9381800.0	8648500.0
+FBL	647010000.0	648360000.0	573420000.0	506720000.0
+RPL35	76659000.0	37473000.0	67295000.0	70764000.0
+NUMA1	15611000.0	0.0	6404500.0	7354300.0
+PMVK	580610000.0	630530000.0	426150000.0	425490000.0
+DHX30	13084000.0	0.0	9093200.0	7888100.0
+HSPA1A	7164100000.0	7135300000.0	6877400000.0	7024000000.0
+ACAD10	1869400000.0	1890500000.0	1708000000.0	1918800000.0
+ACAD11	1778300000.0	1825100000.0	1658100000.0	1390400000.0
+CARNS1	26010000.0	0.0	29741000.0	36175000.0
+HSPA1L	17586000.0	21160000.0	5967700.0	4641700.0
+IDH3A	336200000.0	308770000.0	239140000.0	233020000.0
+IDH3B	29051000.0	44462000.0	31891000.0	20229000.0
+HCFC1	2931600.0	0.0	0.0	0.0
+HAGH	24107000000.0	26914000000.0	26049000000.0	27911000000.0
+PLOD3	80936000.0	18980000.0	83295000.0	105260000.0
+CPNE1	110960000.0	107260000.0	155020000.0	172540000.0
+PLOD1	3693000.0	0.0	10977000.0	11895000.0
+NRAS	245220000.0	230330000.0	319550000.0	266400000.0
+DNASE2	68387000.0	69568000.0	48293000.0	60554000.0
+FOXRED1	157620000.0	147230000.0	136350000.0	173040000.0
+PXN	12182000.0	15878000.0	15583000.0	16581000.0
+G3BP1	45086000.0	63729000.0	97263000.0	38720000.0
+ATP5ME	24444000.0	0.0	31522000.0	34050000.0
+UFL1	46619000.0	43829000.0	38802000.0	43535000.0
+RAD21	4059800.0	0.0	0.0	6626400.0
+USP13	207820000.0	24651000.0	119790000.0	155630000.0
+ALDH6A1	19642000000.0	19976000000.0	20662000000.0	21415000000.0
+USP15	309830000.0	336150000.0	340380000.0	376260000.0
+SNRPB	141900000.0	121870000.0	147290000.0	130060000.0
+SNRPA	185060000.0	214310000.0	229040000.0	164990000.0
+INPP1	23503000.0	25989000.0	26898000.0	24516000.0
+SMU1	28960000.0	29580000.0	26580000.0	28683000.0
+AKR1D1	14875000000.0	14827000000.0	23590000000.0	19503000000.0
+TXNDC12	74339000.0	78128000.0	57526000.0	52461000.0
+LYZ1	25736000.0	29417000.0	51292000.0	51012000.0
+ALOX15B	1223700.0	0.0	6840200.0	8275900.0
+PUDP	75299000.0	61468000.0	58442000.0	66633000.0
+SCFD1	110330000.0	93305000.0	91714000.0	89646000.0
+SCFD2	8836900.0	10435000.0	4580800.0	5348200.0
+PRKAG1	296650000.0	285340000.0	498310000.0	528240000.0
+ENSBTAG00000033457	6347400.0	0.0	0.0	0.0
+OXNAD1	94587000.0	120280000.0	164910000.0	101440000.0
+OR5C1	0.0	0.0	0.0	0.0
+P4HA1	7716400.0	9334300.0	0.0	0.0
+ANP32B	562810000.0	573060000.0	588350000.0	461320000.0
+ANP32A	624360000.0	565370000.0	806750000.0	758330000.0
+FDXR	42381000.0	61825000.0	44386000.0	42522000.0
+TYK2	3559800.0	0.0	5734900.0	4897500.0
+TAT	83209000.0	85139000.0	27537000.0	30543000.0
+SUPT5H	6593900.0	0.0	9198100.0	9927000.0
+NAPG	49828000.0	86448000.0	90989000.0	94570000.0
+NAPA	2474500000.0	2299100000.0	2695400000.0	2939900000.0
+THY1	58617000.0	71541000.0	103160000.0	112830000.0
+MRPL58	136080000.0	173210000.0	91316000.0	94382000.0
+CDC42BPA	0.0	0.0	0.0	0.0
+LARP1	9911400.0	4562500.0	5089400.0	0.0
+SF3A3	11972000.0	21823000.0	15991000.0	10811000.0
+SCCPDH	347860000.0	359370000.0	155270000.0	173930000.0
+FXR1	0.0	0.0	0.0	0.0
+FXR2	566330.0	0.0	0.0	0.0
+AGXT2	2033600000.0	2164700000.0	1992200000.0	1943400000.0
+TNS1	51592000.0	49311000.0	44125000.0	35372000.0
+CNDP2	879220000.0	773960000.0	834790000.0	926310000.0
+ISOC2	5804500000.0	5445500000.0	4634200000.0	5754100000.0
+NPL	92108000.0	106490000.0	168470000.0	151080000.0
+D2HGDH	29669000.0	21354000.0	25421000.0	28003000.0
+PTER	38595000.0	35761000.0	43510000.0	43702000.0
+MITD1	64099000.0	69749000.0	84130000.0	63031000.0
+LDAH	472750000.0	464300000.0	666910000.0	711230000.0
+GADD45GIP1	93871000.0	83479000.0	70578000.0	79378000.0
+ANGPTL2	45317000.0	110000000.0	0.0	18200000.0
+ENSBTAG00000045947	105390000.0	105790000.0	63896000.0	70149000.0
+ACE2	2099800.0	0.0	1754200.0	1588500.0
+ENSBTAG00000038755	3936800.0	0.0	482040.0	0.0
+TSN	43318000.0	37383000.0	76082000.0	59054000.0
+PBDC1	61749000.0	33676000.0	95979000.0	118530000.0
+ELAVL1	1186000000.0	1358600000.0	1059000000.0	1075100000.0
+ELAVL2	19138000.0	0.0	0.0	0.0
+EXOC4	2023800.0	13398000.0	4638700.0	0.0
+PDS5A	1400100.0	0.0	0.0	0.0
+PDS5B	3002000.0	0.0	5250600.0	4941100.0
+MYO18A	52755000.0	3316000.0	4502300.0	5529400.0
+GPLD1	53482000.0	58724000.0	37160000.0	41510000.0
+TST	83417000000.0	92519000000.0	82189000000.0	85271000000.0
+MTSS1	33478000.0	27590000.0	28621000.0	19223000.0
+HSCB	83669000.0	70868000.0	80276000.0	89499000.0
+CHCHD3	3555200000.0	3746800000.0	3415800000.0	3009900000.0
+RPL7A	7649000000.0	8908800000.0	4133100000.0	3626300000.0
+ENSBTAG00000013919	219170000.0	255700000.0	500010000.0	343930000.0
+FARSA	136430000.0	154570000.0	149110000.0	191440000.0
+FAM151B	47369000.0	78331000.0	40283000.0	30222000.0
+PAICS	331530000.0	351180000.0	233380000.0	238250000.0
+OVCA2	160330000.0	194060000.0	193740000.0	237200000.0
+KYAT3	101060000.0	93288000.0	71930000.0	64825000.0
+VTA1	80212000.0	38637000.0	64384000.0	74800000.0
+NUDT2	34307000.0	34963000.0	26506000.0	27378000.0
+KIF1BP	1692100.0	0.0	0.0	1991800.0
+DLG1	27402000.0	0.0	18952000.0	16966000.0
+NUDT3	98520000.0	103960000.0	165520000.0	104970000.0
+ENSBTAG00000047973	24365000.0	33321000.0	27937000.0	26154000.0
+ALDH8A1	4643100000.0	4324400000.0	4919600000.0	4288600000.0
+PPP1R18	46250000.0	12306000.0	5631200.0	0.0
+BNIP1	30599000.0	26737000.0	52232000.0	57399000.0
+XIRP2	0.0	0.0	0.0	0.0
+MBL2	122620000.0	247640000.0	200410000.0	160600000.0
+GZMA	16291000.0	16177000.0	15085000.0	12719000.0
+MTHFD1L	26655000.0	0.0	7904800.0	12836000.0
+EMC9	33199000.0	34794000.0	24974000.0	26067000.0
+EMC8	51464000.0	60986000.0	0.0	0.0
+FBXO30	446960.0	0.0	3441900.0	3452300.0
+FLOT1	61710000.0	71473000.0	75339000.0	99006000.0
+FLOT2	50093000.0	47270000.0	37697000.0	42926000.0
+EMC2	211670000.0	252160000.0	236680000.0	196880000.0
+EMC1	18069000.0	12972000.0	78505000.0	79944000.0
+CNRIP1	124140000.0	147730000.0	151410000.0	136310000.0
+EMC7	216120000.0	236940000.0	209180000.0	182810000.0
+MYH10	162230000.0	90808000.0	187030000.0	152330000.0
+MYH11	229420000.0	7773100.0	41284000.0	50474000.0
+MYH14	668250000.0	473960000.0	302160000.0	292090000.0
+GNS	223800000.0	245030000.0	237340000.0	183390000.0
+AP3M2	76186000.0	73059000.0	90849000.0	83538000.0
+SMG8	352830000.0	620930000.0	629200000.0	519790000.0
+HTRA2	367850000.0	347110000.0	415940000.0	387400000.0
+RTRAF	238520000.0	245700000.0	271460000.0	296140000.0
+PIK3AP1	29274000.0	20729000.0	35952000.0	35059000.0
+HINT3	215780000.0	246900000.0	243860000.0	232490000.0
+HMBS	30448000.0	36603000.0	19161000.0	11053000.0
+SMC3	25150000.0	0.0	9207400.0	6436900.0
+SMC2	8596200.0	0.0	3625900.0	3440300.0
+CDC37	70338000.0	120510000.0	112560000.0	106510000.0
+ALAS1	25913000.0	10762000.0	21266000.0	27961000.0
+ENSBTAG00000009788	386416000.0	352430000.0	341101000.0	309659600.0
+NMT1	15797000.0	16725000.0	13496000.0	14111000.0
+KIAA0513	0.0	0.0	0.0	0.0
+CPOX	11336000000.0	11394000000.0	8707500000.0	9394100000.0
+GRIPAP1	24820000.0	0.0	72981000.0	47968000.0
+TNKS1BP1	39419000.0	0.0	29646000.0	28123000.0
+LTF	42915000.0	0.0	114580000.0	116590000.0
+HIBCH	4241700000.0	4132700000.0	4709600000.0	5251600000.0
+LASP1	1335544000.0	1273349200.0	1449800000.0	1446300000.0
+AFDN	41584000.0	16285000.0	34720000.0	28935000.0
+PGLS	1833100000.0	1747500000.0	1958100000.0	1597800000.0
+C8B	30897000.0	30673000.0	32070000.0	39114000.0
+PPP5C	40807000.0	54437000.0	46279000.0	46954000.0
+LMOD1	2222000.0	0.0	1729100.0	0.0
+GLS2	141190000.0	160970000.0	106750000.0	130330000.0
+MAP7	20235000.0	33258000.0	40724000.0	48240000.0
+RBM4	38117000.0	53283000.0	33343000.0	29917000.0
+GALK2	78803000.0	70339000.0	79531000.0	94072000.0
+RPL23A	237880000.0	240200000.0	87890000.0	68838000.0
+SPCS3	448690000.0	429640000.0	389390000.0	385990000.0
+ARL8B	223200000.0	240640000.0	72128000.0	86819000.0
+EGFR	24920000.0	0.0	5029300.0	7906400.0
+CAT	1.6038e+11	1.6105e+11	2.0388e+11	2.1283e+11
+ACADM	13801000000.0	13652000000.0	7419900000.0	8075200000.0
+WDR82	234795000.0	243163000.0	277772000.0	228740000.0
+ENSBTAG00000011511	85385000.0	117110000.0	118970000.0	90806000.0
+CAD	3402500.0	0.0	2550100.0	2382100.0
+NUBP2	180660000.0	148320000.0	194510000.0	187300000.0
+PGD	495050000.0	457100000.0	523150000.0	554190000.0
+DYSF	4419600.0	0.0	18537000.0	9096200.0
+VPS25	85790000.0	101610000.0	75405000.0	72503000.0
+DYNC1I1	0.0	0.0	0.0	0.0
+C29H11orf54	4003600000.0	4877300000.0	4697800000.0	4497900000.0
+VPS28	135570000.0	105570000.0	111350000.0	95796000.0
+VPS29	325920000.0	249880000.0	191740000.0	191370000.0
+NUDC	86640000.0	74091000.0	76593000.0	67288000.0
+ESYT1	18123000.0	0.0	32907000.0	41289000.0
+TOP1	10436000.0	0.0	2039800.0	2531900.0
+PGP	586810000.0	690450000.0	596490000.0	524140000.0
+ENSBTAG00000047700	1403100000.0	1066900000.0	1424100000.0	1326700000.0
+PTPN23	5620900.0	0.0	4329200.0	3843600.0
+COA7	129100000.0	205990000.0	133650000.0	110920000.0
+TMEM214	4794400.0	6609600.0	2969300.0	4280700.0
+LGALS3BP	107060000.0	109560000.0	116480000.0	114840000.0
+SEPSECS	61554000.0	55800000.0	56364000.0	74506000.0
+PLEKHO2	0.0	25159000.0	0.0	0.0
+PDE12	17861000.0	14436000.0	24687000.0	24332000.0
+EXOC2	2331100.0	0.0	0.0	1853600.0
+ARSB	2706300.0	3346600.0	4055100.0	2919000.0
+CA3	38243000000.0	37004000000.0	46031000000.0	50774000000.0
+CA2	3205000000.0	2902700000.0	5933500000.0	5051400000.0
+EXOC8	3578300.0	0.0	3851000.0	0.0
+HEXB	103290000.0	109690000.0	142870000.0	142930000.0
+RBMX	302330000.0	355300000.0	238690000.0	266880000.0
+ACBD3	9610500.0	0.0	6283000.0	6515500.0
+ANK3	162600000.0	7528600.0	62632000.0	63091000.0
+ACBD5	148270000.0	148500000.0	140500000.0	130460000.0
+ACBD4	3843900.0	2497500.0	3147900.0	2644600.0
+MON2	5290600.0	0.0	0.0	0.0
+BZW1	57658000.0	56809000.0	34106000.0	35548000.0
+EEF2	2931200000.0	1920200000.0	1498400000.0	1299300000.0
+BZW2	13909000.0	13759000.0	6033700.0	6981800.0
+PDGFRB	0.0	0.0	3116000.0	3568600.0
+GSTA4	709120000.0	697980000.0	622170000.0	830090000.0
+GSTA5	12943000000.0	13936000000.0	16929000000.0	23978000000.0
+EVA1B	51585000.0	50796000.0	81191000.0	81173000.0
+UFC1	544900000.0	611290000.0	577060000.0	645150000.0
+GSTA2	38311000000.0	43348000000.0	57110000000.0	53731000000.0
+GSTA3	2.1924e+11	2.4298e+11	3.1553e+11	3.1526e+11
+CTSB	2541800000.0	2366000000.0	1616300000.0	1702500000.0
+CBR3	10356000000.0	9958100000.0	9579600000.0	9426600000.0
+ENSBTAG00000012096	2217400000.0	1885900000.0	1857600000.0	1927000000.0
+PYCR3	1546300000.0	1789700000.0	1898500000.0	1805100000.0
+PYCR2	149850000.0	182610000.0	78988000.0	148580000.0
+FAM234A	2756200.0	0.0	5206400.0	0.0
+RSU1	450940000.0	572230000.0	609850000.0	573940000.0
+DDX39B	298980000.0	292000000.0	293450000.0	283450000.0
+DDX39A	5907700.0	0.0	4796700.0	5202600.0
+ADAMTS9	2626300.0	0.0	0.0	0.0
+STRAP	193600000.0	236300000.0	168070000.0	222360000.0
+CBFB	52134000.0	54014000.0	78914000.0	66049000.0
+ENSBTAG00000014567	294970000.0	239570000.0	300230000.0	352560000.0
+DMAC2	85419000.0	63575000.0	64880000.0	77769000.0
+EEFSEC	55534000.0	87310000.0	0.0	62581000.0
+CDH2	46358000.0	18627000.0	69219000.0	79557000.0
+BOLA-DRA	58384000.0	82213000.0	122320000.0	108350000.0
+ENSBTAG00000022715	2687300.0	0.0	0.0	0.0
+LIPA	50770000.0	48269000.0	37941000.0	50055000.0
+EIF2B5	24215000.0	1338500.0	9175800.0	8104200.0
+RAB5A	312690000.0	259990000.0	319220000.0	364050000.0
+RAB5C	1660000000.0	1430400000.0	1633200000.0	1677100000.0
+RAB5B	403350000.0	354430000.0	544380000.0	508580000.0
+SEC24D	128220000.0	0.0	52058000.0	51576000.0
+ENSBTAG00000019516	13134000000.0	11632000000.0	14799000000.0	16692000000.0
+PEX11B	272220000.0	267720000.0	339030000.0	274530000.0
+SEC24A	71015000.0	18151000.0	48095000.0	79276000.0
+SSH3	2483800.0	0.0	0.0	0.0
+SEC24C	181350000.0	13546000.0	72687000.0	66382000.0
+SEC24B	22112000.0	0.0	45096000.0	34487000.0
+PAFAH1B3	144860000.0	83680000.0	111300000.0	137220000.0
+PAFAH1B2	86750000.0	89999000.0	96167000.0	101770000.0
+HOGA1	7100700000.0	6155300000.0	6957500000.0	8384900000.0
+PDXDC1	26882000.0	9763900.0	19787000.0	29095000.0
+MIF4GD	77140000.0	46076000.0	72345000.0	107100000.0
+SCARB1	9266400.0	9190300.0	0.0	0.0
+AZU1	247400000.0	219380000.0	1052000000.0	1132300000.0
+PLEKHA4	1928600.0	0.0	0.0	0.0
+PLEKHA6	12805000.0	14291000.0	14130000.0	0.0
+PLEKHA7	1987200.0	0.0	9393600.0	8458600.0
+MRPL47	68460000.0	75243000.0	36930000.0	31232000.0
+MRPL46	94184000.0	102650000.0	91550000.0	82342000.0
+ALAD	33235000000.0	34914000000.0	32079000000.0	36304000000.0
+MRPL44	122210000.0	156430000.0	89494000.0	103010000.0
+ACTB	17736000.0	25743000.0	16310000.0	0.0
+DGKQ	1090600.0	0.0	7425600.0	7571500.0
+PPA2	4050400000.0	3908000000.0	5469600000.0	5055900000.0
+STARD10	1800200000.0	1526800000.0	2040500000.0	1703800000.0
+CPT1A	32894000.0	47487000.0	8313800.0	15266000.0
+ERAP1	16281500.0	0.0	10619300.0	11372800.0
+ENSBTAG00000023939	2566200000.0	2673600000.0	1773300000.0	2133900000.0
+NMRK1	52266000.0	0.0	0.0	64103000.0
+RRAS	228850000.0	226530000.0	228110000.0	214840000.0
+ARFGAP2	12324000.0	16617000.0	18504000.0	19259000.0
+ARFGAP3	685370000.0	756040000.0	542920000.0	579520000.0
+LAMB1	9697100.0	12890000.0	9470700.0	0.0
+DHX36	2696300.0	0.0	0.0	14887000.0
+COPZ1	588390000.0	482700000.0	315150000.0	401950000.0
+NEK7	81473000.0	68748000.0	115720000.0	65171000.0
+DDX58	6671000.0	5974900.0	15110000.0	17887000.0
+COPZ2	707750000.0	748880000.0	501720000.0	617060000.0
+RUVBL1	117020000.0	110350000.0	115430000.0	122700000.0
+RUVBL2	14817000.0	13085000.0	12566000.0	16152000.0
+U2AF1	45344000.0	60756000.0	25495000.0	25709000.0
+PLA2G12B	136610000.0	170650000.0	203050000.0	186320000.0
+ADAR	10871000.0	0.0	10159000.0	10194000.0
+NEK9	21046000.0	0.0	18473000.0	15532000.0
+GATM	7805700000.0	7892800000.0	8093700000.0	8469000000.0
+ADAL	32325000.0	0.0	30523000.0	24772000.0
+SF3A1	122070000.0	29598000.0	79787000.0	97968000.0
+CDC42BPB	1249300.0	0.0	0.0	0.0
+FAM129B	2901300.0	0.0	6655100.0	3952700.0
+TXNRD1	114110000.0	138550000.0	134210000.0	165230000.0
+CAPG	62536000.0	64629000.0	77192000.0	58357000.0
+ENSBTAG00000045566	0.0	0.0	0.0	0.0
+TPT1	627510000.0	567620000.0	788890000.0	642440000.0
+BUB3	222660000.0	147350000.0	130970000.0	137130000.0
+ALYREF	693790000.0	606400000.0	677590000.0	667880000.0
+PEX16	106300000.0	76329000.0	82310000.0	84735000.0
+ABCF2	3403100.0	0.0	0.0	0.0
+BLVRB	6931700000.0	6964900000.0	10194000000.0	11632000000.0
+ADSSL1	30329000.0	22639000.0	43563000.0	36805000.0
+GLTPD2	79006000.0	66847000.0	38275000.0	46452000.0
+EGLN1	309270000.0	529290000.0	283660000.0	262130000.0
+OGT	19323000.0	0.0	10103000.0	0.0
+MTHFD1	11596000000.0	4501100000.0	6251700000.0	6220600000.0
+YBX1	135600000.0	207300000.0	204320000.0	168400000.0
+IK	1543700.0	0.0	0.0	0.0
+C13H20orf194	7396300.0	0.0	97805000.0	271210000.0
+ANXA1	4579000000.0	5169100000.0	7308500000.0	7974700000.0
+NSD1	0.0	0.0	0.0	620410.0
+METAP2	10718000.0	12859000.0	8494600.0	8970200.0
+ATP6V1D	134220000.0	131310000.0	138780000.0	151610000.0
+CCDC47	23335000.0	26694000.0	24014000.0	26111000.0
+TCERG1	10251000.0	0.0	5204600.0	3527900.0
+RNPEP	31859000.0	29488000.0	43701000.0	34715000.0
+HSD17B11	17377000000.0	17068000000.0	25299000000.0	25530000000.0
+TPM1	299860000.0	256020000.0	367770000.0	613850000.0
+ADSL	263140000.0	271300000.0	262270000.0	318900000.0
+ENSBTAG00000005146	22442000.0	22511000.0	15543000.0	0.0
+AS3MT	271990000.0	280180000.0	405770000.0	399760000.0
+MYH3	0.0	0.0	6009200.0	0.0
+COASY	150380000.0	165660000.0	165410000.0	177020000.0
+MYH9	1772000000.0	1077400000.0	832330000.0	947130000.0
+USF3	9132100.0	0.0	35814000.0	38437000.0
+NAE1	5794800.0	7390000.0	8693200.0	11052000.0
+RANBP1	343700000.0	330080000.0	254660000.0	325180000.0
+RANBP3	12670000.0	16124000.0	0.0	0.0
+CADM1	28020000.0	0.0	8779900.0	7802300.0
+GNB4	99642000.0	45080000.0	82338000.0	84992000.0
+SIPA1	97852000.0	98736000.0	160710000.0	176630000.0
+GNB1	1342400000.0	1233100000.0	1389900000.0	1387400000.0
+GNB2	1679000000.0	1657900000.0	1639100000.0	1831100000.0
+NUDT12	51318000.0	56029000.0	64071000.0	95023000.0
+GCN1	39797000.0	0.0	5424300.0	6099500.0
+NUDT16	162890000.0	131250000.0	114470000.0	116820000.0
+NUDT14	594020000.0	595070000.0	739850000.0	1036700000.0
+ZW10	9845300.0	2967500.0	11651000.0	9866100.0
+NUDT19	24868000.0	28780000.0	28047000.0	24514000.0
+BREH1	283230000.0	225000000.0	174730000.0	206590000.0
+STX8	38721000.0	37912000.0	50684000.0	36790000.0
+RTCB	123380000.0	138010000.0	102720000.0	98178000.0
+SDS	46777000.0	53276000.0	73606000.0	75933000.0
+STX5	71603000.0	59136000.0	66599000.0	96818000.0
+STX4	89167000.0	134210000.0	201510000.0	173740000.0
+STX7	124930000.0	114390000.0	200370000.0	133560000.0
+GDPD1	16522000.0	16502000.0	51349000.0	36970000.0
+RPS3A	13813000000.0	14613000000.0	8544700000.0	7706500000.0
+RANBP2	39593000.0	3067100.0	13984000.0	12454000.0
+POLR1E	0.0	0.0	0.0	0.0
+PON1	4949100000.0	4240700000.0	10127000000.0	9879600000.0
+ECE1	6871100.0	0.0	0.0	0.0
+ENSBTAG00000046839	407830000.0	409380000.0	408110000.0	453520000.0
+IQGAP1	24154000.0	0.0	34302000.0	40179000.0
+IQGAP2	873920000.0	551000000.0	463040000.0	491300000.0
+YWHAZ	3234100000.0	3695200000.0	3090600000.0	2909000000.0
+DRG2	35680000.0	44124000.0	31161000.0	26767000.0
+DRG1	22748000.0	24259000.0	12560000.0	15912000.0
+XXYLT1	64440000.0	81354000.0	71679000.0	91124000.0
+NOP58	11176000.0	4710800.0	2239900.0	2060300.0
+PITHD1	359960000.0	418260000.0	431230000.0	405450000.0
+YWHAQ	1400500000.0	1215100000.0	1269800000.0	1293800000.0
+NOP56	76954000.0	27374000.0	31913000.0	30629000.0
+IL18	30462000.0	18741000.0	27154000.0	32994000.0
+YWHAH	1149800000.0	1225100000.0	769800000.0	894100000.0
+RPE	323040000.0	198320000.0	535720000.0	407210000.0
+YWHAB	5727400000.0	5511600000.0	5893600000.0	5329900000.0
+AP1B1	169130000.0	182490000.0	108680000.0	91104000.0
+YWHAG	7743700000.0	9202000000.0	6286500000.0	7009500000.0
+YWHAE	6775900000.0	6647100000.0	4726000000.0	5840300000.0
+CARD19	353580000.0	404430000.0	448720000.0	377840000.0
+MAT2A	558590000.0	595560000.0	427420000.0	443560000.0
+ATAD3A	136330000.0	133260000.0	130950000.0	138110000.0
+MAT2B	705870000.0	730610000.0	671760000.0	808180000.0
+ENSBTAG00000045888	346750000.0	354100000.0	373550000.0	321430000.0
+C1S	64847000.0	12858000.0	14731000.0	16395000.0
+C1R	69160000.0	18341000.0	28192000.0	31003000.0
+TUBA4A	785840000.0	656190000.0	797400000.0	710660000.0
+CALD1	1082700000.0	1308800000.0	1468400000.0	1762800000.0
+TBKBP1	1509200.0	0.0	0.0	0.0
+PANK4	3948900.0	0.0	0.0	0.0
+COQ6	59849000.0	50569000.0	56437000.0	62308000.0
+NUDT13	131080000.0	116190000.0	124630000.0	83189000.0
+ENSBTAG00000037775	592840000.0	528960000.0	522800000.0	448610000.0
+ABI1	187770000.0	184470000.0	180110000.0	161880000.0
+ROCK1	10470000.0	0.0	0.0	7899700.0
+ROCK2	2215400.0	0.0	0.0	0.0
+CUL4A	36752000.0	17740000.0	41355000.0	26649000.0
+CYP2C19	497210000.0	580150000.0	1892900000.0	1790100000.0
+ILF3	42156000.0	0.0	7112000.0	5134900.0
+TGFBI	88139000.0	81617000.0	98123000.0	90576000.0
+ENSBTAG00000036298	256420000.0	264220000.0	402030000.0	284840000.0
+ILF2	70511000.0	63837000.0	50811000.0	45532000.0
+IMMT	927790000.0	228460000.0	455220000.0	405310000.0
+ACADVL	8322400000.0	8860600000.0	5366600000.0	5353600000.0
+NDUFB9	1235100000.0	1096700000.0	1154000000.0	1026800000.0
+RAB4A	181780000.0	184510000.0	241500000.0	219160000.0
+PCCB	3828300000.0	3636100000.0	3739800000.0	3718300000.0
+PCCA	5796600000.0	6197300000.0	3987000000.0	4292100000.0
+FCHO2	0.0	6572500.0	14968000.0	14542000.0
+URAD	255210000.0	439250000.0	225060000.0	266510000.0
+FAM213B	386020000.0	313920000.0	298990000.0	269150000.0
+PECAM1	0.0	0.0	0.0	4601500.0
+SUGT1	428080000.0	506410000.0	723290000.0	606380000.0
+TPD52	180300000.0	237530000.0	215690000.0	201420000.0
+UHRF1	1666200.0	0.0	0.0	0.0
+ENSBTAG00000045976	98042000.0	79451000.0	59155000.0	72863000.0
+CLN5	22306000.0	20719000.0	18241000.0	21148000.0
+ZC3HAV1	189970000.0	228910000.0	239090000.0	183390000.0
+CLINT1	150520000.0	184360000.0	98048000.0	166920000.0
+ANKRD44	1765800.0	0.0	1735600.0	1690500.0
+ANKRD46	23663000.0	25008000.0	19104000.0	0.0
+CXADR	13022000.0	6060600.0	31805000.0	0.0
+CRYL1	2396600000.0	2147500000.0	3126600000.0	2966000000.0
+WNK1	2530600.0	0.0	0.0	0.0
+ACSM2B	6259700000.0	5592200000.0	5505100000.0	5814100000.0
+ACOT8	1135500000.0	1315000000.0	1544400000.0	1611800000.0
+ACOT4	103590000.0	61606000.0	36650000.0	36937000.0
+ACOT2	26532000.0	22850000.0	20575000.0	14209000.0
+SHMT2	1321400000.0	1297400000.0	1109700000.0	1058800000.0
+SHMT1	17289000000.0	18519000000.0	18169000000.0	17758000000.0
+ENSBTAG00000026758	12335000000.0	12942000000.0	11463000000.0	10971000000.0
+TOR1AIP1	24495000.0	28768000.0	33809000.0	44241000.0
+PLD2	0.0	0.0	0.0	175260000.0
+PLD3	7580800.0	7581400.0	7355200.0	8852000.0
+LIMA1	37050000.0	50951000.0	54039000.0	72864000.0
+KIF27	6570000.0	0.0	3391900.0	3677200.0
+PPFIBP2	1289100.0	2278800.0	0.0	0.0
+ETNPPL	84978000.0	77498000.0	103510000.0	105490000.0
+PNPO	1725300000.0	1952000000.0	2186800000.0	2205000000.0
+ZBTB20	3068400.0	0.0	0.0	5106800.0
+SRSF3	554290000.0	574500000.0	937140000.0	757390000.0
+STX2	45526000.0	60440000.0	83757000.0	80654000.0
+DDI2	383010000.0	459100000.0	212490000.0	201080000.0
+IRGQ	5032400.0	0.0	0.0	4849000.0
+HRAS	15169000.0	26928000.0	21251000.0	22042000.0
+CC2D1A	10218000.0	0.0	3717500.0	0.0
+SEPT8	27216000.0	19427000.0	30765000.0	33351000.0
+SEPT7	501890000.0	589180000.0	562650000.0	543480000.0
+SEPT6	34101000.0	26813000.0	40200000.0	32064000.0
+PITPNA	131310000.0	80383000.0	65588000.0	49210000.0
+SEPT2	345250000.0	525260000.0	478470000.0	420110000.0
+HSPH1	16783000.0	2844000.0	22130000.0	26716000.0
+MFF	53244000.0	54983000.0	79051000.0	60458000.0
+ENSBTAG00000006819	9962400.0	0.0	19760000.0	15460000.0
+GK5	82056000.0	76538000.0	101350000.0	110070000.0
+MFN1	497220.0	0.0	4105800.0	4202200.0
+NARS	330330000.0	298460000.0	289420000.0	350250000.0
+JUP	133570000.0	79926000.0	88505000.0	123300000.0
+YARS	373690000.0	368340000.0	343620000.0	324900000.0
+RBM39	1515200.0	0.0	7448200.0	6772100.0
+AGPS	4178900.0	21599000.0	19859000.0	18484000.0
+FAM98B	24826000.0	21573000.0	17895000.0	38848000.0
+TFR2	126280000.0	3731500.0	43219000.0	32150000.0
+PARP9	1094100.0	0.0	0.0	0.0
+ENSBTAG00000039643	16599000.0	37180000.0	0.0	0.0
+SEC13	1278700000.0	1335000000.0	1646000000.0	1634400000.0
+EPN1	1021600.0	0.0	0.0	0.0
+PARP1	29526000.0	30078000.0	39371000.0	40924000.0
+EPN3	11776000.0	0.0	44819000.0	62844000.0
+DDT	72443000.0	15724000.0	158000000.0	195050000.0
+MPP1	79367000.0	62097000.0	81639000.0	81916000.0
+GIMAP8	569570000.0	711840000.0	447260000.0	568070000.0
+GIMAP4	6520446000.0	7922436000.0	13524172000.0	14720990000.0
+GIMAP5	19548000.0	26506000.0	31299000.0	34710000.0
+GIMAP7	612990000.0	738750000.0	1109960000.0	1121780000.0
+GPHN	87636000.0	27092000.0	54533000.0	50303000.0
+LMNB2	371870000.0	414900000.0	252760000.0	289670000.0
+ENSBTAG00000010033	47201000.0	48244000.0	76667000.0	83343000.0
+ALDH4A1	6445900000.0	6948600000.0	7366100000.0	7514900000.0
+GSTT2	27221000000.0	27605000000.0	31963000000.0	33600000000.0
+TOLLIP	622970000.0	523460000.0	803230000.0	905730000.0
+MRPS26	91296000.0	110220000.0	104630000.0	109180000.0
+WARS	179490000.0	157360000.0	236000000.0	280770000.0
+MRPS25	91066000.0	78235000.0	67418000.0	74638000.0
+MRPS22	200830000.0	172840000.0	188640000.0	206580000.0
+MRPS23	262860000.0	243840000.0	190430000.0	193840000.0
+LAMTOR1	36993000.0	37027000.0	34751000.0	0.0
+LCMT1	82577000.0	76579000.0	95408000.0	111650000.0
+RASIP1	80363000.0	34553000.0	18803000.0	28381000.0
+EARS2	11696000.0	11436000.0	12182000.0	16286000.0
+ACTC1	372860000.0	368380000.0	179340000.0	256850000.0
+NAMPT	94309000.0	112770000.0	105540000.0	93040000.0
+ENSBTAG00000016032	446200000.0	369200000.0	332440000.0	299340000.0
+CTNND1	228550000.0	84502000.0	136920000.0	136970000.0
+GAREM1	38963000.0	0.0	5444900.0	5739700.0
+SH3GL1	20737000.0	18150000.0	31160000.0	21925000.0
+A2M	1054300000.0	1104000000.0	1471000000.0	1591700000.0
+OPTN	4585900.0	5984600.0	0.0	0.0
+BHMT	22120000000.0	20705000000.0	10381000000.0	10097000000.0
+THOP1	872630000.0	1109900000.0	659920000.0	657780000.0
+GOLGA2	6445000.0	0.0	2439900.0	0.0
+TTC24	0.0	0.0	0.0	140660000.0
+FTL	2607400000.0	2738200000.0	1826100000.0	2077500000.0
+VARS2	2585000.0	0.0	4548200.0	4510200.0
+FHL1	34958000.0	32920000.0	34106000.0	42464000.0
+DCXR	23207411000.0	21575405000.0	20072545000.0	20438960000.0
+FTH1	326120000.0	429230000.0	225920000.0	170550000.0
+UGGT2	0.0	0.0	0.0	0.0
+UGGT1	24549000.0	24915000.0	23915000.0	31228000.0
+RPS25	115990000.0	55709000.0	111490000.0	83904000.0
+APPL2	23145000.0	42928000.0	37342000.0	26820000.0
+ALDH7A1	1527800000.0	1555300000.0	1480800000.0	1455800000.0
+TOMM70	247440000.0	259600000.0	207700000.0	204840000.0
+MEMO1	312480000.0	308550000.0	351630000.0	359970000.0
+NT5DC1	15482000.0	11019000.0	13634000.0	9957900.0
+PPIF	3575400000.0	3694500000.0	2904800000.0	2797800000.0
+PPIE	324850000.0	411170000.0	270800000.0	253580000.0
+PPID	8480900.0	9943000.0	5043500.0	0.0
+SIGMAR1	92364000.0	121460000.0	213710000.0	160460000.0
+PPIA	1076400000.0	1097900000.0	983090000.0	1002600000.0
+SARS2	146510000.0	172940000.0	159610000.0	148820000.0
+SIRT3	1612100000.0	1720500000.0	1822700000.0	1646900000.0
+CYFIP1	83240000.0	8625300.0	15945000.0	17307000.0
+SNTB1	207830000.0	210450000.0	192310000.0	232880000.0
+HYI	522160000.0	562130000.0	767220000.0	714750000.0
+AIMP2	1236000000.0	1216600000.0	1073800000.0	1111200000.0
+KIAA0408	9072500.0	0.0	8682100.0	10002000.0
+AIMP1	84807000.0	103640000.0	53911000.0	69457000.0
+CORO1B	792030000.0	812400000.0	857800000.0	951080000.0
+CORO1C	546000000.0	563920000.0	671770000.0	639960000.0
+CORO1A	175350000.0	215620000.0	232520000.0	298110000.0
+ZBTB8OS	47651000.0	58223000.0	73723000.0	52760000.0
+MDH2	72975000000.0	76495000000.0	57739000000.0	51023000000.0
+MDH1	9057000000.0	9091700000.0	9152100000.0	9559200000.0
+MOXD1	4323500.0	0.0	0.0	0.0
+DDX3X	149900000.0	146870000.0	120840000.0	114870000.0
+TTPAL	30723000.0	34623000.0	19484000.0	22327000.0
+DCPS	9541100.0	18373000.0	6728900.0	9067600.0
+THUMPD3	10215000.0	9120700.0	9818300.0	10724000.0
+KYNU	146160000.0	170370000.0	177880000.0	206970000.0
+LHPP	1966000000.0	1888700000.0	1950700000.0	1944600000.0
+UVRAG	0.0	0.0	10180000.0	0.0
+SMARCA5	4099400.0	0.0	1812700.0	1688600.0
+FAH	4024200000.0	4203100000.0	2853600000.0	2842500000.0
+COPG2	1687800.0	0.0	0.0	4863700.0
+HNRNPA2B1	16098000000.0	16049000000.0	12679000000.0	14442000000.0
+COPG1	880400000.0	79820000.0	631490000.0	490520000.0
+CYP4A22	0.0	0.0	0.0	0.0
+NBAS	2055200.0	0.0	0.0	0.0
+PDZK1	361699000.0	398792000.0	216866000.0	207549000.0
+RENBP	33928000.0	33811000.0	30852000.0	34911000.0
+ENSBTAG00000001851	195620000.0	193290000.0	273230000.0	242800000.0
+SORT1	5271000.0	0.0	3576600.0	4655400.0
+GTPBP1	5051500.0	0.0	11203000.0	11029000.0
+NIF3L1	61108000.0	75349000.0	112840000.0	56148000.0
+GTPBP3	6836500.0	6714800.0	7100000.0	5884000.0
+GTPBP2	49330000.0	46109000.0	41825000.0	34104000.0
+HELLS	1716800.0	4645500.0	4976700.0	0.0
+CASP6	733920000.0	773920000.0	1093400000.0	1063300000.0
+UPP2	2415172000.0	2184720000.0	2086728000.0	2110034000.0
+SNRNP40	44366000.0	64544000.0	39208000.0	50883000.0
+BPNT1	146870000.0	141160000.0	219050000.0	267980000.0
+SHTN1	11868000.0	10959000.0	12066000.0	11188000.0
+ENSBTAG00000031738	4955700000.0	4662400000.0	4982600000.0	5856200000.0
+CASP8	12698000.0	12299000.0	13057000.0	15284000.0
+PURB	122270000.0	166300000.0	146000000.0	135950000.0
+PURA	131120000.0	113530000.0	125800000.0	133910000.0
+CFDP2	295360000.0	285400000.0	218890000.0	157310000.0
+EIF4A2	402540000.0	464500000.0	268960000.0	291670000.0
+PICALM	266490000.0	381600000.0	283080000.0	269320000.0
+HECTD3	8597200.0	0.0	14832000.0	19956000.0
+HECTD1	4589200.0	0.0	7373000.0	0.0
+ADPRHL2	270990000.0	293080000.0	287090000.0	314870000.0
+MAN2B1	3659400000.0	3957900000.0	4246200000.0	4066400000.0
+DARS	271920000.0	271780000.0	287600000.0	295260000.0
+LYPLA1	3915200000.0	3599900000.0	3753400000.0	3721800000.0
+NPEPL1	16461000.0	25302000.0	23582000.0	35160000.0
+CLMN	1200800.0	0.0	0.0	0.0
+CCS	96978000.0	111940000.0	111010000.0	104750000.0
+GLRX3	684860000.0	818690000.0	762600000.0	850230000.0
+AKT2	0.0	0.0	21789000.0	12819000.0
+LRFN4	20893000.0	19244000.0	51829000.0	104400000.0
+UPB1	2235500000.0	2118100000.0	1905500000.0	1644800000.0
+MRC1	3851800.0	0.0	0.0	0.0
+AHCYL2	93784000.0	100360000.0	45671000.0	73248000.0
+STUB1	357570000.0	354430000.0	333720000.0	332870000.0
+GRK2	105630000.0	110540000.0	118340000.0	181440000.0
+OTC	51295000000.0	53739000000.0	60054000000.0	61494000000.0
+CAPN5	9980800.0	0.0	5926700.0	5973000.0
+FLII	9828400.0	7593200.0	6604900.0	10570000.0
+CAPN2	176250000.0	4055200.0	23929000.0	33769000.0
+CAPN1	76448000.0	22145000.0	84894000.0	73600000.0
+PIR	47049000.0	37347000.0	66380000.0	45415000.0
+SEPT11	62722000.0	32852000.0	60561000.0	65773000.0
+SEPT10	37968000.0	37904000.0	39614000.0	38917000.0
+ENTPD5	652680000.0	585850000.0	558120000.0	521520000.0
+SPAG9	6473900.0	0.0	0.0	0.0
+COG3	1191200.0	0.0	4382000.0	4733000.0
+SMS	132670000.0	159860000.0	209480000.0	224030000.0
+P4HB	21324000000.0	21186000000.0	16337000000.0	17604000000.0
+CHTOP	166280000.0	212130000.0	127540000.0	135390000.0
+COG7	2448800.0	0.0	2248800.0	2198100.0
+SARAF	615090000.0	584540000.0	705440000.0	620540000.0
+ENTPD8	17127000.0	14952000.0	12837000.0	6618900.0
+OSTF1	444720000.0	323200000.0	438780000.0	440380000.0
+SERPINB1	209490000.0	158450000.0	692010000.0	707990000.0
+SERPINB2	3356000.0	0.0	0.0	0.0
+SERPINB4	0.0	0.0	179570000.0	96372000.0
+SERPINB6	1595600000.0	1623200000.0	1283100000.0	1422500000.0
+NFS1	146560000.0	176670000.0	145640000.0	151330000.0
+ENSBTAG00000048257	44965000.0	26241000.0	14271000.0	16695000.0
+UBC	8559600000.0	9490600000.0	9685800000.0	9964400000.0
+ELP2	6900700.0	0.0	0.0	3652200.0
+ELP1	0.0	0.0	7100800.0	7265000.0
+SPC24	41090000.0	71657000.0	19140000.0	0.0
+NRDC	4432300.0	0.0	0.0	0.0
+METAP1	6508700.0	5263200.0	0.0	0.0
+DES	610300000.0	624370000.0	830150000.0	935870000.0
+MSH2	12815000.0	5874800.0	12610000.0	18794000.0
+DCTN2	16588000.0	18958000.0	19313000.0	16854000.0
+AKR1A1	27258000000.0	24310000000.0	36807000000.0	34138000000.0
+SPRYD4	165880000.0	113550000.0	133890000.0	104040000.0
+ST13	184500000.0	153190000.0	281180000.0	337300000.0
+PTGFRN	160840000.0	7553400.0	61950000.0	56245000.0
+PLXNB2	88070000.0	38354000.0	60390000.0	50817000.0
+TRIM56	2132800.0	0.0	1594800.0	0.0
+TCTN3	258630000.0	196890000.0	261910000.0	221710000.0
+DDX6	31389000.0	29804000.0	40816000.0	37737000.0
+ENSBTAG00000022590	201950000.0	188470000.0	251240000.0	299460000.0
+HDDC3	313060000.0	406470000.0	583910000.0	463690000.0
+CMAS	183230000.0	137340000.0	116280000.0	104750000.0
+LANCL1	1017900000.0	1155500000.0	1416000000.0	1394600000.0
+PCBP2	835500000.0	898470000.0	1085300000.0	885340000.0
+PCBP1	4102600000.0	3954200000.0	2917500000.0	2997600000.0
+GBA3	2720000000.0	2928800000.0	3499100000.0	3411500000.0
+NPEPPS	147920000.0	7619700.0	66604000.0	69623000.0
+AMT	392590000.0	401670000.0	235680000.0	280700000.0
+SMC1A	4283000.0	0.0	0.0	0.0
+SIRT2	902880000.0	1037100000.0	929700000.0	837500000.0
+RAB7A	2354300000.0	2444000000.0	2423500000.0	2654300000.0
+NR4A1	0.0	0.0	0.0	0.0
+GNPNAT1	330660000.0	355410000.0	270860000.0	323810000.0
+SIRT5	1348100000.0	1308200000.0	1413600000.0	1401600000.0
+NDUFV2	375970000.0	345210000.0	549670000.0	551030000.0
+SGTA	291230000.0	299840000.0	402800000.0	435080000.0
+TMEM11	117870000.0	121370000.0	135000000.0	102430000.0
+TRIM47	18786000.0	3695400.0	4662400.0	5107300.0
+PLEK	21131000.0	12597000.0	19038000.0	18638000.0
+KIF3A	2949100.0	0.0	0.0	3145500.0
+PEX1	28072000.0	0.0	4991700.0	6960000.0
+HADH	56928000000.0	54954000000.0	38624000000.0	37434000000.0
+PEX5	4546500.0	0.0	5339000.0	9016200.0
+PEX6	14323000.0	0.0	5569500.0	4634400.0
+TKFC	3889200000.0	4322200000.0	5484100000.0	5520400000.0
+NWD2	0.0	0.0	4221900.0	4472400.0
+RBM25	1853500.0	0.0	4594600.0	4698500.0
+PPP2R1A	615130000.0	475210000.0	594520000.0	546420000.0
+ENSBTAG00000012692	119090000.0	150560000.0	198930000.0	153610000.0
+ATP5S	80615000.0	58300000.0	37874000.0	27685000.0
+ENSBTAG00000026812	530750000.0	161870000.0	419390000.0	425720000.0
+STAMBP	53207000.0	57120000.0	84763000.0	51072000.0
+NEB	10814000.0	0.0	13423000.0	287030000.0
+APOOL	528780000.0	481620000.0	490450000.0	417420000.0
+HNRNPH1	705390000.0	760280000.0	636750000.0	652400000.0
+HNRNPH3	116020000.0	170780000.0	151620000.0	128700000.0
+HNRNPH2	91756000.0	121390000.0	68973000.0	43704000.0
+PLRG1	0.0	26059000.0	22865000.0	18683000.0
+GNAI2	2837600000.0	2698800000.0	3478700000.0	3104000000.0
+GNAI3	423940000.0	446010000.0	666540000.0	531530000.0
+GNAI1	36702000.0	25732000.0	52118000.0	45727000.0
+MRPS34	47158000.0	60322000.0	37906000.0	24547000.0
+AFMID	479880000.0	536270000.0	697040000.0	735510000.0
+MRPS30	0.0	0.0	0.0	0.0
+HSPA12B	8022300.0	8874500.0	12752000.0	10881000.0
+STRN3	3389200.0	0.0	0.0	0.0
+ABHD16A	19047000.0	17955000.0	20742000.0	21030000.0
+MTHFR	1841100.0	0.0	15728000.0	14416000.0
+MTHFS	1068800000.0	1210200000.0	1054700000.0	1079800000.0
+PDSS2	13400000.0	13987000.0	5631400.0	6754100.0
+DTNB	0.0	13352000.0	12456000.0	14809000.0
+VCAM1	4752600.0	9958500.0	16303000.0	18328000.0
+PREP	101480000.0	59978000.0	158610000.0	162270000.0
+SYNE1	0.0	0.0	0.0	4429400.0
+SYNE3	9949100.0	12678000.0	16331000.0	20042000.0
+GOPC	24654000.0	24230000.0	219180000.0	33116000.0
+HNRNPUL1	12692000.0	10346000.0	3122100.0	5019500.0
+YTHDC1	4666600.0	0.0	0.0	0.0
+PCMT1	574170000.0	473220000.0	847370000.0	1172600000.0
+BSG	715560000.0	516320000.0	1008200000.0	894830000.0
+CNTLN	83002000.0	0.0	0.0	0.0
+DCHS1	0.0	0.0	550520000.0	0.0
+STOML2	1444300000.0	1811600000.0	1754100000.0	1894500000.0
+PDE4DIP	70217000.0	87860000.0	63303000.0	58188000.0
+ADA	733740000.0	778290000.0	762810000.0	773360000.0
+VPS16	11926000.0	0.0	6078100.0	0.0
+EP400	41899000.0	0.0	33587000.0	32396000.0
+RNH1	374310000.0	385710000.0	283330000.0	307100000.0
+RPS13	53552000.0	52299000.0	38297000.0	54888000.0
+CLPX	51022000.0	53789000.0	52208000.0	35238000.0
+RPS11	2050000000.0	2181500000.0	719190000.0	582020000.0
+RPS10	972550000.0	963850000.0	504090000.0	369130000.0
+RPS17	4413300000.0	5015000000.0	2341900000.0	2503800000.0
+RPS16	51607000.0	43867000.0	38571000.0	29380000.0
+RPS14	173000000.0	252610000.0	222780000.0	240580000.0
+ARL1	57347000.0	50909000.0	43345000.0	37487000.0
+CLPP	327050000.0	396390000.0	324780000.0	290900000.0
+RPS19	74594000.0	81296000.0	91809000.0	105780000.0
+CCDC22	22932000.0	0.0	0.0	1712500.0
+CCDC25	179030000.0	160030000.0	159340000.0	180580000.0
+FIBP	32611000.0	51232000.0	58892000.0	67641000.0
+ALDH3B1	1803800000.0	1739900000.0	1843500000.0	2069800000.0
+DCAF11	17731000.0	23010000.0	23699000.0	22160000.0
+DDOST	545390000.0	570530000.0	537010000.0	453090000.0
+MGC152281	557640000.0	569870000.0	721230000.0	754790000.0
+RRM1	13024000.0	0.0	6190300.0	6542500.0
+CLPB	34110000.0	35020000.0	36136000.0	36429000.0
+PUSL1	0.0	56005000.0	0.0	0.0
+DERA	3641400000.0	3319200000.0	3690800000.0	4214400000.0
+BROX	9319600.0	12444000.0	8118700.0	8757700.0
+TXN	21594000.0	0.0	26220000.0	144880000.0
+PAPSS2	715820000.0	663540000.0	478190000.0	595530000.0
+SLC9A3R2	99779000.0	157850000.0	89244000.0	99014000.0
+SLC9A3R1	609397600.0	668495400.0	624548400.0	700310000.0
+UBQLN1	42306000.0	42339000.0	77342000.0	77462000.0
+LSM12	130360000.0	147130000.0	104930000.0	123540000.0
+GCLC	18076000.0	20110000.0	16502000.0	15385000.0
+CASP7	317640000.0	309820000.0	404910000.0	382470000.0
+TF	171811000.0	105965000.0	170761000.0	157210000.0
+CYP2C18	464500000.0	607670000.0	762470000.0	835030000.0
+OAS1Y	30693000.0	28108000.0	13733000.0	14962000.0
+OAS1X	363200000.0	468150000.0	352220000.0	394300000.0
+TFAM	589950000.0	692400000.0	813680000.0	749750000.0
+TXNL1	1644300000.0	1455900000.0	1375300000.0	1334100000.0
+SSSCA1	23451000.0	25538000.0	0.0	17865000.0
+ENSBTAG00000000229	76348000.0	67270000.0	71280000.0	84392000.0
+GGT1	257060000.0	273170000.0	333610000.0	320620000.0
+TMX1	747730000.0	885280000.0	822000000.0	886890000.0
+NAGA	52725000.0	45252000.0	29319000.0	31871000.0
+NAGK	43969000.0	61140000.0	67062000.0	73778000.0
+ACTN2	9952900.0	0.0	3457400.0	0.0
+ACTN1	569180000.0	277130000.0	245470000.0	240630000.0
+CYP4A11	2275300000.0	2183500000.0	2032900000.0	2027000000.0
+ACTN4	3497200000.0	1229100000.0	1791600000.0	1941100000.0
+EZR	255700000.0	19718000.0	295630000.0	227620000.0
+GLYAT	2.2364e+11	2.0025e+11	1.5191e+11	1.3174e+11
+G3BP2	27139000.0	26798000.0	33032000.0	36041000.0
+PTPRM	8227600.0	0.0	0.0	0.0
+MYO7B	0.0	0.0	0.0	0.0
+STK10	5390100.0	4661200.0	0.0	0.0
+FKBP4	541680000.0	560730000.0	563180000.0	602130000.0
+SRSF10	514140000.0	492330000.0	565490000.0	520530000.0
+SEC23IP	64151000.0	42028000.0	58825000.0	98144000.0
+FKBP3	1186600000.0	1319000000.0	1254100000.0	1408300000.0
+FKBP8	51378000.0	78727000.0	115900000.0	89603000.0
+GAPVD1	53472000.0	73206000.0	70446000.0	120760000.0
+SGPL1	9431300.0	27854000.0	18613000.0	20251000.0
+NDUFB8	254190000.0	210980000.0	143200000.0	126090000.0
+PPME1	21684000.0	24815000.0	14152000.0	19079000.0
+MANF	286530000.0	286440000.0	139370000.0	126130000.0
+HEBP1	4319100000.0	4575200000.0	7177000000.0	6718200000.0
+HBS1L	28500000.0	13336000.0	16037000.0	16793000.0
+VAC14	74315000.0	35246000.0	78327000.0	69729000.0
+WDR5	90033000.0	77185000.0	112110000.0	98267000.0
+MAN2C1	0.0	0.0	0.0	0.0
+WDR1	509390000.0	549880000.0	506910000.0	528810000.0
+ZFYVE21	52572000.0	80923000.0	63792000.0	116730000.0
+APRT	1481800000.0	1601000000.0	1429700000.0	1302900000.0
+CSNK1A1	41405000.0	45183000.0	55643000.0	54308000.0
+ABLIM1	24298000.0	30745000.0	35816000.0	30282000.0
+JCHAIN	148620000.0	177090000.0	172050000.0	219710000.0
+SULT1E1	302150000.0	359680000.0	357020000.0	388660000.0
+L2HGDH	46199000.0	39565000.0	27411000.0	14522000.0
+SNAP23	66970000.0	51918000.0	63462000.0	77367000.0
+TOP2B	848310.0	0.0	0.0	0.0
+GM2A	71260000.0	77260000.0	77265000.0	92771000.0
+LACTB	88309000.0	100760000.0	121250000.0	115750000.0
+CSRP1	250440000.0	236990000.0	572850000.0	554550000.0
+CSRP2	31487000.0	37792000.0	77162000.0	68822000.0
+SUCLA2	11206000.0	13604000.0	0.0	9781500.0
+HHIP	2319500.0	0.0	0.0	0.0
+HSD17B12	258570000.0	282110000.0	460290000.0	423990000.0
+HSD17B13	86389000000.0	87613000000.0	94315000000.0	95872000000.0
+HSD17B10	1.662e+11	1.4555e+11	1.5148e+11	1.5949e+11
+20ALPHA-HSD	177990000.0	231600000.0	291200000.0	362590000.0
+ATP6V1A	105230000.0	130110000.0	105010000.0	120580000.0
+HSD17B14	2476000000.0	2450600000.0	2568200000.0	2983100000.0
+BBOX1	1907300000.0	2058700000.0	2389500000.0	2614800000.0
+EMD	181900000.0	173000000.0	273880000.0	301920000.0
+ATP6V1E1	235810000.0	245280000.0	287180000.0	278560000.0
+UOX	1162700000.0	1254500000.0	1838500000.0	1812200000.0
+ATP6V1H	8766500.0	9134000.0	11867000.0	12336000.0
+RAB6B	1420100000.0	1492800000.0	1449100000.0	1310800000.0
+MX1	2218300.0	0.0	18035000.0	15739000.0
+SFXN5	148090000.0	102920000.0	128200000.0	143170000.0
+SFXN2	457760000.0	415760000.0	376950000.0	392850000.0
+SFXN1	13866000000.0	12897000000.0	10756000000.0	12038000000.0
+UROD	1776200000.0	1899400000.0	1431300000.0	1669500000.0
+IFIT5	48904000.0	44297000.0	51053000.0	36661000.0
+LMO7	76731000.0	77792000.0	59847000.0	61464000.0
+CCT8	1277900000.0	1275600000.0	1300600000.0	1337600000.0
+ENSBTAG00000032453	1024300000.0	1249300000.0	1678600000.0	1528700000.0
+CCT2	842750000.0	836740000.0	910820000.0	765340000.0
+CCT3	681290000.0	685820000.0	638380000.0	668430000.0
+CCT7	691210000.0	768160000.0	749400000.0	833560000.0
+CCT4	1139600000.0	1022000000.0	1020400000.0	1115200000.0
+CCT5	661777000.0	786885000.0	697410000.0	708990000.0
+EFTUD2	63447000.0	14132000.0	31781000.0	27269000.0
+C4A	2683500.0	0.0	5047300.0	4945400.0
+ENSBTAG00000026133	0.0	0.0	0.0	1307300.0
+C14H8orf82	261800000.0	269680000.0	274300000.0	252230000.0
+PDLIM5	667980000.0	879930000.0	879870000.0	866960000.0
+PDLIM1	693510000.0	766260000.0	861740000.0	983630000.0
+PDLIM3	24464000.0	24396000.0	41071000.0	31825000.0
+BRCC3	145110000.0	133520000.0	170560000.0	170700000.0
+AKTIP	14386000.0	17852000.0	16217000.0	0.0
+ENSBTAG00000048287	91122000.0	110550000.0	174000000.0	144370000.0
+RAP1GDS1	222930000.0	164390000.0	327320000.0	387160000.0
+GDI2	2954800000.0	2703400000.0	2691500000.0	2596500000.0
+DHRS1	16786000000.0	16823000000.0	13378000000.0	14514000000.0
+GDI1	207740000.0	188400000.0	189740000.0	205500000.0
+MCCC2	1180000000.0	1203000000.0	1090500000.0	1176400000.0
+MCCC1	479860000.0	199200000.0	272440000.0	296780000.0
+PAFAH2	26890000.0	29125000.0	18514000.0	13953000.0
+ERLIN2	2578900000.0	2626300000.0	2326900000.0	2312200000.0
+GFM1	91462000.0	22034000.0	62233000.0	80288000.0
+GFM2	13191000.0	0.0	9623700.0	12104000.0
+CBS	331710000.0	405290000.0	299320000.0	343850000.0
+ENSBTAG00000034850	0.0	38902000.0	38575000.0	52146000.0
+FLNB	440460000.0	178120000.0	238220000.0	488900000.0
+EIF4A1	1291800000.0	1381800000.0	566150000.0	615320000.0
+EIF4A3	41238000.0	39590000.0	34954000.0	28141000.0
+KRT18	22250000000.0	23937000000.0	24904000000.0	26564000000.0
+CAPNS1	871780000.0	806020000.0	1008500000.0	1021700000.0
+CROT	2659100000.0	2615200000.0	2044900000.0	2005700000.0
+LETM1	95938000.0	14092000.0	63193000.0	64186000.0
+TMPRSS3	0.0	126060000.0	77770000.0	0.0
+PRKCSH	426160000.0	47167000.0	197520000.0	203480000.0
+TAF15	22299000.0	17855000.0	14406000.0	24872000.0
+FH	2269200000.0	2490900000.0	2614700000.0	2638000000.0
+DCTN3	521710000.0	498800000.0	418570000.0	578860000.0
+DCTN1	22437000.0	7038500.0	25766000.0	12439000.0
+RNASET2	212930000.0	311820000.0	208530000.0	215590000.0
+NDUFV3	68075000.0	66336000.0	76613000.0	95977000.0
+PKLR	1112300000.0	1158400000.0	1773200000.0	1970100000.0
+NDUFV1	304650000.0	301060000.0	265320000.0	240840000.0
+RPS4Y1	5758600000.0	5550400000.0	4115100000.0	4909900000.0
+ASPA	66040000.0	66841000.0	76709000.0	75187000.0
+FAM186A	0.0	0.0	0.0	13677000.0
+ASPN	146030000.0	155720000.0	279990000.0	293980000.0
+SERF2	0.0	0.0	0.0	5681200.0
+ASPH	224830000.0	234750000.0	199970000.0	207430000.0
+CYP39A1	8395000.0	0.0	7533400.0	5251100.0
+RBM15	26794000.0	32039000.0	0.0	0.0
+RBM14	190730000.0	204760000.0	105400000.0	124930000.0
+PARVA	230050000.0	236840000.0	257510000.0	270800000.0
+GGH	256520000.0	238600000.0	239100000.0	239980000.0
+NEXN	0.0	0.0	0.0	0.0
+MVP	362850000.0	60114000.0	328010000.0	414310000.0
+LAMA2	5163900.0	0.0	6648900.0	6664400.0
+PSMD6	24954000.0	0.0	28822000.0	24165000.0
+LAMA5	90082000.0	44053000.0	95415000.0	106580000.0
+ARVCF	15518000.0	7490600.0	1484000.0	7006500.0
+NAT1	1399700000.0	1165000000.0	1847700000.0	1659500000.0
+QPCTL	10582000.0	14977000.0	12539000.0	12945000.0
+FAM96A	183380000.0	138430000.0	160790000.0	165700000.0
+ALDH9A1	674280000.0	869410000.0	990140000.0	1009600000.0
+BPHL	1125500000.0	992170000.0	1082600000.0	978050000.0
+GLO1	6141200000.0	6630200000.0	9284100000.0	7989500000.0
+MVK	334470000.0	322000000.0	629160000.0	427220000.0
+ASRGL1	185280000.0	180700000.0	187390000.0	181430000.0
+CMBL	6730800000.0	6854400000.0	8409200000.0	8764900000.0
+F7	20044000.0	19853000.0	15657000.0	17768000.0
+F9	83664000.0	109390000.0	61310000.0	73307000.0
+LSP1	15994000.0	12617000.0	32234000.0	29300000.0
+GSTZ1	14655000000.0	16114000000.0	15953000000.0	17280000000.0
+MARS	88118000.0	9877800.0	81274000.0	53420000.0
+TUBGCP2	1622400.0	0.0	0.0	0.0
+CUL3	6928200.0	0.0	11029000.0	9865000.0
+NBEAL1	4800300.0	0.0	10826000.0	10975000.0
+CFD	0.0	0.0	0.0	61208000.0
+VAV2	3681100.0	0.0	0.0	0.0
+PSMD9	404120000.0	365530000.0	484210000.0	420800000.0
+PSMD8	449450000.0	620000000.0	397420000.0	398250000.0
+PSMD5	117950000.0	120000000.0	119040000.0	156130000.0
+PSMD4	155190000.0	170780000.0	121050000.0	106790000.0
+PSMD7	290790000.0	268130000.0	162760000.0	130450000.0
+FLAD1	29684000.0	47204000.0	35544000.0	11192000.0
+PSMD1	201290000.0	26324000.0	109910000.0	121460000.0
+PSMD3	42419000.0	53347000.0	75063000.0	82834000.0
+PSMD2	303750000.0	206420000.0	302810000.0	218040000.0
+CTNNB1	128470000.0	21738000.0	102480000.0	101680000.0
+NGFR	4660200.0	0.0	0.0	0.0
+CPSF7	22101000.0	27438000.0	18554000.0	0.0
+MOB1A	80968000.0	86045000.0	62961000.0	60203000.0
+CPSF3	4819700.0	0.0	2513700.0	3079100.0
+CPSF2	12355000.0	0.0	0.0	0.0
+CPSF1	0.0	0.0	0.0	0.0
+EPS15	14692000.0	20334000.0	21062000.0	18323000.0
+QKI	49407000.0	35100000.0	45602000.0	66936000.0
+ENSBTAG00000014220	91830000.0	93167000.0	148960000.0	137590000.0
+MAD1L1	11499000.0	0.0	0.0	6970700.0
+CATHL2	264870000.0	275800000.0	1099600000.0	1005200000.0
+CATHL3	35131000.0	43219000.0	367880000.0	353550000.0
+CATHL1	52952000.0	47811000.0	97534000.0	102780000.0
+HSD17B8	5362300000.0	5608000000.0	4592700000.0	5121100000.0
+HMGCL	4501300000.0	5242700000.0	4685300000.0	5195300000.0
+ACAA1	14126000000.0	15236000000.0	12981000000.0	12920000000.0
+ILVBL	400130000.0	433190000.0	503800000.0	520350000.0
+CNOT7	66502000.0	56477000.0	34253000.0	35471000.0
+HSD17B6	12351000000.0	12042000000.0	20767000000.0	20932000000.0
+HSD17B7	819430000.0	856740000.0	1351200000.0	1350900000.0
+ITGB1	159000000.0	5402500.0	53231000.0	59428000.0
+ITGB3	36181000.0	0.0	2942500.0	2632500.0
+ENSBTAG00000039289	266550000.0	255220000.0	312160000.0	348370000.0
+ITGB5	4616100.0	0.0	5805400.0	5596900.0
+ITGB6	8678600.0	0.0	13554000.0	0.0
+RTN4	2998500.0	7860500.0	8646500.0	43422000.0
+HAX1	17560000.0	18992000.0	18092000.0	16648000.0
+KPNB1	468780000.0	19149000.0	188070000.0	148720000.0
+HGS	6456800.0	2900500.0	0.0	1583900.0
+R3HDM1	0.0	0.0	0.0	0.0
+MST1	3544800.0	0.0	0.0	0.0
+HGD	9350000000.0	9826300000.0	10338000000.0	10131000000.0
+PRMT5	664950.0	0.0	0.0	0.0
+COPS7B	80421000.0	25712000.0	82350000.0	84168000.0
+COPS7A	376950000.0	439990000.0	352550000.0	362020000.0
+CRAT	937510000.0	953140000.0	837990000.0	823690000.0
+PPFIA1	1257700.0	0.0	0.0	0.0
+MYO6	8065100.0	0.0	22000000.0	31960000.0
+RABGGTB	89700000.0	107540000.0	110640000.0	107890000.0
+NAP1L4	12128000.0	13242000.0	11755000.0	10763000.0
+KIF13B	3597700.0	0.0	0.0	0.0
+RABGGTA	10909000.0	10594000.0	11334000.0	9474100.0
+ENSBTAG00000019601	34380000.0	39797000.0	27628000.0	28720000.0
+FSHB	7739200.0	0.0	7583300.0	6911400.0
+ENSBTAG00000044137	0.0	0.0	0.0	61369000.0
+HUWE1	35663000.0	0.0	49643000.0	15985000.0
+MAT1A	2752000000.0	2761900000.0	2424600000.0	3007500000.0
+EHD4	90108000.0	74856000.0	68414000.0	87003000.0
+PKP2	181330000.0	271840000.0	187080000.0	189640000.0
+EHD3	638510000.0	663950000.0	546150000.0	484830000.0
+SLC25A15	1432900000.0	1717300000.0	1186700000.0	1081700000.0
+SLC25A13	5389300.0	5656600.0	5559500.0	0.0
+SLC25A12	0.0	0.0	0.0	0.0
+SLC25A11	1441800000.0	1491900000.0	1532800000.0	1535300000.0
+PEBP1	25712000000.0	22913000000.0	33230000000.0	32581000000.0
+ACAA2	39992000000.0	40136000000.0	29003000000.0	27706000000.0
+CNOT9	46751000.0	55376000.0	43803000.0	52149000.0
+NDUFA10	685240000.0	746010000.0	751540000.0	728560000.0
+FGG	3701700000.0	3937600000.0	5071600000.0	5600200000.0
+METTL7A	77720000.0	140140000.0	134380000.0	122100000.0
+METTL7B	42381000000.0	38075000000.0	46410000000.0	53351000000.0
+TOR1AIP2	16648000.0	21520000.0	33596000.0	32846000.0
+PLBD2	467430000.0	476440000.0	521650000.0	511990000.0
+ACIN1	2569300.0	0.0	3345000.0	0.0
+ATP1B3	213660000.0	233490000.0	352570000.0	407660000.0
+LPP	48707000.0	72113000.0	56820000.0	42382000.0
+TNFRSF21	6167700.0	0.0	0.0	0.0
+PSMC2	409550000.0	407570000.0	470930000.0	447010000.0
+SYNCRIP	152230000.0	198680000.0	104310000.0	112560000.0
+FCGRT	363270000.0	483160000.0	388460000.0	436190000.0
+HSD17B4	47904000000.0	50286000000.0	52436000000.0	53262000000.0
+ALDH1L1	25332000000.0	9838100000.0	17083000000.0	20738000000.0
+MPV17L	50791000.0	95094000.0	15954000.0	7800400.0
+C1QC	103610000.0	107250000.0	114500000.0	106760000.0
+C1QB	209980000.0	165440000.0	262140000.0	246170000.0
+VIM	3926300000.0	4128400000.0	5853000000.0	6041200000.0
+EFL1	2856600.0	0.0	7274200.0	6343700.0
+TRA2B	484300000.0	496070000.0	411220000.0	452140000.0
+PHB	15985000000.0	15933000000.0	14559000000.0	16163000000.0
+MMAA	1352500000.0	1572900000.0	1779700000.0	1585200000.0
+ALDH5A1	1487600000.0	1489400000.0	1700900000.0	1830900000.0
+MMAB	1654500000.0	1766300000.0	2075900000.0	1757700000.0
+OSBP	428520000.0	265220000.0	187730000.0	176890000.0
+PTPN11	19019000.0	16365000.0	20393000.0	687930000.0
+DDAH2	359630000.0	357680000.0	422850000.0	475020000.0
+DIABLO	297480000.0	303310000.0	308250000.0	272710000.0
+SDR39U1	647830000.0	617860000.0	552030000.0	591450000.0
+SNX2	578520000.0	550310000.0	521130000.0	531050000.0
+PDXK	336240000.0	336910000.0	287390000.0	227620000.0
+CYB5R3	18540000000.0	16537000000.0	25042000000.0	26395000000.0
+SNX6	156050000.0	187170000.0	103590000.0	94271000.0
+CYB5R1	97616000.0	87402000.0	76542000.0	121300000.0
+SNX4	13815000.0	13045000.0	13681000.0	16818000.0
+UGT3A2	102390000.0	95136000.0	152750000.0	127000000.0
+SPTAN1	1147800000.0	373950000.0	643940000.0	625110000.0
+SNX9	41027000.0	59252000.0	38935000.0	57635000.0
+SPON1	8440200.0	0.0	0.0	8201500.0
+ALG5	62653000.0	58442000.0	63948000.0	80832000.0
+ITGB2	27198000.0	22826000.0	37216000.0	29875000.0
+MASP2	31078000.0	0.0	25379000.0	33242000.0
+PDXP	858860000.0	819780000.0	1036300000.0	947310000.0
+FUK	6615700.0	0.0	14818000.0	14564000.0
+CCDC127	94328000.0	123450000.0	115780000.0	113080000.0
+NOS3	3590500.0	14437000.0	0.0	0.0
+RAB11A	1991600000.0	2249400000.0	2029700000.0	1881300000.0
+GCC2	594960.0	0.0	0.0	0.0
+ENSBTAG00000046676	48550000.0	69465000.0	39650000.0	57079000.0
+PKM	257561000.0	261645000.0	306633000.0	266375000.0
+TMED7	835790000.0	932310000.0	672290000.0	680350000.0
+BLA-DQB	21763000.0	36572000.0	33903000.0	31517000.0
+CSK	30640000.0	31665000.0	37316000.0	41025000.0
+DAP3	22690000.0	21559000.0	25655000.0	26666000.0
+TNPO1	90346000.0	4736100.0	74437000.0	68664000.0
+EIF4E	220430000.0	300230000.0	246000000.0	213620000.0
+TELO2	12148000.0	0.0	4630400.0	3660700.0
+CALU	14441000.0	14244000.0	8392400.0	0.0
+TUBB2A	0.0	33716000.0	34336000.0	38766000.0
+TUBB2B	68642000.0	59808000.0	84258000.0	54872000.0
+PAAF1	31569000.0	28441000.0	37512000.0	37182000.0
+CD99	17962000.0	43054000.0	61204000.0	0.0
+COMTD1	18172000.0	18721000.0	11679000.0	12535000.0
+TUBB	699230000.0	646990000.0	567290000.0	505000000.0
+MAOB	11277000000.0	11786000000.0	10746000000.0	12257000000.0
+NAPRT	1570700000.0	1416600000.0	2024700000.0	2003500000.0
+DTYMK	447940000.0	418540000.0	254230000.0	235700000.0
+NEIL3	4165200.0	0.0	3392300.0	4049300.0
+ENSBTAG00000048275	800657000.0	804232000.0	952999000.0	915604000.0
+MUT	2304300000.0	1235200000.0	1726600000.0	1640800000.0
+INMT	446420000.0	232420000.0	145190000.0	153350000.0
+CLYBL	3550279000.0	3836427000.0	3564100000.0	3735583000.0
+RFC2	21130000.0	22319000.0	11434000.0	0.0
+PGAM5	949790000.0	898470000.0	802760000.0	816340000.0
+TECR	19389000.0	28373000.0	41910000.0	32385000.0
+FABP1	1412600000.0	1248700000.0	2425500000.0	2126800000.0
+AKR1C4	76362000000.0	90433000000.0	85571000000.0	70277000000.0
+CBX3	139270000.0	144060000.0	134780000.0	135410000.0
+LCP1	262450000.0	245330000.0	236000000.0	308880000.0
+FECH	319750000.0	376110000.0	317500000.0	357100000.0
+AKR1C3	1.017e+11	1.0931e+11	1.4652e+11	1.5405e+11
+ZBTB10	90706000.0	6285900.0	24843000.0	27192000.0
+SEH1L	19484000.0	17666000.0	0.0	19348000.0
+ENSBTAG00000008184	1650200000.0	1815000000.0	1312700000.0	1459900000.0
+CCDC51	109650000.0	130190000.0	163400000.0	188320000.0
+MRPL22	13524000.0	31727000.0	0.0	0.0
+C1QBP	106850000.0	176150000.0	115140000.0	80877000.0
+RAB18	1764900000.0	2089300000.0	1520400000.0	1432000000.0
+ENSBTAG00000018680	1282300.0	0.0	0.0	0.0
+TRAPPC11	2564400.0	0.0	13091000.0	12838000.0
+TRAPPC12	892000.0	0.0	0.0	0.0
+ENSBTAG00000047699	0.0	23767000.0	0.0	0.0
+RAB13	50773000.0	60555000.0	49456000.0	50840000.0
+SRP72	16433000.0	14733000.0	19372000.0	17076000.0
+RAB15	926950000.0	1102700000.0	1462400000.0	1369100000.0
+RAB14	5535700000.0	6435600000.0	5914900000.0	5779400000.0
+RAB17	14932000.0	15309000.0	15395000.0	16709000.0
+ASL	3952400000.0	4219400000.0	4383400000.0	4614200000.0
+RRAS2	863910000.0	793140000.0	959630000.0	779890000.0
+RAB1A	3093800000.0	3255700000.0	3498900000.0	2919000000.0
+NAGLU	17864000.0	0.0	8838100.0	25113000.0
+FYN	0.0	19205000.0	22333000.0	0.0
+GMPPA	297170000.0	275830000.0	198880000.0	196640000.0
+GMPPB	260290000.0	247220000.0	222020000.0	213150000.0
+ENSBTAG00000011330	551640000.0	472870000.0	318140000.0	286080000.0
+GNL1	4006900.0	0.0	2782800.0	3925300.0
+MTOR	1779700.0	0.0	0.0	0.0
+LAMP2	252180000.0	124500000.0	290720000.0	240700000.0
+ACADSB	20895000.0	28348000.0	22520000.0	28382000.0
+ALDH2	26150000000.0	25846000000.0	33588000000.0	34135000000.0
+PTPA	368780000.0	325710000.0	531010000.0	447250000.0
+SHOC2	215600000.0	231460000.0	84800000.0	85916000.0
+RPL10A	7105900000.0	6729600000.0	6670700000.0	6663700000.0
+RAD50	825210.0	0.0	0.0	0.0
+SEPT9	171480000.0	182550000.0	237690000.0	217310000.0
+PIP4P1	63096000.0	55017000.0	60643000.0	58816000.0
+USP8	1436300.0	0.0	1347300.0	0.0
+DDO	1051630000.0	1095370000.0	1424250000.0	1556720000.0
+USP4	4593700.0	0.0	0.0	0.0
+USP7	14138000.0	0.0	10256000.0	11462000.0
+RPRD1A	331490000.0	330780000.0	391730000.0	255150000.0
+MRPS15	24696000.0	28921000.0	20246000.0	24660000.0
+NUP37	12007000.0	9333000.0	10802000.0	18845000.0
+RNF31	360570.0	0.0	0.0	0.0
+COQ4	202260000.0	227590000.0	185860000.0	135080000.0
+ASAH1	140440000.0	146830000.0	310630000.0	252340000.0
+TPPP	57902000.0	53537000.0	106850000.0	83540000.0
+XRCC5	2772000.0	0.0	0.0	0.0
+BID	44864000.0	56484000.0	62319000.0	42804000.0
+PHKB	3676600.0	0.0	9364500.0	8701600.0
+PFKM	3724200.0	0.0	7122000.0	8272100.0
+PFKL	87787000.0	0.0	140350000.0	120400000.0
+QDPR	21128000000.0	19245000000.0	20589000000.0	20254000000.0
+PITPNB	461790000.0	437130000.0	612110000.0	560760000.0
+LMAN2L	70254000.0	62676000.0	92550000.0	131550000.0
+TTPA	1552600000.0	1241400000.0	1342000000.0	1372300000.0
+SND1	1459700000.0	1270300000.0	755680000.0	780930000.0
+TPP1	682970000.0	731230000.0	604190000.0	605200000.0
+TPP2	340190000.0	101450000.0	264160000.0	228690000.0
+PSME2	1489900000.0	1807900000.0	1707600000.0	1835300000.0
+PSME3	91765000.0	78561000.0	115470000.0	111240000.0
+PSME1	1717400000.0	1762600000.0	2569900000.0	2132400000.0
+SRSF6	59275000.0	67466000.0	100290000.0	105190000.0
+CUL5	14825000.0	3746200.0	6827500.0	6948600.0
+SLK	771150.0	0.0	0.0	0.0
+CIDEB	317680000.0	340030000.0	296290000.0	321110000.0
+CTNNA1	549040000.0	33126000.0	185030000.0	179460000.0
+CTNNA2	998140.0	0.0	30542000.0	13242000.0
+PHYH	7381900000.0	6930500000.0	6795200000.0	5994400000.0
+TAMM41	39948000.0	21162000.0	16393000.0	21088000.0
+ABCF1	41976000.0	0.0	21719000.0	19873000.0
+TOPBP1	3669100.0	0.0	0.0	0.0
+CLEC4G	160360000.0	163570000.0	157240000.0	185490000.0
+GSPT1	37664000.0	53827000.0	35029000.0	11117000.0
+SSR1	67042000.0	82735000.0	180780000.0	154180000.0
+SSR4	60152000.0	69130000.0	55690000.0	85881000.0
+TMEM33	40266000.0	44747000.0	52057000.0	49719000.0
+CNTRL	41156000.0	0.0	44410000.0	38086000.0
+SLF1	186380000.0	137090000.0	80350000.0	88024000.0
+GDA	264690000.0	263390000.0	380070000.0	446970000.0
+TM7SF2	178810000.0	140280000.0	266780000.0	289770000.0
+ADPGK	39968000.0	21227000.0	35039000.0	30031000.0
+MLEC	926030000.0	886520000.0	1716900000.0	1761400000.0
+TGM2	312630000.0	105940000.0	210220000.0	322130000.0
+BGN	5747200.0	0.0	2720100.0	2919900.0
+CASTOR1	285430000.0	407950000.0	651840000.0	655160000.0
+IST1	82810000.0	67184000.0	90333000.0	121040000.0
+RAPGEF1	30054000.0	0.0	200330000.0	227800000.0
+XDH	19766000.0	0.0	3890400.0	0.0
+ASPDH	3411200000.0	3744400000.0	4248500000.0	4001800000.0
+SELENBP1	8123800000.0	7795500000.0	11938000000.0	12859000000.0
+PARK7	8095000000.0	9412200000.0	10240000000.0	10160000000.0
+PRODH2	30926000.0	31076000.0	40897000.0	46306000.0
+RORC	352020000.0	0.0	0.0	0.0
+MPP6	136080000.0	106750000.0	73667000.0	70741000.0
+EML4	26866000.0	0.0	5985300.0	6239700.0
+TFRC	42903000.0	1534600.0	24988000.0	19314000.0
+NSFL1C	287620000.0	226100000.0	233050000.0	235900000.0
+TAGLN2	202160000.0	223180000.0	255200000.0	192880000.0
+GUSB	286452000.0	179470000.0	125880000.0	75764200.0
+GNPDA1	221430000.0	237310000.0	332770000.0	262800000.0
+PRPSAP1	32545000.0	30984000.0	24045000.0	17497000.0
+LAS1L	2197200.0	0.0	0.0	0.0
+ENSBTAG00000040134	13439000.0	11551000.0	40177000.0	112060000.0
+PRUNE1	24636000.0	18829000.0	30498000.0	21264000.0
+ETFDH	3518500000.0	3746000000.0	3225600000.0	3141500000.0
+SLC25A22	4573900000.0	5094200000.0	4754300000.0	5387800000.0
+SLC25A20	6567700000.0	6403600000.0	4486500000.0	4504100000.0
+ERO1A	51777000.0	73414000.0	48843000.0	54628000.0
+CFAP73	95913000.0	30724000.0	108970000.0	42958000.0
+SLC3A2	1556500.0	0.0	4036700.0	0.0
+GMPS	17641000.0	53838000.0	29957000.0	24794000.0
+ENSBTAG00000030384	62681000.0	150460000.0	13026000.0	107140000.0
+IKBKB	3645100.0	0.0	0.0	3025800.0
+ATIC	1463900000.0	1577300000.0	1687800000.0	1869500000.0
+PCTP	878140000.0	912010000.0	1116400000.0	866430000.0
+DHODH	271590000.0	258390000.0	244670000.0	260810000.0
+ENSBTAG00000046905	33754000.0	30891000.0	46408000.0	68161000.0
+KPNA6	0.0	0.0	25838000.0	0.0
+REXO2	134800000.0	118240000.0	147050000.0	122940000.0
+KPNA3	30780000.0	33423000.0	38521000.0	38178000.0
+KPNA2	8038500.0	21105000.0	3849900.0	3423800.0
+COPB1	363400000.0	56652000.0	187320000.0	239400000.0
+COPB2	233430000.0	81395000.0	127390000.0	101640000.0
+SEL1L	58488000.0	0.0	23751000.0	23988000.0
+UBE2N	64123000.0	74279000.0	101300000.0	74555000.0
+PTPMT1	13311000.0	11356000.0	14016000.0	17835000.0
+CRP	400110000.0	394520000.0	484060000.0	462730000.0
+PLCB1	34418000.0	0.0	0.0	0.0
+GORASP2	88387000.0	53118000.0	13313000.0	67499000.0
+CARM1	14440000.0	16580000.0	14201000.0	17424000.0
+CIAO1	16818000.0	12062000.0	14232000.0	22084000.0
+EXOC3L2	3269800.0	0.0	0.0	0.0
+TMEM177	40962000.0	27093000.0	28736000.0	32043000.0
+CRK	338600000.0	343810000.0	486080000.0	547430000.0
+EIF5B	25147000.0	2972400.0	5535100.0	9515600.0
+NUDT21	401550000.0	358920000.0	438540000.0	368960000.0
+EIF5A	546490000.0	478300000.0	136510000.0	291950000.0
+SUMF2	55881000.0	46413000.0	42227000.0	45629000.0
+NONO	101390000.0	127330000.0	98999000.0	119910000.0
+GLDC	909960000.0	279330000.0	431400000.0	368030000.0
+UNC45A	26330000.0	0.0	20115000.0	27295000.0
+PC	16755000000.0	8060000000.0	6060500000.0	6002200000.0
+RTN4IP1	282650000.0	262160000.0	300050000.0	313510000.0
+FNDC3A	8186000.0	0.0	0.0	6604700.0
+PGK1	3846700000.0	4153900000.0	2412900000.0	2519100000.0
+SULT1C4	12400000000.0	11685000000.0	8719100000.0	9321700000.0
+TUBB6	19910000.0	20654000.0	22843000.0	18861000.0
+DHRS11	1696800000.0	1758100000.0	1599700000.0	1517100000.0
+DHRS12	545750000.0	615250000.0	498050000.0	507130000.0
+ACSF3	82967000.0	60923000.0	101500000.0	88958000.0
+TUBB3	9054300.0	5466500.0	8428900.0	5727300.0
+MAN2A1	35954000.0	9905800.0	6133700.0	7325200.0
+RPP25L	50837000.0	61199000.0	50463000.0	51813000.0
+EEF1D	5022300000.0	5680500000.0	5375400000.0	5295700000.0
+SPACA6	0.0	0.0	0.0	0.0
+GALK1	3022500000.0	3012100000.0	2117100000.0	2196900000.0
+SH3BGRL3	73872000.0	0.0	0.0	0.0
+RPAP1	23613000.0	70312000.0	115630000.0	97181000.0
+PRPF19	37825000.0	39665000.0	40946000.0	45918000.0
+EIF3A	43766000.0	3553300.0	65440000.0	78429000.0
+GPD1L	25201000.0	37663000.0	23703000.0	31374000.0
+TMLHE	8287900.0	7133700.0	0.0	7044800.0
+EIF3B	103000000.0	6112700.0	50218000.0	38226000.0
+OXA1L	13987000.0	40108000.0	6671000.0	10835000.0
+TINAGL1	14317000.0	33653000.0	47543000.0	69276000.0
+EIF3E	76322000.0	80931000.0	46587000.0	48670000.0
+DDC	76879000.0	63251000.0	94560000.0	94206000.0
+DARS2	57325000.0	55495000.0	38114000.0	51614000.0
+RHOT1	8852400.0	0.0	4990100.0	8419800.0
+ARHGEF1	19179000.0	21207000.0	16996000.0	29976000.0
+TP53RK	503000000.0	523800000.0	487190000.0	469860000.0
+DNAAF5	35503000.0	37232000.0	55074000.0	49106000.0
+POFUT1	71799000.0	59515000.0	45066000.0	49801000.0
+STAT6	6931700.0	0.0	3030300.0	0.0
+LAMC1	6696000.0	8776100.0	0.0	0.0
+STAT3	293640000.0	354740000.0	159310000.0	256630000.0
+STAT2	36567000.0	35118000.0	10531000.0	16581000.0
+STAT1	82050000.0	108390000.0	155510000.0	160200000.0
+CD81	32301000.0	65261000.0	93587000.0	121200000.0
+ENSBTAG00000037605	23272000.0	22127000.0	30367000.0	23349000.0
+HPRT1	1554600000.0	1927100000.0	1281100000.0	1247800000.0
+USP19	1541600.0	0.0	0.0	0.0
+RPL13A	1853600000.0	2151400000.0	1746900000.0	1818000000.0
+ICAM1	6197400.0	0.0	5552400.0	5385200.0
+CYP7A1	125470000.0	100730000.0	49475000.0	48058000.0
+CTDSP1	0.0	22956000.0	26691000.0	26935000.0
+DPM1	812290000.0	854150000.0	648660000.0	773710000.0
+CRYAB	295960000.0	441530000.0	434730000.0	765690000.0
+CD68	24017000.0	3878200.0	6296000.0	7915600.0
+LMNB1	94612700.0	87258000.0	66640000.0	82345000.0
+TPD52L2	59415000.0	116940000.0	100030000.0	99381000.0
+MAIP1	135950000.0	148740000.0	176170000.0	124630000.0
+EFCAB11	200270000.0	179980000.0	185050000.0	172180000.0
+AKR1B1	505260000.0	497560000.0	648990000.0	790800000.0
+LRBA	7792500.0	0.0	23297000.0	29613000.0
+ENSBTAG00000037510	56623000.0	66507000.0	91987000.0	93652000.0
+SLBP2	0.0	0.0	0.0	0.0
+LRP1	103570000.0	18666000.0	30687000.0	40503000.0
+GSTT1	9622970000.0	8760550000.0	11908300000.0	12553900000.0
+ISOC1	3908400000.0	3766300000.0	3709900000.0	3859600000.0
+ARPC5L	135520000.0	164240000.0	279390000.0	279070000.0
+WDR13	48482000.0	53244000.0	36699000.0	0.0
+ATP5PD	2917900000.0	3334800000.0	3635300000.0	3491200000.0
+WDR11	0.0	0.0	0.0	0.0
+TMTC3	118920000.0	0.0	0.0	0.0
+RHEB	55905000.0	0.0	61047000.0	54597000.0
+STIM1	71143000.0	106670000.0	74968000.0	78189000.0
+CD276	1770800.0	0.0	3647400.0	3424900.0
+CREG1	862999000.0	721157000.0	1570010000.0	1633270000.0
+CDH17	40960000.0	209260000.0	29298000.0	25708000.0
+SPATA20	71267000.0	17384000.0	67358000.0	63115000.0
+ENSBTAG00000016472	68538000000.0	67296000000.0	1.4577e+11	1.5094e+11
+C8A	73567000.0	107180000.0	55628000.0	54803000.0
+USP9X	17399000.0	0.0	8239500.0	5391700.0
+GPD1	62098000000.0	56265000000.0	57407000000.0	58741000000.0
+MAP2K6	262040000.0	242890000.0	206250000.0	212000000.0
+MAP4	20375000.0	0.0	32554000.0	44631000.0
+MAP2K4	56386000.0	56810000.0	78206000.0	51191000.0
+AACS	0.0	0.0	2462200.0	2288000.0
+BCL9L	184120000.0	228080000.0	87008000.0	166030000.0
+MICU1	8180600.0	0.0	0.0	0.0
+TSNAX	52854000.0	44020000.0	62545000.0	42609000.0
+ENSBTAG00000048135	7596100000.0	7057900000.0	9843800000.0	10550300000.0
+COX2	2881100000.0	2034500000.0	1622700000.0	2043000000.0
+GAT	8595100000.0	8036900000.0	6933700000.0	7132400000.0
+MRPL18	29895000.0	39796000.0	13792000.0	0.0
+PPL	120960000.0	25649000.0	81002000.0	106750000.0
+APEX1	241440000.0	290870000.0	254290000.0	193590000.0
+ACY1	4267600000.0	3897600000.0	4004700000.0	3900700000.0
+KMT2C	34326000.0	59607000.0	45843000.0	50135000.0
+ITPA	73286000.0	54244000.0	60827000.0	65127000.0
+HSPB1	74536000000.0	63782000000.0	1.2829e+11	1.2019e+11
+COL18A1	452620000.0	527270000.0	298610000.0	332070000.0
+CYP4V2	201970000.0	208260000.0	251870000.0	271860000.0
+PKN2	0.0	95081000.0	33973000.0	24290000.0
+SUCLG2	3098200000.0	3059300000.0	1944500000.0	1959800000.0
+SUCLG1	5900200000.0	5648200000.0	5316700000.0	5819900000.0
+ENSBTAG00000021368	53939000.0	35884000.0	77103000.0	82457000.0
+DYNC1H1	109350000.0	35590000.0	60784000.0	55303000.0
+ALDOA	2074700000.0	2014700000.0	1191000000.0	1139300000.0
+ALDOC	42258000.0	23839000.0	21695000.0	0.0
+ALDOB	313550000.0	81383000.0	117810000.0	109250000.0
+ENSBTAG00000019437	4443500.0	0.0	0.0	2993400.0
+ENSBTAG00000046325	6019900.0	0.0	0.0	0.0
+DIS3L2	1482700.0	0.0	4869100.0	4948900.0
+IMPA1	153090000.0	177080000.0	152940000.0	166560000.0
+RAB30	27882000.0	26272000.0	14101000.0	20189000.0
+CYC1	2774800000.0	2991700000.0	2472800000.0	2895500000.0
+PON3	541890000.0	549370000.0	521820000.0	491840000.0
+PON2	109480000.0	101690000.0	63738000.0	57138000.0
+PSAT1	9977100000.0	10684000000.0	13686000000.0	14121000000.0
+CPNE3	139600000.0	160280000.0	200310000.0	173060000.0
+SPATA2L	12336000.0	0.0	0.0	2966100.0
+CMPK1	3057700000.0	2900400000.0	3025600000.0	2995100000.0
+HAO1	14077000000.0	12679000000.0	16286000000.0	16490000000.0
+HAO2	12887000000.0	13047000000.0	9921600000.0	11276000000.0
+CMPK2	6470300.0	6993500.0	6650600.0	9271800.0
+CKAP4	835660000.0	849250000.0	606150000.0	587120000.0
+EDEM3	3194500.0	0.0	0.0	1731600.0
+FAM213A	774150000.0	799570000.0	1209100000.0	1128500000.0
+GSS	285760000.0	267960000.0	351250000.0	373390000.0
+GSR	406380000.0	438930000.0	456640000.0	467730000.0
+MRPL2	138100000.0	117430000.0	52367000.0	74822000.0
+LRPPRC	132450000.0	0.0	136940000.0	139320000.0
+WASHC5	1252200.0	0.0	11694000.0	11853000.0
+PSMF1	304680000.0	196450000.0	219600000.0	228440000.0
+PPCDC	89014000.0	108650000.0	149690000.0	144310000.0
+AFG3L2	75593000.0	87184000.0	60569000.0	44647000.0
+SCO2	367310000.0	340910000.0	333880000.0	410440000.0
+SCO1	2159600000.0	2175200000.0	1850400000.0	2091100000.0
+PBXIP1	19017000.0	1821500.0	6024400.0	11059000.0
+UGP2	6024000000.0	6034600000.0	3775600000.0	4248100000.0
+HTATIP2	312500000.0	382280000.0	255650000.0	312110000.0
+MPST	2178500000.0	2338100000.0	2672800000.0	2722400000.0
+KHK	7678700000.0	7719300000.0	7810000000.0	8109500000.0
+GOLGA5	3346200.0	3413000.0	0.0	0.0
+APEH	472090000.0	21387000.0	210340000.0	206070000.0
+PTBP2	67267000.0	56472000.0	173780000.0	70403000.0
+PTBP1	1016600000.0	1283000000.0	894870000.0	1040700000.0
+NNT	440450000.0	463020000.0	249680000.0	221990000.0
+ENSBTAG00000038461	77886000.0	22533000.0	103280000.0	99644000.0
+BOLA	147600000.0	161720000.0	129670000.0	133910000.0
+ENPP6	12060000.0	10733000.0	11865000.0	13246000.0
+HK3	33321000.0	0.0	157920000.0	154700000.0
+HK1	9312600.0	0.0	8800400.0	6942300.0
+ENPP1	470280000.0	63057000.0	359790000.0	288310000.0
+ENSBTAG00000015438	2181400000.0	322990000.0	728230000.0	724770000.0
+GIPC1	10438000.0	0.0	8210700.0	10131000.0
+MGC152010	2791900000.0	3014300000.0	4702300000.0	4636000000.0
+CSNK2A1	166170000.0	188340000.0	260910000.0	171480000.0
+KCTD12	663870000.0	752580000.0	983320000.0	920060000.0
+MTCH1	0.0	21524000.0	16194000.0	39023000.0
+ENSBTAG00000001700	3788300000.0	3963800000.0	3955000000.0	3972100000.0
+MSRA	13810290000.0	14631050000.0	22953210000.0	24060900000.0
+PPIP5K1	18596000.0	0.0	0.0	0.0
+ALDH1L2	326580000.0	97406000.0	139840000.0	172960000.0
+DHDH	8638800.0	9531300.0	16282000.0	20249000.0
+CPS1	65033000000.0	60378000000.0	33664000000.0	31457000000.0
+TJP3	1250900.0	0.0	0.0	0.0
+PLS1	15541000.0	0.0	16709000.0	18218000.0
+PABPC1	607930000.0	656990000.0	391730000.0	458100000.0
+MACF1	7325000.0	0.0	0.0	0.0
+PABPC4	75009000.0	83386000.0	50404000.0	61454000.0
+H6PD	881570000.0	161700000.0	722450000.0	749530000.0
+CHCHD10	93071000.0	118410000.0	147040000.0	160680000.0
+GRHPR	3469300000.0	2818600000.0	2613800000.0	2520900000.0
+JSP.1	54883000.0	103500000.0	59392000.0	94205000.0
+DLAT	102800000.0	16857000.0	146050000.0	156370000.0
+DNM2	83085000.0	61660000.0	100170000.0	136160000.0
+DLGAP5	280400000.0	281980000.0	419250000.0	496820000.0
+ADPRH	167440000.0	134090000.0	152510000.0	184390000.0
+PDHX	108620000.0	100420000.0	131090000.0	134150000.0
+C14H8orf33	20855000.0	24378000.0	17832000.0	23426000.0
+TRAP1	260620000.0	288860000.0	138440000.0	147340000.0
+TRABD	33844000.0	24659000.0	0.0	17726000.0
+GOLPH3	73283000.0	68236000.0	57990000.0	61765000.0
+TUBA1D	9018100000.0	8996400000.0	6776800000.0	7086400000.0
+ARHGEF37	3007700.0	0.0	4016700.0	3471500.0
+PIK3R4	4249900.0	0.0	0.0	0.0
+PIK3R1	3783300.0	0.0	4150500.0	4660700.0
+PDHB	1559300000.0	1350700000.0	675680000.0	614470000.0
+OS9	34952000.0	16090000.0	48385000.0	65828000.0
+GYS1	3476400.0	0.0	3587900.0	3989600.0
+DSTN	128120000.0	123830000.0	36265000.0	33960000.0
+GYS2	211320000.0	155400000.0	78435000.0	82918000.0
+PCBD1	0.0	4009200.0	157040000.0	126560000.0
+ENSBTAG00000047868	88564000.0	110880000.0	107790000.0	96271000.0
+ASMTL	16602000.0	40011000.0	50649000.0	47064000.0
+AP1G1	36476000.0	6237800.0	22516000.0	34443000.0
+G6PD	55189000.0	55741000.0	68413000.0	95358000.0
+HMOX1	2070900000.0	2136900000.0	1795300000.0	1898100000.0
+USP10	36746000.0	43844000.0	45100000.0	34493000.0
+HMOX2	615617000.0	726136000.0	527020000.0	638961000.0
+ELMO3	1760100.0	0.0	0.0	0.0
+AASDHPPT	97840000.0	105810000.0	89461000.0	99286000.0
+GATD1	62515000.0	61136000.0	63743000.0	108430000.0
+SULT1B1	1874000000.0	1822800000.0	1691200000.0	1823900000.0
+TUBA8	34374000.0	37694000.0	30326000.0	27279000.0
+RAD23B	23657000.0	72828000.0	28078000.0	39228000.0
+EHD2	11750000.0	8164800.0	7500300.0	7027100.0
+EHD1	62531000.0	89941000.0	63258000.0	73367000.0
+ZER1	931480.0	0.0	2859700.0	2585300.0
+RPS18	112970000.0	107120000.0	82309000.0	85997000.0
+IYD	148360000.0	174420000.0	125030000.0	108810000.0
+STOM	2047600000.0	2194800000.0	3056200000.0	2989300000.0
+RBKS	121110000.0	146550000.0	178560000.0	198220000.0
+NPLOC4	23630000.0	34367000.0	27489000.0	22626000.0
+IDE	6399000.0	0.0	14748000.0	13397000.0
+MBLAC2	88137000.0	86568000.0	81174000.0	68798000.0
+ENSBTAG00000038171	3519700.0	0.0	0.0	0.0
+FAHD2A	5571100000.0	5918600000.0	5208700000.0	4970800000.0
+TMED4	666600000.0	777420000.0	543140000.0	535360000.0
+SNX5	483730000.0	360640000.0	400850000.0	392090000.0
+TMED1	45074000.0	41812000.0	52257000.0	57954000.0
+CGN	133130000.0	5419300.0	44349000.0	45761000.0
+HNRNPR	220300000.0	232720000.0	219180000.0	268950000.0
+ENSBTAG00000035584	4798300.0	0.0	8169600.0	10749000.0
+TMED9	2893300000.0	3302600000.0	2770400000.0	2433800000.0
+AP2M1	174340000.0	208170000.0	246860000.0	254070000.0
+HNRNPK	2413900000.0	2438900000.0	1992700000.0	1777600000.0
+HNRNPL	463100000.0	534120000.0	464780000.0	478980000.0
+HNRNPM	291523900.0	312651000.0	334282000.0	364367000.0
+PML	56936000.0	27323000.0	38091000.0	34213000.0
+HNRNPC	776760000.0	834790000.0	1055900000.0	1076600000.0
+HNRNPD	1250100000.0	1148800000.0	1062700000.0	1007800000.0
+RPL27A	82969000.0	219440000.0	113470000.0	169980000.0
+HNRNPF	277060000.0	253410000.0	378080000.0	291820000.0
+TMEM205	68459000.0	195260000.0	191020000.0	126030000.0
+FMO1	5945400000.0	6490600000.0	9987500000.0	10148000000.0
+ENSBTAG00000038549	232750000.0	249300000.0	373940000.0	424670000.0
+RCC2	27806000.0	28080000.0	16173000.0	18826000.0
+PBLD	3249700000.0	3513100000.0	4686300000.0	4380100000.0
+EEF1B2	562230000.0	481700000.0	667050000.0	653720000.0
+ERP44	1348000000.0	1498600000.0	1297900000.0	1316400000.0
+GCAT	5382400000.0	4961300000.0	5530800000.0	6278300000.0
+STAU1	29957000.0	37825000.0	31143000.0	28898000.0
+FAAH	17439000.0	9643300.0	23832000.0	14821000.0
+VPS26C	113060000.0	116510000.0	122570000.0	133220000.0
+PSPH	407370000.0	442680000.0	374170000.0	435570000.0
+UGT1A1	1518800000.0	1368130000.0	1768610000.0	1982390000.0
+ENSBTAG00000002943	108960000.0	116710000.0	66086000.0	62555000.0
+PGPEP1	318030000.0	246580000.0	315110000.0	345340000.0
+GLUD1	29655000000.0	29556000000.0	31977000000.0	29422000000.0
+ENSBTAG00000037613	79423000.0	55485000.0	131260000.0	149400000.0
+TIMM29	105770000.0	93994000.0	102570000.0	136000000.0
+HSP90AA1	5334700000.0	1532400000.0	1907700000.0	2031200000.0
+TIMM23	112960000.0	93899000.0	151110000.0	108220000.0
+TIMM22	0.0	0.0	0.0	0.0
+TIMM21	64127000.0	57016000.0	38849000.0	31862000.0
+KARS	115320000.0	99866000.0	98437000.0	106740000.0
+HP1BP3	18219000.0	13844000.0	33875000.0	30816000.0
+NDUFS8	534330000.0	610750000.0	610280000.0	639950000.0
+CYP2D14	4334900000.0	3897300000.0	5847700000.0	7050300000.0
+TXNDC11	2247200.0	0.0	0.0	0.0
+CD58	23693000.0	25817000.0	72580000.0	44734000.0
+SCP2	5739600000.0	5868200000.0	6372300000.0	6054700000.0
+MSN	142050000.0	31677000.0	88961000.0	92443000.0
+ZNF326	5418500.0	0.0	20543000.0	21723000.0
+CACYBP	1195400000.0	1393100000.0	1200600000.0	913130000.0
+PDE2A	2195700.0	0.0	1515100.0	0.0
+OPLAH	65110000.0	8258800.0	59809000.0	82824000.0
+SEC31A	352840000.0	253140000.0	496690000.0	422670000.0
+PRRC1	173280000.0	144380000.0	105560000.0	97495000.0
+RAB35	184150000.0	210390000.0	210900000.0	146690000.0
+SRP54	16870000.0	0.0	17183000.0	0.0
+RAB32	199490000.0	188260000.0	351400000.0	358680000.0
+CAND1	143430000.0	0.0	113590000.0	111100000.0
+PRPS1	653600000.0	756410000.0	811960000.0	707820000.0
+DAO	333390000.0	272980000.0	483960000.0	495640000.0
+TATDN1	100810000.0	103650000.0	152670000.0	202680000.0
+ENSBTAG00000037509	3239100000.0	3031800000.0	5003900000.0	4721000000.0
+RPIA	529880000.0	493570000.0	486610000.0	396180000.0
+TTLL12	137580000.0	31001000.0	102560000.0	151130000.0
+LDHD	30163000.0	23224000.0	57165000.0	30997000.0
+GMPR2	1031600000.0	1196000000.0	1168800000.0	1186300000.0
+LDHA	14870000000.0	13195000000.0	7208500000.0	6815000000.0
+LDHB	90843000000.0	88904000000.0	60403000000.0	58145000000.0
+LDHC	536100000.0	426860000.0	448290000.0	374210000.0
+LONP2	43884000.0	15621000.0	38450000.0	34587000.0
+PLS3	741000000.0	726080000.0	702790000.0	743600000.0
+LONP1	553770000.0	100790000.0	301640000.0	541030000.0
+PRPS1L1	14452000.0	143990000.0	204130000.0	173310000.0
+PDIA6	5536300000.0	5153100000.0	5742700000.0	5418200000.0
+PDIA5	287100000.0	277620000.0	269670000.0	311580000.0
+PDIA4	3752300000.0	1290600000.0	1720300000.0	1680700000.0
+PDIA3	11361000000.0	11404000000.0	10557000000.0	10780000000.0
+GAPDHS	0.0	27573000.0	0.0	10917000.0
+CFL2	273520000.0	244060000.0	155080000.0	116930000.0
+CFL1	2096000000.0	1982600000.0	1271000000.0	1574900000.0
+PLAA	21632000.0	30059000.0	23076000.0	24565000.0
+BICD2	588990.0	0.0	0.0	0.0
+SEC22B	702980000.0	952600000.0	1044700000.0	1106500000.0
+NFIA	72864000.0	84889000.0	132520000.0	107650000.0
+CD163	11492000.0	0.0	11306000.0	5193400.0
+AARS	146460000.0	9450400.0	61691000.0	59180000.0
+PDCD6IP	385510000.0	34680000.0	144850000.0	133720000.0
+TSGA10	10537000.0	12086000.0	8208100.0	0.0
+DNM1L	11295000.0	18871000.0	21188000.0	19447000.0
+SERPINH1	65738000.0	86493000.0	87575000.0	75870000.0
+FOLR3	71727000.0	76916000.0	40142000.0	41058000.0
+C5orf51	101150000.0	94942000.0	112990000.0	90720000.0
+GSTK1	3823200000.0	3929400000.0	4085200000.0	4575800000.0
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/transcript_data.tabular	Fri Sep 14 12:22:13 2018 -0400
@@ -0,0 +1,2818 @@
+Gene	D03_01	D03_02	M14_01	M14_02
+ELANE	-0.08223053805901	0.128367421476871	0.168575604288361	0.179386061121957
+AGL	18.3503026568495	18.3971714903452	28.8550772364392	28.2897976837947
+AGK	4.96373192231441	4.0307358661387	4.69732878268058	5.64327232883133
+HSPA6	0.350288503153011	0.592013587104232	0.612568173305459	0.833794197245084
+HSPA5	413.409614153405	438.011930274678	197.673685843884	193.727515486021
+HSPA4	14.8468997976502	15.3061633055397	15.275973226593	14.7835817685183
+HSPA9	170.253077768686	169.323500684362	159.978594056721	161.35877481037
+HSPA8	486.867209766023	498.041303389437	352.185123018411	340.356699934716
+AGA	55.2930712045865	50.7686596245107	69.9129100715734	66.07384169934
+LGALS3	12.3566659422422	12.6797640900226	18.7284481408449	16.497115341329
+CSNK2A2	20.6258110499688	20.054472820524	18.5817134405737	18.3292680140834
+PMM2	21.8385112586243	23.0035148281517	16.003600132562	17.2109074501839
+PMM1	8.10344421010251	6.45300943797042	5.29673056867481	5.29511229568809
+ASS1	1516.70059430521	1464.12181445199	987.76849371654	994.644000920779
+SPR	29.8024212677962	31.4255886777817	31.79677566883	28.6670221909796
+RNF114	33.1294000243847	33.6664789344251	28.9252501819995	29.2816301523686
+UCHL3	24.423075481539	27.4024225580356	29.922955743965	26.0349789575326
+ENSBTAG00000047256	0.198684163979848	0.326976011762912	0.0965464670861903	0.195629128584535
+ABCD3	58.7883234930997	65.4050144271272	44.0781156389721	45.9473853318538
+SCLY	18.3455097325074	12.0439548297371	14.5431284057665	13.4342441387722
+DHX9	32.2266699445344	36.0820538117998	35.4491208799006	35.8446454974175
+OSGEP	29.0980770472159	32.8130489058944	28.7841249063531	29.9202928144102
+NUP98	21.4830493303323	21.235967445222	20.6724652583012	22.2449776146426
+PPP2R2B	31.8301859398506	30.1268425510797	23.5899320354255	24.1446221529343
+GOLIM4	77.5784923330104	79.4625370538813	112.276390607867	104.067050552795
+ENSBTAG00000039928	359.614982869772	382.125322623553	543.941055328692	546.030125904376
+OPA3	5.18347064997793	4.15589059496056	4.03566324685585	3.86302350820354
+OPA1	17.0182215598298	16.1769424590617	14.3846256512375	14.6461260137112
+PIK3C3	9.84397565598685	8.70006988836737	13.5221256093077	10.8636519932476
+GK	65.3713999987646	68.7043984462497	24.7873549302085	25.9121453607769
+PTRH2	17.909813910486	11.7471606497093	10.9263216383985	12.0202004570597
+HNRNPDL	37.5925704923559	41.1578984184042	54.6425179347757	52.9859134623444
+ENSBTAG00000024233	37.7416967628295	39.5317543165011	38.5879336019462	39.9028585669302
+TRAPPC3	17.0068732811101	16.3667538068817	15.7092710313949	15.4243816805198
+TRAPPC5	45.0403443110014	42.0513255117671	28.9286451423378	32.7199255117285
+ACLY	13.4740474442297	14.3387262055932	9.58029287059529	10.3337981947598
+CTBP2	5.99360085192578	4.51762221965351	4.98093076698102	6.42950200799512
+ITGA9	17.6306543365399	17.8886530469848	22.7476079210683	19.8507879088077
+ENSBTAG00000021558	21.1194017135072	17.7807242658146	20.1526593853834	18.2217376654255
+HACL1	246.657620535078	256.567529495172	229.415834596451	220.138080113882
+ITGA1	9.29786949411024	9.76396771663312	13.5013428589913	14.8294210742118
+NOP2	6.80838573089712	6.89524552209448	6.72211107944166	6.36046866759143
+ITGA6	11.8735075257508	12.6555131238251	15.482031234154	15.5906619691222
+PDCD10	18.7315219469136	22.601547803977	21.2323631686951	23.5166048769705
+ENSBTAG00000014423	145.95935840011	143.533614530968	183.076474422877	181.551319884355
+EDC4	5.52923753091842	5.7877027035443	5.23171974237195	5.96904629810924
+APOA4	1001.67305558535	942.744279140933	107.00083069641	106.440618749974
+APOA5	1029.86419861909	979.325280504821	674.842850735208	668.048257430335
+UFSP2	16.2749903128682	20.256738769108	18.7220238728349	15.9515918998196
+XPO1	16.485245004257	16.8668226905226	18.4411687253671	18.2090074546333
+CSDE1	88.2990636083208	94.874140787585	111.6583797805	112.40205326067
+XPO7	15.7401949501504	14.2091535237298	17.7515728413077	18.037145679691
+MRPL28	52.9893031681559	48.9584949101096	42.2163527456254	40.7325874477505
+TIPRL	20.3593806662543	18.8266323736025	22.1406027919464	23.9116420800724
+LSS	69.4405230982464	67.9177325717943	34.6165192487874	36.4756780332274
+PSMG2	24.3340985914468	23.1473288109428	20.1222558498083	19.2832537875864
+GHDC	18.4919529769017	17.5838035280669	18.9382753160037	18.0121064664024
+COL4A2	15.5642265337804	12.9203859487482	12.6604151875499	11.5741214026047
+COL4A1	18.7737518722348	17.9754153048966	14.7656650528014	14.1620652210673
+MOGAT1	29.214304014299	27.2106358144939	48.813385462078	45.6665374274383
+RBM12B	10.2220215777789	9.08546549239542	9.59408615710437	9.39417720968644
+GART	21.5436980575652	23.2984700656073	24.1828609787347	24.0004515765337
+GARS	10.4910364163667	9.58944697505935	9.87971225491647	9.63543758311674
+PSMD14	36.0575786878339	36.4148897543947	27.7902740804373	27.2684578677359
+ATAD1	25.413418725973	24.7301016946236	26.4360294340748	26.6545479857708
+PSMD10	13.5768391812326	9.3532359211042	10.8405613619929	12.2488783349383
+PSMD13	43.6839875293078	48.0199832997457	51.2565442656727	54.7745310242926
+PSMD12	32.3869688289328	35.9623944517067	34.9204575429278	32.647504142095
+ENSBTAG00000039321	112.259112376834	100.238484530008	58.6067447808408	59.3027474433137
+FTCD	309.573136539452	295.074871337398	274.566642289599	275.934257978524
+GIT1	5.98665615660445	4.13219088841018	4.31070407993306	4.07519319098542
+SERBP1	92.6844087711888	103.442915624876	117.427762984193	118.124478506835
+PPP4C	55.7197885548943	55.2493692622856	43.4455864375624	45.176077879304
+OCRL	10.3264092206792	10.9789449669842	11.959814900627	10.4136711254052
+GANAB	64.3122238655378	65.0695408590483	71.3203377582816	74.2726862141167
+NUP133	4.45902286123096	4.84535662254183	6.72438653093649	6.17882466580224
+LRPAP1	39.6607118298376	39.667324289904	29.5432412799297	27.3187118073329
+VAPB	33.8702904392001	30.2693811622097	31.4173326842444	29.2929310980619
+VAPA	76.1546605041493	81.3371215996031	81.6706014323395	82.1110532113614
+SHROOM1	21.4810018134023	18.4561566411643	21.5571482143965	20.697368126951
+NDUFAF6	27.2882339620369	25.4094168879516	28.2550995885815	29.2385834162002
+MTIF3	33.0636275228121	29.8367202861899	27.5634090338781	27.5477833560371
+MIOS	4.26591122111643	5.21359359064982	7.12579399384903	6.83589766649823
+SNTB2	3.44676097069901	3.3371843145823	2.52823542190094	3.34353582107334
+IGF2R	20.3869302286559	18.4169743231909	21.5848513751896	21.119359211056
+CTH	23.7452527235334	28.0730838392641	20.5257484503605	17.8868290710971
+ARL6IP1	366.492111230662	413.904559500269	341.945846819416	344.091482581901
+SPART	22.0039686136008	22.2710603819198	24.2563861964032	24.3687278917066
+ABHD14B	139.93182580896	142.076678793288	138.017203335669	141.447561047386
+NECAP2	32.342511082654	29.1683949165178	30.9004923222674	31.8135482422216
+ARF4	177.906467824909	185.11386912031	120.919332619611	117.322225614047
+FAHD1	23.4790229313779	26.3252143975123	23.2631431801679	22.2514583136608
+ENSBTAG00000009622	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+AP3D1	35.3786363820956	34.5749292219143	29.8908508467828	31.2156269399088
+EIF4B	154.524576676941	153.28152421075	176.12154082364	184.124226128935
+ZSWIM2	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+ENOPH1	15.4055430899225	13.8419843115498	21.5808205115286	20.7971877299735
+SULT1A1	845.575240323372	814.50990400149	782.934194000434	785.782825518319
+TCEA1	53.5643588897778	55.7535934144872	43.8579071646478	50.0118717755338
+COX4I1	309.919683480587	291.014671463711	253.02526267569	246.837605760305
+PRKAR1A	75.0317104266905	75.6797180159207	67.6452882356599	68.086861744805
+MOB2	8.34698503488294	7.88178344525066	6.28178957023459	7.79647994110156
+SAR1A	56.7295062911519	51.4765112093329	59.5206613514234	58.4317153725386
+SAR1B	70.3457473197658	74.2411191917892	93.6695949365961	85.9996902150374
+NIPSNAP2	22.2409279443414	23.6675529379508	23.7958240572163	22.2304188233296
+NIPSNAP1	261.760193663487	257.808857903779	282.981075524417	283.129564822466
+PIPOX	59.2527204027095	55.7123593473811	72.0030323551228	71.040024233988
+GAA	22.8247118216386	22.3220096464427	15.5252186804416	14.2809388207976
+FGL1	2555.98920665391	2628.44831974902	3284.2932551994	3274.6102441295
+METTL27	18.1913067140135	16.5254690880281	11.3830492437096	12.7694618928597
+METTL26	35.165014623508	30.6060665296889	47.0401804068985	40.6256404639011
+SPP2	1784.99498394807	1798.12910993085	2319.1080452268	2301.08216805348
+DDAH1	38.9178538545167	41.0705326162855	44.3938943848196	44.8720457230236
+SPHK2	19.9238628097942	19.8335687969203	10.0651876263558	10.735626778193
+IFIH1	7.03896789737137	7.08042454247708	9.70047174052227	9.63188806787781
+DPT	14.684224587926	15.1690900417726	1.65584269235146	1.53089191181918
+IPO11	9.78747564766886	8.42943393013128	10.7166326702021	10.3850789048885
+EEF1A1	3529.66359717918	3775.55204622843	4257.79444312061	4202.71665392599
+HMGB1	127.814223095732	126.102728522203	134.537795502212	126.782452387701
+NADSYN1	34.8115709446594	30.9374810391975	30.0315749194893	28.6156343632691
+FYCO1	11.8833517675312	10.3416387364826	18.146604971577	15.4921469995441
+RAB2A	62.5509676241328	66.9966912236371	56.0323977714773	53.3226922315867
+RAB2B	5.51549912033921	6.47597494872138	8.00535272209009	7.39671182238791
+SRBD1	8.31459314631765	5.40203128694332	10.8599607699136	8.8923374959611
+ABAT	93.6090018664263	94.0604435927781	85.0992264753205	85.9840040189955
+ARHGEF2	16.1006521844568	15.7284670256871	12.4995761183079	12.7035062890944
+NFX1	20.6905826175321	21.5102719233328	20.3686983067127	21.4631053285698
+WDR45B	11.6549980415905	11.1523722350841	10.0822519746743	9.82223941788683
+DPYD	125.826066238406	130.930045213624	107.686919723906	108.256599018326
+AASS	7.8914461669373	8.13970359677149	6.73944044936138	6.3483393338133
+RDH5	1.79251889795048	2.72783739942013	2.69293715060828	2.81803975238425
+PEX14	42.3812981701585	43.4688919742291	31.9647855676644	29.6196348337707
+DPYS	415.526138098317	428.867293349806	495.757493643467	493.853439305384
+CLIP1	12.9868704613915	13.4886510950039	17.5827108973963	18.3290029094934
+ERAP2	17.4247579503051	16.6562757190611	20.5361587574596	21.8824164306055
+TIMM50	29.3492678861377	27.4006185258684	26.1342457867284	23.4351295484163
+ENSBTAG00000047529	149.495513086567	139.342071872203	24.1801671225914	22.7082887605049
+DHRS7B	18.1950043251175	18.4823562687571	13.6463389222502	15.6253624250419
+CD46	65.3726198053503	74.270239910639	101.054275282023	97.1873411657754
+DMTN	5.92399265481323	4.4561329283421	6.08392838520068	5.16829312410744
+HIKESHI	96.2207036892234	100.160285992896	68.7098155791241	71.5239930710969
+FPGT	14.3094893013407	14.6812299826117	17.8287642243643	17.8191309005061
+RAB21	27.7472527702365	24.9532945239171	34.0969791040787	29.8855752260238
+CFH	767.294507242946	818.173178670704	1041.15753075284	1048.53215116834
+PNP	332.470624222216	335.399776703518	341.594319111974	337.879549287364
+CALR	547.808827828665	544.550148715678	311.993698451087	314.830818784292
+CYB5A	1279.71947937063	1386.20747777369	1278.94847592941	1279.56595705498
+CYB5B	118.775991716626	123.256467544453	65.7720989249889	73.6310240206118
+NGP	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+PIK3CB	3.8517453800314	4.46490589534062	4.02996405177878	4.5529561992062
+HNRNPUL2	47.4234424954677	47.1056769107593	44.4535735677995	42.2584653992133
+ACTR1A	21.7299478723611	21.7936385705149	16.1674085490479	15.4133085835672
+PNN	36.4129816672753	36.2587500070935	32.7810351218855	34.661968292265
+CHID1	66.5172347638444	64.0181074125876	57.9733031916989	55.3420779019853
+EWSR1	54.1683946610428	53.0021535902792	53.9936184091863	59.0360940996303
+PCK2	251.203985954915	243.616925385796	140.766920970437	142.830793766762
+RPN1	116.718849259482	108.288455429388	75.0381777229905	78.0666545276412
+TRIM13	10.3084486149378	12.5857697617364	13.6427168919822	13.6854569313284
+PCK1	1265.75686610038	1236.34525852274	1406.69713146692	1419.48730399179
+NTAN1	62.8797536647571	69.1947937594922	100.707922686855	108.831439179798
+NQO2	222.62209856547	190.96696710527	137.944437885814	131.294377867393
+NQO1	32.7668453881373	37.6680611198006	30.5202232334309	32.367387170966
+PRPF8	45.536241120716	44.7936380566713	48.1251730294754	49.1573339523372
+CYP4F2	137.317057716928	138.703061951477	75.4866875958729	73.1834721663011
+PRPF6	16.7526636813592	15.2311379981886	15.7555916952368	15.0976180464327
+SAO	1073.73742208767	1021.88943986436	830.50559434436	833.477853092995
+CD177	1.1064766601143	0.953317941290519	0.341218021933693	0.153610807026454
+ESRP2	50.3155261869543	44.619485168079	47.1721194966727	46.0241969281125
+CNPY4	10.0073895725895	11.7091870323942	9.79011112829774	10.0635723357581
+CNPY3	45.6062009119591	54.6688278769568	42.3361904744904	43.2902187714202
+CNPY2	52.6939452099784	57.3174560133973	64.3741910437105	57.026286264242
+UFD1	37.490492039711	35.9029843625734	38.4924783278795	39.7174601812313
+HDGF	132.114229179939	119.157426899464	93.5406149231975	100.903906100436
+PIP4K2A	9.94077180962714	9.9601190548232	12.273037893579	13.5319122184368
+PIP4K2B	11.3854163174358	10.1401622345344	12.1726641243729	12.8141966973479
+ARG1	398.397801204718	416.700438067688	177.985789305031	181.145073922015
+MRPL39	17.6479220239243	18.7867561846128	26.0920872201995	23.3437776703563
+PPP2R5A	83.2787384234597	78.7383482087907	91.5819522630186	95.6081897061122
+TBL2	17.6044406984494	16.6717367518503	15.8876868352769	16.6080879411354
+THOC6	3.154741233258	5.01941914482926	3.22597627195503	3.49366554248318
+THOC5	17.0476717492872	16.4936245013996	13.6715969398354	14.2331407939343
+FAM45A	10.3567182569904	11.7069399026618	15.1140708030144	13.1451402101531
+CSAD	121.646520077837	127.750510244592	36.8610759318546	33.9018548891293
+MGC127055	224.575619797312	200.27769415398	317.239513685238	327.427273286726
+HSD3B7	97.2473056730277	87.8609258855866	141.355082856094	132.414109745301
+UQCRFS1	141.454214766287	131.924019658601	110.639769549328	104.86438684157
+ABCE1	15.8248475055053	21.8172616033683	23.4067588945618	21.8118736662113
+UQCRC2	152.230541812823	166.808493235143	126.328662289673	122.994402255727
+XPNPEP1	41.8807649441074	40.6081698661029	18.3535845813194	18.7479346711993
+XPNPEP2	5.30103159227074	5.77207117987478	19.7709539960855	19.8714798966939
+UQCRC1	134.568480174264	126.131237251667	101.775599208664	105.169742148037
+NUP88	16.5887334626008	14.9994854494616	16.8870822233886	17.9216378091807
+COPS8	25.6815415038193	32.1308773946308	32.3689295868065	33.0426964241527
+DDX42	11.9558286042061	13.3755349689871	16.0180555442053	15.028408310974
+RETSAT	111.198575750054	108.234565332469	64.7740124709037	66.3199179023973
+NSDHL	196.206497037071	194.996329006316	95.4511145003505	97.6093615840869
+COPS2	21.8874445010306	21.1471225994447	29.8896354760515	24.9366705753889
+COPS3	36.792558084955	36.012224070399	31.1814705079747	29.7691487172069
+PGAM1	128.197182074873	132.744999071466	115.951538425384	114.043264474737
+KHDRBS1	24.8612093702586	22.7117760447553	27.1193193660084	28.2779244387664
+NUBPL	7.26094544277042	6.27516525710021	11.0926766737667	9.12658370376235
+COPS5	46.7385780403867	44.573471003325	51.450706832298	54.5550979617182
+PPOX	24.4384475237034	22.4650265394009	19.5511294975975	23.1051027157849
+ENSBTAG00000034189	1535.26272411505	1549.7627784892	2220.81535301455	2192.62982443271
+ENSBTAG00000014988	-0.0852424485972669	0.392672184418438	0.229878939571751	0.0160375845066772
+DDX46	13.8211747463843	14.5697069189569	18.310272049786	19.4926863517895
+TKT	90.1527255282997	90.3228079129476	51.1029230044274	58.7600337132427
+TNS3	19.7983720525298	19.2669361780051	26.6583681920854	26.5576747555308
+TNS2	46.3766710579474	40.7834279771236	54.7358598374475	53.3126451539783
+SDF2L1	48.1891283121328	42.0367507494488	21.0318787819253	23.7945977876345
+FDFT1	230.460887232816	245.947318190569	120.763143974621	117.130536954793
+NLN	7.07532998105508	8.54557900985034	13.2274088682484	13.4171960452136
+NUDT8	37.5210877453456	36.0080104212579	41.1581288265437	36.2502195018032
+NUDT9	35.8336134386665	33.3809334485037	49.4797898626705	47.8603339788615
+TARS2	20.2575343976251	17.3790267157561	20.2433971353388	21.5236047391908
+DPYSL2	10.1053007008949	8.85930993697005	11.1086266678461	11.565168833617
+HEXA	38.877016564319	37.7314453646721	52.6980753830058	52.0258756258857
+DLD	45.4312031551119	49.910499454934	54.0517288521742	52.6710590402174
+NUDT1	18.8793782493198	18.8527260787607	12.3038809833938	13.2866843020744
+NAXE	59.3073261395044	55.1293928443162	61.2054448772134	60.3812186171541
+NAXD	57.8955362638437	43.6320101574989	46.991284295244	47.7596406263779
+NUDT5	16.1507454793259	14.6942379912549	20.0543101479719	19.8748659218738
+TK2	33.9979320424689	33.0844481516052	26.6390511054135	32.643749648284
+IGFBP7	96.1715883245993	96.9849127734383	73.8446854539096	80.1413700430556
+EPS8L2	63.1318290081556	61.3573800230007	51.7789907957507	51.8770051707783
+LARS	11.2227190970869	11.5871577365339	12.621647507795	13.8301461988261
+PROZ	116.809886640552	104.858776046389	117.957069400365	117.529049770823
+CYP8B1	412.065295525826	424.999207684934	464.440371255463	456.332400512045
+ATP5F1A	465.782327739059	489.329449302093	369.486001185207	367.713507433185
+ATP5F1B	513.546065335708	528.33262563355	387.362696330798	388.315109609166
+ATP5F1C	165.22570160091	163.302687551094	132.846351531124	127.31907389261
+CYP27A1	330.369783913126	310.29234287436	349.399104678752	343.446147391654
+BTD	33.3813845062862	32.2538602523885	29.7869780486328	27.5510469622459
+NUBP1	11.4048602470467	12.7382574393044	11.1785894349288	9.95118941684435
+SERPINA3-8	168.417714809174	167.970507408395	156.311118422826	158.396478705801
+DDRGK1	73.1256519539238	69.6134279072901	89.4499144554201	87.6467582491982
+GAS2	24.1141839058607	21.6921538411643	25.4995596647139	28.9163000443201
+PROC	257.135492596388	250.759657656163	324.180045008162	321.635705884631
+SSB	29.7339194164135	31.537381503401	32.3697689830767	34.1734894040076
+EPHX1	1282.64070174471	1231.31335477416	1096.1264487374	1106.882416371
+EPHX2	267.254769439827	282.304537311901	291.384664316726	285.555257100128
+AMPD2	24.8937745496354	27.0386591397879	17.7872665597086	23.1796002540168
+EIF2B4	26.4887557965806	25.9363758016864	20.2133086701299	21.7163785368209
+RPLP0	829.702612336098	775.436256693867	651.772908433284	654.881810999245
+EIF2B2	10.8182510719445	11.8213317939747	10.8812350114344	10.4730454873175
+EIF2B3	10.3371570078383	8.67245257243822	10.0647106581741	10.039083091741
+UGT2A1	90.3836856244171	96.8452690777283	116.226869137167	110.28527355416
+EIF2B1	13.1418240517451	14.3039936928032	16.5197542513587	15.0508416887651
+PRKAR2A	27.3648052251888	33.660829367772	28.2743970133358	33.3601940269362
+ENSBTAG00000030882	887.671080444981	876.251886680296	1050.08995355016	1034.351777053
+PPA1	68.8539061719247	72.9347408623078	58.5251629497892	59.3975783114507
+QPRT	223.497888592996	214.633721536292	164.112700149496	168.873988656332
+MLF2	280.835430305601	275.532928515868	234.282285768835	236.378832310805
+ALCAM	24.8530471583304	24.6458417152982	43.2278910081907	42.4831972700685
+TPM4	59.7755367612895	59.504108592511	37.4316111803736	39.2393780376755
+TPM3	80.2482524202322	83.3926516833143	96.460478502711	94.7942037798843
+SNRPA1	21.8486546659052	18.7731575446815	22.3599041797701	19.9420938776355
+TRADD	7.91439177282105	8.05320345058496	6.32019055753322	6.95827046996287
+ETF1	28.0226903934314	28.5075331727821	28.5133031292269	29.5491157617827
+THYN1	125.76550872745	114.034631077185	102.274550689111	104.261178066886
+PRELP	2.26786018926251	1.96606581443142	1.68936641506156	1.76613680814355
+TAGLN	32.099452031918	29.1484424074593	17.5917391803785	16.509390173962
+ETFA	135.141449569574	144.963441695701	130.672574708148	128.225900224345
+PHACTR4	12.5339579904123	14.7522133671977	14.3461622879086	15.0294524007617
+CLIC4	61.8332679529114	64.5166939843832	75.2674611554502	74.2803060751161
+ETFB	209.264228536475	184.991100348228	147.803507966251	144.773413999346
+CLIC2	5.6385595704383	6.55771019944208	7.04816461542892	5.77086834430778
+CLIC1	43.1533587140058	39.9599256941446	36.5331332537157	33.6665460706112
+UGDH	253.02867864416	267.054638155161	212.601167110265	208.290026972686
+SEPHS2	113.476159128145	98.4335183950974	112.942581584812	105.587424112673
+SEPHS1	20.1668788705997	20.0841930429626	12.9833468848857	13.05437399181
+TPMT	37.3539008448681	45.7663089123757	42.2498608667885	44.6219886398567
+ASGR1	574.26165428167	551.397362864625	661.028892970386	668.74644494183
+ASGR2	1498.2023349371	1458.93747322725	653.20127456486	671.437605289062
+TMEM141	6.77638454057323	6.36358018083691	5.34501016871541	5.34043028569703
+DDX19A	10.2264421918185	11.6017514367502	10.9392637149186	12.2002611418184
+RPS4X	370.606210921147	387.615158508429	325.94457278781	295.398196414374
+ENSBTAG00000001219	27.5002915548413	24.1254709605611	29.9956228010897	27.7050791539923
+CASP3	13.6407386113878	12.1131758151392	15.3737406004101	14.7632148560478
+TJP2	23.5471811946994	22.9414444173909	22.2199156676969	22.4503687582357
+API5	24.5120470652308	23.7286927168825	32.7844671733315	34.1936237246548
+TJP1	12.6864601144569	11.5936059129246	12.6392826035758	11.8325757102949
+DLST	52.934832417484	51.1588093239547	46.7562965795153	48.2045508515671
+TCP1	112.131202207662	110.910440071749	97.4706808780156	90.2564541447596
+PPAT	12.9663599130648	13.4127577044066	16.5679134408528	15.7026652137807
+XAB2	10.850398910469	7.45428243618544	8.60682146979172	8.74181328016818
+KTN1	13.5917939719345	13.2862990084361	14.2256517291323	13.303763734422
+ST6GAL1	165.229264975642	179.239983837993	124.694954568808	127.499990199542
+PRDX6	134.230883044861	133.103972206919	177.160396297109	173.982741992254
+PRDX5	141.574940423992	137.725992770752	131.031605344666	137.814420150429
+PRDX4	87.8696821185557	95.0781960700951	64.7507646532726	73.9173233612039
+PRDX3	226.183756366869	236.922452938662	211.134649736436	212.569740450738
+PRDX2	26.5557760752879	28.1974369071007	17.0004894733476	16.2288890611705
+PRDX1	74.3912473879908	70.3300111920131	72.9684635138833	77.3066978965897
+CLGN	-0.0769494798646383	0.134583609833271	-0.00515264632226811	0.0623934897114842
+SMARCA2	20.3593132759385	18.7902611833367	30.6744398451897	29.688136681472
+OTUB1	25.8982325862306	30.0692658747372	34.5873136404171	32.7595878205512
+RABL3	16.9469843721439	19.6807527614847	17.8762456131016	17.4418933997269
+PLPBP	23.8636810065543	22.0581080082221	20.8171521244186	19.6413481588875
+PDK1	13.3819325431579	16.2490439405129	20.5817877798094	17.1517929071161
+CD93	15.9086560245681	14.7094557809897	13.0258049347392	12.7060245724838
+CAMP	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+POR	135.154827598721	108.541471373971	133.848368946207	137.090730361401
+ENSBTAG00000009760	6.46415271214865	8.26146386647607	17.1078553775569	17.9350562212556
+MPRIP	18.861432035832	15.5098865277044	15.3997932307497	14.833519534604
+TOR1A	33.4847560379608	33.0946703435662	26.5562010236844	29.1095049016675
+HNRNPA3	102.155542447621	105.978780204414	108.356531149615	104.728720082175
+KANK2	13.4497827047211	10.8610886777587	9.67268601983471	9.31600165426222
+SULT2A1	544.420560738779	587.138429835008	600.605989642546	619.620066264069
+RAB1B	64.8001697709825	61.6704468875612	74.4870293049082	73.5811598080436
+RAC2	15.1528799674561	16.6120161683308	21.5805335239663	22.9098008728685
+RAC1	144.871933193455	133.76419069935	110.544995623283	117.714557016536
+SBDS	52.3300951995314	58.8510105177794	71.2287538949878	68.4988115280331
+KANK1	38.7083668936645	39.0613346432396	59.8783082517713	58.0948282444095
+VCL	12.9864940162902	12.5103186763001	8.93598455816918	8.95075998339195
+OSTC	84.8346216299972	84.4508821875817	91.1304891053569	91.8217268065564
+VCP	140.535918088026	143.476321536453	125.127227850425	128.982120434154
+OLA1	25.1824643374335	25.931751376637	25.0604072981031	22.7585162618521
+AP2A1	22.0182379500007	21.5486712028007	15.2611711684692	13.934489196156
+AP2A2	27.1697890312162	26.4417489134357	21.7610471693701	22.1951339983571
+LYPLAL1	3.34899680322929	4.66833172405662	6.12858842111593	5.23066328320325
+CYP7B1	23.1360768551171	22.4690579382223	62.0391905328311	58.145626153812
+MYH7B	0.16456422572363	0.254542260320269	0.0230733681785335	0.0140036826877487
+DPH5	8.92866530606837	9.44685179381996	10.110233626372	9.48675065538081
+C3H1orf50	37.1672354579663	31.0344286542843	30.3352622287305	35.0610534192782
+BCKDHA	33.3347140933374	30.3699155604248	32.5880478602026	30.0470161238574
+TARS	58.3346523760796	61.3452927342599	60.1174891333598	62.5639925423971
+TIMM44	12.7707734182071	13.2493063107241	10.3639663791509	9.05734653636706
+TUFM	68.8048800326677	66.3901386072852	55.2240841678637	55.9380345267129
+LAMP1	570.166468356905	531.539077614722	550.370817248693	549.20043514358
+LYVE1	42.332090907862	44.7807626316673	59.3734080880618	58.0638912714492
+CKB	15.6671458050596	19.9648955893968	17.7557976420411	17.0109074209085
+PTGS1	7.48905023674876	7.64979664168315	13.8381202850499	13.9880384661815
+ERGIC1	49.6443473408582	55.4931623743165	43.2607031334041	40.8211731904949
+TXNDC9	18.0969611430883	21.8941370380688	23.7607006653692	24.2262949098011
+CLEC14A	10.6122879481349	11.0813991506722	12.3059657369904	9.95524992723328
+PAH	1044.11626930845	1049.80153097312	1359.04203448889	1350.35018648269
+TXNDC5	77.5284698782203	67.8020339385372	55.0017892229316	51.0694326103712
+CPPED1	43.1981228276528	40.9683829313164	49.7615116871596	47.3353298793024
+DCN	59.5307921342537	59.4208950657746	54.7991865479456	54.9461564976765
+GPS1	24.7958745262074	26.0022920374557	25.6580994092983	25.1252546804033
+CALM3	35.0709614614792	32.6332399605844	24.2324170704281	23.7202940680336
+SPG21	46.4223372009773	51.4042757420462	48.533670026875	49.4211358539337
+ACSM1	827.562355463645	844.15943074068	928.901400582796	929.387840748824
+ACSM3	169.150483252366	182.11344091291	262.814704088015	260.952011118048
+ACSM5	20.046581368137	22.4926241797368	34.3780747297027	35.465762332379
+MGC127133	8.86111406835099	8.50752222605345	7.02451247034377	6.02444418176124
+CYP51A1	157.12698521429	165.206017985066	68.7660597227103	70.491810220329
+ATP6V0D2	1.2341975788172	0.877167935857445	0.777383419071078	1.27526958392675
+ATP6V0D1	65.8683638418193	55.3304641920697	45.5815637735467	53.4373602438446
+WDR61	35.1110800682472	37.6202389497737	39.2644006433297	39.259368680735
+ENSBTAG00000022570	19.0019095044803	19.2707444121756	39.4668053612846	37.8408914025013
+CUL1	16.1500566401071	17.438451527384	17.4691912519176	16.5805214948805
+CUL2	8.13870687807213	7.98038561274466	10.6627483654666	9.10580856651355
+PSMG1	28.2621158656397	25.8711204741751	29.1648864546432	31.4253545205057
+TTN	-0.0523068519948276	0.166094765457831	0.0224945492390797	0.0391090796486431
+ENSBTAG00000038058	55.9058490183006	54.7538130787994	71.4213192687985	72.0976616658343
+SLC25A3	132.951249188516	134.078827981023	113.992097344352	124.128902179982
+TRIM25	30.7042091635934	35.5036670406055	39.1545231540834	41.2647931983878
+SLC25A1	311.615151485823	291.250873522062	179.304384821911	175.465855438779
+PRMT1	37.9333215497911	37.3828617282321	30.2560508678175	30.4004632500649
+SLC25A6	285.342697198011	252.86427745884	191.315006725148	190.951625186782
+SLC25A5	37.5835112064881	40.7882634457076	24.8334313386296	24.3137005206595
+SLC25A4	198.579965337122	203.687381210991	159.823810749347	153.543858264709
+HMGCR	127.264561169596	127.317153095414	49.6285053841519	50.0187086639129
+LZTFL1	14.9220708084475	13.5434796682992	17.9301984441499	21.2681592038123
+DNAJA2	47.6871913084575	56.6977738539339	69.131122034082	63.159470565716
+DNAJA3	51.3205333889838	49.436641338831	42.2481062572819	44.0364892819402
+DNAJA1	120.318868007511	127.170136462854	118.337994014837	116.922400151691
+RBM47	15.0297379298076	13.162524735772	10.5656005250471	10.6984404424176
+PTPN12	21.8950094956548	25.1566975935055	29.7641231071949	28.9249195900597
+KIF5B	21.3824382590587	20.6115864462121	21.6553260044545	20.7240378178645
+KIF5C	-0.0242909356493393	0.169992433972603	0.177050708567648	0.0828988899603681
+MASP1	31.5939174041741	32.4197437525564	52.9779224202884	51.6513474135442
+ARCN1	68.1819355685582	69.1212495370072	54.438343452279	58.3613437871432
+UTRN	10.4992129523934	11.0711887799641	13.2795767305464	13.1166368811989
+GLT1D1	82.129491077376	79.3352312187318	73.8723339790502	76.2114824680646
+TTC19	13.0523861886925	13.1435830833606	13.5480758176078	12.157710960407
+DMGDH	117.708296045597	118.203564915098	122.923367633367	121.162722874162
+ACADS	464.557981988281	431.75966394129	432.015623447996	427.665527364402
+MRPL21	16.958495295684	11.0579595157229	12.7933224431094	11.5197658017626
+MRPL23	734.304345916776	673.026586156728	555.080627196372	541.114736674224
+GBA	30.3706492397304	28.1343923107183	29.4137112184891	28.0771909890332
+DNAJC25	35.0149401389874	29.5731279565976	22.0094234922849	26.876907639099
+HSPG2	5.4379276412408	5.00249535538277	3.3669523301715	3.73500814553961
+GAPDH	1388.95241503039	1321.86291368768	1087.51002915168	1094.95667893931
+DTD1	10.1199929505268	9.2462312441433	12.0344244167317	13.3523667738941
+ARHGAP4	3.72390784167576	3.55214653303536	4.76327926806366	5.52365956803669
+SEC16A	21.692720742859	19.7828680658911	19.9199433914636	18.6485118941923
+NDRG2	426.327078699551	410.40205785834	497.313623224112	490.962109473413
+ACADL	57.6279348342202	67.5778634275052	95.9954844887053	95.8119751265253
+ARHGAP1	29.8561055019898	29.2929024991071	37.5299987228663	35.604027743373
+PPM1F	6.42492807046245	4.91214727386321	4.36698752034975	5.17614871366705
+SRSF7	54.7788221666939	56.8900583028954	61.8211680104577	69.2906695422771
+THEM4	77.1971225485442	77.5783332904371	64.5196052585858	61.89233436228
+SRSF1	66.9472197454219	69.1564120567732	83.030324222926	86.3644350673638
+PPM1B	34.3770553355863	29.2984634431719	30.1595835863183	30.2870463812903
+PPM1A	48.3342136581773	51.2964857165377	50.3193760686842	51.8230601237334
+SRSF2	99.3912241150377	101.825089167873	100.848799151579	100.454372164283
+C4BPA	868.398291213353	925.42956307545	1305.18147323815	1302.42096015856
+USP47	18.6962658261789	19.9728302203766	17.2957059687319	17.5946707265597
+ENSBTAG00000022205	126.374436751481	134.518955654307	76.69362825283	72.799247093856
+DNAJB11	39.1649196354961	36.0327537875175	21.5198294338515	21.669850226013
+ENSBTAG00000008564	48.6573800792927	53.6086465645478	126.695465233359	116.944280508725
+PPP6C	16.8918471797716	19.1847040052265	22.8877714004926	24.2718321671767
+ZYX	37.0754172798721	33.6719648011908	34.2737308688148	34.8908231116317
+ANXA11	22.2285017038063	19.5587233692368	23.6541673795234	22.7619091734793
+ANXA13	203.750699406579	210.824271781609	217.552515373933	220.471809140069
+CISD1	79.7726256101505	82.3486714046288	77.5615370611229	77.7433182222355
+UMPS	20.2532185334857	21.7589611812923	20.3611960851864	22.180822702914
+MRPL4	33.9667821111815	28.6032657931341	25.7553356077485	24.6127827036147
+ENSBTAG00000025760	39.0288028673365	39.5129247484177	69.4692472890008	67.3034185131852
+MRPL3	41.8840875012297	45.4245593859166	49.9878059987069	50.6518660135045
+SCRN2	13.8925265228457	13.9674148118253	13.8460621137794	14.6772212926173
+PTPN6	21.4100404840134	17.3855930881567	29.6525937791027	25.3892490370881
+ATP5PO	166.719207918648	185.498918508729	176.716666098354	178.619746289059
+BTF3	243.995919849111	252.095720967703	284.066063535482	287.484576295899
+ACAD8	141.472729413469	134.247959479837	179.943110069442	178.434124784149
+ACAD9	9.68817867241119	8.23908175008195	8.61084073155634	10.1843126422223
+CYP2E1	1835.04753204953	1868.54273657555	4069.21205714596	4053.379533667
+NPTXR	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+BAG2	5.93602412871786	6.30944260256545	6.69200528766228	7.88794945830727
+BAG6	45.6395495523408	43.288093577168	40.7841212593621	41.4937906793189
+EPS15L1	6.10039041661555	6.4041975308741	6.69931766909498	5.71988267777854
+MYO1F	4.95963818654873	4.92318392277188	5.58176887805038	6.18702651041897
+MYO1E	7.00806366858247	8.26899307209221	5.392979257911	5.4982026878874
+MYO1C	22.6463084693309	20.5654786032694	20.9596580307528	18.8457486692894
+MYO1B	80.7786173329754	84.2432126293212	107.943262689484	105.090572404892
+MSRB3	67.4087793862751	61.6353320153419	92.8777023295648	87.4701387694682
+RPS7	702.574737317351	702.6101852007	606.073466384682	599.981479430538
+RPS5	729.993028498007	661.630845988332	636.758990856548	639.055300954126
+RPS3	740.606356649539	757.051364220655	699.041867308351	703.615112817368
+RPS2	1617.52103347076	1511.45299461047	1244.96296604917	1259.56387051812
+ARRB1	5.12630579483302	6.65033958064044	9.96834669593266	11.77031853134
+VDAC3	116.347937195268	117.532880125573	104.938248399075	102.016541403382
+VDAC2	68.6394348764366	74.5765253938946	68.6581588388352	71.7976393942272
+VDAC1	145.519667261676	139.54561575613	137.291461498404	134.064338702345
+CHMP6	13.5824165437818	10.5857283177606	11.4149421044129	11.8651864589396
+RPS9	545.61997769218	508.405120927999	470.016153240504	470.448297127517
+RPS8	1210.9805966132	1188.96587338987	1058.99936402095	1037.43707172544
+ADI1	1024.10879625059	979.475443500323	933.674997711211	915.325207630376
+ATXN1L	5.00185845487956	5.6911188377407	7.72628385398004	7.37544352127196
+GMFB	13.5416729683807	15.7850612256572	19.0944806509045	18.5023618884103
+GPNMB	115.227329549535	123.110192544982	140.43168999246	144.10209504583
+HPF1	31.3007478467807	30.1136885205977	28.2504400771294	26.0033304925835
+PSMA2	80.1726068467046	86.2428600372228	69.7787284706752	72.5406843005262
+PSMA3	109.596445113318	112.32916615502	99.912943180605	101.92405326643
+PSMA1	82.8517588406072	85.0509263181308	82.2619607008741	78.2731237892882
+PSMA6	105.204411361905	119.895956636583	120.850368223614	113.396953794034
+PSMA7	178.312753646554	191.452163133474	151.221512915762	140.850146658638
+PSMA4	55.4410212462756	51.9305655113369	54.3587417167831	50.3525738926555
+PSMA5	80.2610098308323	95.2927793486028	77.0145836865966	67.1797233436214
+DSG2	16.2514502586404	16.4530862110991	20.7457687358425	21.8495010297568
+C2	251.183988483194	254.183673445657	318.265328258274	324.379805688705
+C6	365.2297364725	381.977668759816	504.921962589699	500.435083961504
+ENSBTAG00000038540	174.507427025873	187.684541479802	242.317963001166	230.188467846836
+GALT	64.1494282539513	58.1175836329367	35.8603128146891	30.9725208563217
+HMGCS1	430.110003956077	457.274349744887	142.879224865808	145.95583101321
+HMGCS2	1360.09145336772	1369.05777240643	1515.46275306298	1508.59412842439
+PDHA1	79.3779390001048	76.9297402192079	70.9829275790784	69.4563416095573
+COL4A3BP	17.6908668270604	19.0816902109071	28.3390494204734	30.0991661700921
+SEC23A	29.4797222398034	30.363061553092	28.0021646615805	28.0625393454352
+MGLL	197.373426947179	192.357953825692	161.897896688479	148.514338289689
+SRI	42.361949627163	54.9492167630345	60.3190209314406	65.2848217739431
+SORD	270.205064622654	291.44179011057	343.773034246005	346.803105495147
+GALE	52.6608093618216	51.7787787717443	26.3245360872852	26.2208112485834
+LGALS9	38.7022804674686	34.8558668050426	46.3471977609061	48.5793347499184
+LGALS8	57.5592907932021	52.0369600285485	93.4088235212831	91.1536627271034
+CS	10.1553166109125	12.0959777206	10.9170984919873	10.980623291111
+GALM	159.28871029902	160.68727047157	173.218108815731	174.612673780475
+FSCN1	7.50009095130913	7.91587165290409	6.57361944414281	6.76110084736322
+CYP4F22	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+TDH	204.570701636635	203.1282449823	172.739337406203	178.227512026039
+MYL12B	70.684251328703	69.8407253743907	32.4624943736742	36.4290588686268
+RPSA	931.756812751619	870.143028498824	721.346801452542	718.154569601894
+TSTA3	63.276318109181	55.4154415978116	37.5639238076934	38.4851534115615
+EIF2AK2	16.5233246959094	17.7280846517189	16.9921849303593	15.8675890466403
+TAPBP	78.9714363645159	71.017441624167	89.3716710749899	89.5436883324206
+HNRNPU	76.8994589748686	77.3874251238094	83.0590734760228	84.493297453631
+COL1A2	18.7620337935331	18.7782914942369	2.60818276723789	3.01616815930677
+COL1A1	15.544000426636	15.2259496353233	2.49849109355843	2.37422024603535
+TRNT1	24.5896523061023	27.2081503601077	31.4631907552443	28.9861168687707
+CSNK2B	75.5692235173876	75.5904696883683	71.8578380218151	72.6410590704169
+IDO2	105.412385776916	89.9590632576978	103.974179295223	95.2872829686841
+TMPO	38.055931741142	39.3277371294793	35.1865663338049	37.9842019896363
+C3H1orf123	32.0777008293264	31.1040395932882	35.7761671782901	37.8512733125193
+PSMD11	47.9200429685487	45.2798812844548	45.6214134236566	48.3367746640285
+FCGR3A	37.9750553347855	38.5605837487559	71.0134829968526	69.5548802969403
+ECM1	72.143650109416	64.77946498636	65.9321263235657	69.6119957795539
+ITGAV	8.82887171279355	9.44846950107349	13.0536625487545	13.5505576200314
+FMR1	21.9959094061869	24.5012954946447	23.0513080369683	21.3826105144391
+ALDH1A1	935.592745473172	995.884146092741	1552.11309607103	1515.75188222296
+GCDH	87.1738792841518	85.5316840069647	101.387962341253	101.510859908573
+ALDH1A3	5.64865137065466	4.79069763741386	6.72260964837829	9.91792612433698
+AP3B1	13.3656489859327	12.9551344888718	14.0149546260849	13.5401350425598
+PCYOX1	105.275324016118	114.485608075133	107.984942172662	101.521892450314
+RPL24	571.034153998848	612.205194346373	632.690719381334	625.03498413353
+PPP6R3	35.9051048005352	33.3288906768903	39.8729525403489	40.676972813933
+RPL26	864.785225113768	886.187799281544	871.631861362422	868.416269551763
+RPL21	316.754644874162	323.389645389644	303.715414494177	314.114304320264
+ATG3	37.6656207682015	44.9080354862586	34.279951184147	37.8783497815283
+ATG7	4.38240511688324	5.84590437677476	6.9494550669418	5.61521865483145
+COG1	13.639361490915	12.0999739570515	11.3260963052449	10.5020723071296
+APMAP	89.3343464085615	94.30022276456	91.5312498723775	92.086425000116
+AADAT	25.1483816241629	24.8519976346109	26.9309824814053	26.442166678222
+USE1	51.4294604903283	60.1765270531091	49.1277795881554	49.9988075593112
+PIGR	47.4508901253815	45.9964799547413	35.3139557338216	37.1326118916273
+AADAC	254.608729097143	294.194294793586	410.273286528726	411.094673258425
+HPD	1609.86860738803	1530.41465600232	1885.39602677006	1901.97124798333
+PPP1CB	55.7180068645539	57.1411058658544	58.050626878217	61.4611614284492
+PPP1CC	37.4958897912851	40.6726519889643	44.2449129009937	46.7860991685697
+RHPN2	10.1968036057979	11.6541108172412	10.0796353539341	9.51736120928534
+SRRM1	37.6030479314829	38.4610706842608	46.949207413138	47.4520975484222
+ATXN2	15.9546602949945	16.2198935684649	13.0477042487259	13.4168434349994
+RDH14	14.2582461984711	13.0377738890703	12.577447618541	13.870371176805
+PDK2	65.618326759518	71.6522997338741	68.8863414045609	66.5288104899801
+RDH10	36.6096671299302	41.1465901425207	50.3347806756139	52.4667606678236
+RDH11	51.2678116560163	52.801759134781	23.9891310691885	21.5873875975242
+RDH13	22.6381312953249	21.9405492164773	24.7677289276237	25.8450927837806
+COL6A1	10.2379726872613	10.4024422531145	5.8373852036873	5.39650750882964
+WBP2	74.5837434890667	70.7229789921074	82.7781812489833	74.5042358693879
+COL6A3	4.40249022506231	4.97184519162813	3.11141164426329	3.07482734780711
+COL6A2	12.7096336327775	11.3580206462373	6.57570569374211	8.29045477401882
+ALPL	18.6394950921827	16.3611869889522	18.8094824607056	21.9208270077026
+PECR	414.842936602753	437.547485913324	386.810991514815	382.650118649294
+ENSBTAG00000005501	20.9531418186579	22.1767942941081	30.8568907869777	33.317244513808
+PUF60	41.477865961804	42.3973298543242	39.6817495693424	38.9237537607181
+FBP1	574.579417850847	566.597142203925	500.702340847176	482.937470861179
+PFKP	3.97574182831845	4.27035364337124	3.38902086432137	3.49340898861389
+PLIN2	53.9883017941491	61.4161596310083	27.9160570319036	29.9101523124655
+PLIN3	130.301408182324	121.556212525784	51.8310573286456	50.1782305248031
+ENOSF1	43.9660752689743	43.9641205830451	77.8263728282365	70.8405281473833
+ABHD6	4.33372932324261	3.63360209075637	4.67912867813906	3.70302731934926
+CIAPIN1	32.8378958258149	33.5492800467287	15.9459282099327	16.3022834411983
+CLEC16A	3.18806664069073	2.90602570420109	2.89940833099522	2.78264378850015
+HSP90AB1	249.716229252302	251.364238673861	178.283515811036	178.013155386288
+ABHD4	31.0562588639675	37.6513155719439	17.9113468368529	16.4438618647233
+PTP4A2	123.824275391943	135.941912650309	163.50034494997	157.999420405745
+DNAJC12	32.126825605274	37.0907149915797	43.069077810646	46.8123644844507
+UBR4	17.2151142394216	16.6187141961038	14.8640583771896	15.2541794262567
+EIF3CL	49.25165398452	52.3035523472004	53.9329387407341	53.383656091667
+TWF1	16.5102184705338	17.9716299767002	22.5344545571012	23.0384357652262
+DNAJC10	15.0797600889161	18.6007863012657	17.8393409115298	18.5873043199192
+MRPS9	13.9970227097976	13.4240682494838	14.9494129343459	12.024910571851
+MRPS7	25.9447499666861	25.7469933063357	21.06017231318	23.5965106082411
+DNAJC11	20.5029598641322	17.3228732375999	14.9838276563141	15.8382574311828
+RBP4	5967.76038236905	6099.31389604907	6230.22069356017	6098.90167706187
+PPIB	723.312645697793	682.785340930253	580.843056091039	595.887273512694
+ABHD1	96.4918776593927	91.8664559836183	29.8261210946478	30.0180637874485
+NUCB1	120.700896478678	111.907271672616	100.832991980047	96.6951741258703
+EPRS	33.0887381658401	31.8798461330216	28.4049218299778	28.6346441706269
+HSDL2	181.38570753927	194.184316833277	107.273360945242	107.043769208669
+KRAS	8.88342681297615	7.63573817915969	10.9867587981512	9.07964813911485
+MLYCD	50.6561570093813	44.3326414819259	26.9722571417059	26.6886299308247
+PKN1	46.7114249652488	38.9285117926529	38.763735211262	38.0104603204511
+PPP2CA	61.5556430937443	67.3949285654725	54.6325943521651	53.1213773189854
+ARPC1B	73.7568503872717	72.5881502768215	65.2382134429366	63.7549936447636
+EIF4G1	80.5218124185433	80.2805056359633	64.6725398159867	65.3623329869332
+ACSL1	368.112494780259	387.178926148645	144.79455005561	147.064456570313
+NDUFAF7	7.52496955750774	8.32705204783077	10.4132046189362	11.4009176917736
+ACSL5	368.297895356746	383.247967283847	400.297310486723	398.552218982482
+TERF2	17.662169508637	16.0210553148526	16.6807779175219	17.7546789533843
+GRB2	74.6309086268571	80.0434604870335	60.0214174691101	60.5970437620591
+EEF1G	291.36249942086	309.768751218964	296.733978224553	294.079025404285
+ARPC1A	97.5607102703614	94.8690247451049	100.842335413608	103.141354357448
+PPP2CB	51.67897775882	59.9107779367921	57.7863573885494	58.3065222254995
+RPL8	508.380539549032	484.521218108231	385.942473618182	400.865863736408
+RPL9	896.766070287843	969.982613925704	1056.28866374485	1034.89909191766
+RPL6	633.545612819896	633.173685477536	604.326046780784	590.417382436973
+RPL7	523.083913139424	559.951100504097	496.707070611677	517.849063889666
+HP	3868.59646724715	3838.35544080375	264.244258133973	257.209546653513
+RPL5	619.638685896814	667.410947929764	680.354006772953	696.229254150104
+RPL3	429.314461023182	416.181672891254	365.747324507535	366.072952460585
+NHP2	27.7507923957511	25.3030815075719	18.8864552482127	17.9448150904237
+SSU72	24.0145507269137	22.8846181348975	20.6766451642935	23.5699025808855
+NCKAP1	15.6915139524391	19.2721551308453	17.5277772103901	18.6862123458346
+CHD5	0.378102524004914	0.277347779584312	0.39680653424967	0.42773704715698
+UROC1	201.457209135687	177.050628476769	146.499157245264	144.017319999247
+CHD9	4.54234158603504	4.69619371680298	5.93970001308576	6.27440125383703
+TMPRSS11D	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+ABHD10	19.5439350386652	19.533711635551	23.2566983646907	26.2108663513552
+CAP1	72.8687530446111	76.8221998309333	72.5373957549484	71.2503270400512
+PRKCA	5.09244307098381	4.31778878768765	4.99636120828907	5.97899478296229
+SKIV2L	12.0042161414751	9.45203937793682	8.29091543472455	7.90382050627135
+ENSBTAG00000005315	196.502441800101	245.22808468008	257.64610484036	267.017390460218
+RAB39A	1.45532118357607	1.89465251884894	2.90793954890221	3.52892168394406
+FN3K	10.0688208975768	8.91454082385184	12.9485655881726	12.9042066912005
+MRPL11	67.4877451318734	57.3812050353769	67.4525548024933	65.2623426214753
+MRPL12	148.581160630199	138.665637474197	101.692703713727	90.5253972382838
+MRPL13	29.9836615930842	32.217943149318	37.1485529310395	36.1921540101403
+RAB3GAP2	8.75726440597961	9.35878555211703	10.7207210586656	11.2961546964791
+MRPL15	17.2317586553914	19.0174344408328	12.8072137046096	15.1238358298387
+RCN1	352.890696935056	392.648364549373	410.183739315858	407.770719632824
+RAB3GAP1	14.9668537355672	15.8708753370683	20.0740834422929	17.4350555661915
+ARPC3	107.245848817019	116.890201348133	117.984461622334	120.270662887323
+ARPC2	169.957965551906	164.642136217688	168.486993526044	174.638428369575
+UAP1	57.3188287319017	58.7075781903579	44.8441951810766	44.6715568790319
+DNAJC30	3.6368142500685	7.09249847576193	6.37526145625454	6.16885582041988
+ARPC5	39.8563654294052	46.8557632520326	57.9951658633482	61.8057810213048
+ARPC4	59.9963861123397	54.9973824792684	64.7073693772188	57.7466353097144
+POLR2E	67.3291227604825	59.9322030902188	40.8544285197128	35.655486346523
+DCUN1D1	22.3224057903124	20.6907485043157	31.5047863808962	31.5349536950956
+DAG1	25.7823265513916	25.0401491478302	20.3411529158566	20.4433583268799
+POLR2C	24.1485653338872	26.2655012662215	24.5130257931867	22.8269339573027
+POLR2B	21.7880033338179	24.0114758600295	21.363867136751	23.8315453716318
+RHOC	28.9361741442778	24.4660561733974	22.1002086014252	26.0896764591845
+RHOB	35.5143141084113	32.8345744573365	32.4907890135896	33.2458594277203
+AKR7A2	110.983863090528	102.875722660029	111.614484692782	108.100751801645
+ITPR1	5.83356220902141	6.30554987104384	9.20075907792262	8.26569609353107
+RHOG	28.3443032375148	26.1366599459765	29.0268602924981	26.9600726792915
+ETHE1	144.787538662894	135.057176530301	124.142184386529	126.561358642919
+MPG	32.3686297144552	31.3954726569319	34.9807382722311	33.4946155212162
+KDSR	18.0507484858702	12.944970875173	14.0456776062905	16.437590609634
+TLK1	28.221108176552	27.4471657066417	34.3893197878184	35.3994394406772
+MPO	0.638537569145182	1.6048407108389	0.776611274284478	0.609909899586089
+MTTP	106.952506694673	106.604276279429	71.9439708477298	67.7793469094763
+AIFM2	17.4423658636693	18.1709026898264	12.5515593645162	12.8320996750878
+EBF3	0.105236049814663	0.545542665262452	0.135058347300121	0.267658174938101
+AIFM1	79.0677093147206	79.2641055553824	62.6734336633198	66.9346848592757
+AGO1	4.82205265695339	4.6541461135091	5.15318374644362	3.72644594375745
+A1CF	39.6551599778483	34.8880001594435	56.0678383295113	53.4949335447586
+AGO2	4.57843423254205	5.06374578977108	4.87232199665973	4.39429112233587
+GRPEL1	52.1368211193569	56.8334213812845	41.3282000306447	40.3287425691148
+GAMT	662.985056779826	592.468517715923	762.581010565525	747.642269332419
+VBP1	30.2687663583794	31.3624446313768	30.1849557753635	33.7541099629333
+FAM120B	3.75800869902227	3.85112316196843	5.69850299555534	5.34797934175275
+FAM120C	5.07031880992206	4.11046302992319	5.40716488727401	4.20957181745709
+LAP3	105.119749606569	108.211017385905	101.19351292897	104.685754505682
+FAM120A	35.4588492990109	37.1603461774973	31.7367172020692	30.16660675632
+MAPK14	22.7956165603384	21.9694793577163	23.8655944228792	24.4572592344419
+CD302	68.2378289404061	74.755195136137	139.84932508478	136.189014398459
+GADL1	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+HPGD	11.8169980706091	14.5307655207829	22.475184872186	27.0347799840668
+AKR1B10	19.24486696767	18.9340282995295	52.3117831932445	48.4616353939086
+OGFOD3	12.901530611645	12.5200708738938	11.9865471532262	9.82260308949049
+IQUB	0.00402581315982881	0.130551186661855	-0.0015762168067058	0.163005705537859
+PM20D1	65.2139899160153	64.1278109242474	54.9867302077062	58.2476887933487
+CACNB1	0.722452572994927	1.27686952110553	1.10904994126225	0.895125405243225
+REPS1	11.0862189497719	10.92062438615	11.4509555556661	11.4841834076827
+ACMSD	154.468880362731	153.477281319784	54.2309248175533	55.112044338842
+NECTIN2	72.1444960153682	70.036211875307	69.0771971851763	67.0017480975632
+NEURL1	0.621756635062024	0.539265314273631	1.10629701361336	1.28538292732688
+BCNT2	27.1162704711526	25.2898187580256	35.8024982217088	34.892318768884
+UGT2B10	69.0900923220943	72.903006958683	45.3353525022334	42.4101598625752
+GPN1	10.5427632921661	12.5847083350205	15.5297833580984	13.8273108856277
+TRIM32	8.14816919344869	6.88474382428201	5.60153763952083	5.93532810369625
+S100A9	5.64056218152131	6.77578612282133	2.03470144737551	2.61471102953769
+RPL4	566.055356988393	578.653437594366	575.785243223726	599.372268006608
+DNPEP	39.1460493286512	36.3399231108868	31.9352201938593	36.3646146399634
+RAP2C	35.2619300801374	33.1605461501772	60.3754221772593	60.0628661879753
+OLFML3	19.7915830847905	20.8743221262631	22.2022161051959	24.5536494315336
+FAM49A	18.7937695205866	18.8163081726435	21.1226896212602	18.1786365115365
+FAM49B	23.575391225476	18.9728664628644	28.5359265423879	33.4361731851645
+GGA1	9.85841620604143	10.2907614540323	9.09475337856103	9.67816854108533
+USO1	42.7714455540291	47.3149698623466	43.7967294804329	46.2263769146741
+PLCD1	5.98067498812222	5.96451651421754	4.24242057083689	5.47422033864012
+ADO	7.97454918320147	5.9513471127042	5.2825464211403	5.67628502544168
+ADK	191.390449533644	206.998058276329	236.563198952226	235.115068841514
+HIST1H1C	5.9217792738612	4.95524693721065	3.08599686608936	2.93740002519881
+ADH6	1105.43081797987	1116.25050983947	1266.06451985291	1251.73708446904
+ADH5	174.76512208266	185.888757103885	171.288369593734	175.091193938471
+ADH4	627.747730143551	665.047237057203	974.081942508456	961.472166593059
+TACC2	0.770287877312979	0.684999726390006	0.35643197729882	0.296964381205269
+ENSBTAG00000046172	106.818184222524	111.685602371835	183.042220193776	183.496149676734
+SQOR	87.7011716232612	87.3282444680352	81.5827142810118	81.8866299413566
+PRKACA	29.5060980856036	27.9793635411781	31.8585724658279	32.6768098867138
+PSMB9	15.9025727904202	14.4797083105454	21.7870823605466	16.800394484726
+PRKACB	11.5368562072577	12.2495657531745	17.036479975094	16.3751071270207
+PSMB7	133.75341334523	127.51549048811	113.975164470229	118.59431503862
+PSMB6	113.535773436955	121.379826981675	102.487633671618	103.578500276761
+PSMB5	67.6175240591193	78.6933239697642	60.1992832968828	61.1840823463543
+PSMB4	157.511104185295	152.768294949916	143.155835016009	137.435626255964
+PSMB3	105.742052116652	92.0603001724571	93.3708644729009	95.7050555465877
+PSMB2	123.457762308973	129.473826287437	116.664015972097	117.876040621308
+PSMB1	145.740161313837	141.687848524893	145.508168235908	150.388254356633
+HDHD3	35.9719533342262	35.4537406248179	36.8845295020537	36.9346573441944
+HDHD2	12.3029949121922	12.1217706321042	14.456566910412	13.9822447076885
+CAB39	16.6656839740857	18.8139458413882	17.4463282420011	18.0365077258724
+HDLBP	99.2168803166131	92.2345142229552	67.000123067042	65.5173770809122
+SERPINA3	801.220767771298	803.401401930203	633.71608220141	643.908202017346
+HSPBP1	9.79761074280596	7.7060819034066	6.3271465466497	6.32309502848743
+CORO7	3.0891970219448	2.81317627439183	2.83680531744018	2.61290698816854
+BCL2L13	50.6869633684315	48.5132932256727	30.8973674153838	31.1988647512833
+HADHB	276.497268041029	290.311923822831	252.75831039752	256.299083958476
+ENSBTAG00000046008	1.38094178205221	0.840426513979766	1.57904220415248	0.085804335057465
+HADHA	271.167248080357	271.004748711113	182.988948186126	186.167076379816
+SAE1	23.5463571125196	28.5815712111712	21.5115557599852	21.2545662398848
+NUP43	5.20859465265674	5.50868915258357	6.34510652934563	5.67647582555492
+STBD1	131.775625930627	148.520648358928	185.709447638873	183.471012989348
+IDNK	154.566391641516	166.213443274996	214.124991055638	192.598325547537
+ADRM1	52.3617709637931	43.5686668195816	43.7949505927479	42.2439074597917
+HSD11B1	582.464906368977	615.231975756486	903.396755604835	913.099744333952
+TRAF2	17.6922565355256	16.5567600933531	14.8677082484315	15.174662414789
+RMDN2	52.2186300421565	68.0383837700869	113.26462341627	114.71846490206
+PGRMC2	124.391304672086	134.20384464969	191.065494933781	187.035785454001
+PGRMC1	283.032304612449	306.822427791502	403.905526236531	409.085608539176
+RMDN1	40.6497431302991	38.7777801905708	49.3162426777265	44.5241622205645
+HOOK3	25.4922185969054	26.5875028080602	30.4837901483831	31.9271816640764
+NUP160	5.44806262951116	7.3309970552893	7.62475252103354	7.78738925391181
+HOOK1	6.53856480972397	5.85913656015185	11.7737274045939	9.92077459520354
+TMPRSS6	82.1339306719672	74.7704335353574	91.260050162965	94.2966731132863
+CRYM	7.07309792439572	6.89898178087216	5.10337147998345	5.32079976827509
+ESD	75.6442538453343	83.3345118532909	87.4341711118774	85.8795136051105
+ADHFE1	42.6363219154336	38.0024047832191	65.3554079929732	65.808507216216
+LRRC57	7.10907325443469	7.84034005052354	7.44318522111976	8.18365542362289
+LRRC59	35.6563096465125	34.1620778773981	29.7593149806825	25.9955727305129
+ABCC10	2.47236758427963	2.72568275498941	2.14127736590441	2.41650266717104
+KANK3	3.88160768562745	3.37206389016101	4.57182970077055	4.92008891661378
+COL14A1	10.6822852963128	10.9464837673729	14.6873610110264	13.8831736209655
+RPL30	761.559800967068	741.768290192404	721.083764661762	704.659336934124
+GNA14	14.1090563149206	13.0636652279344	13.7822098527049	14.0784654205362
+GNA11	23.3086519549469	19.7505644650818	16.3744419087467	16.9182240811841
+SDHA	342.895721620255	328.645028155033	270.644392605132	271.563817742724
+ENSBTAG00000030683	4201.19554469149	4486.69776611606	4712.05225597502	4684.59907221519
+SDHB	240.2926032366	238.48797808147	219.156895752741	218.100336343922
+PPCS	12.0715340682994	12.4629526563177	16.4991276565095	14.3552054709709
+SMARCC2	13.4757062113739	13.0785707339008	13.779148869123	14.2056171389136
+MOV10	21.3615481424063	19.4542587631743	19.9166720442971	19.8599920845002
+AP1M1	29.183002953371	28.4627321390151	34.7620874939573	36.4914966220525
+PSPC1	12.2012434006219	9.33301345103818	11.0509936320832	11.7103926257532
+MOCS3	64.3243285933029	68.620939433399	83.9104604269488	79.9182065177737
+MOCS2	73.5970258125575	78.3834013340148	84.7420648538138	83.2626861669147
+MOCS1	61.2719436983883	54.4532836132022	59.3588543754456	57.3641808320027
+DBN1	7.62062667354876	9.42531076114656	3.93402127945625	4.10000182254912
+EEF2K	40.1691060165791	37.2196537110254	34.7725108011912	33.2447300554713
+ENSBTAG00000017938	10.4744885422073	10.3479477514345	12.0141035629637	11.0443097772425
+OGDH	73.6117446168559	68.6380738395411	28.4659169689294	29.0994749865104
+BLOC1S3	4.08576563460671	3.00180422321126	3.00658915148632	4.8083988238156
+ENSBTAG00000039356	7.30691844591151	6.55009685047002	16.3881140889242	11.9274098108731
+COMMD2	5.38576040064327	5.35250177679201	7.20317757835002	5.93599951242827
+COMMD1	20.3735454782713	17.9100258321285	17.1067247381315	22.1357017731009
+MIB1	11.2969217388449	12.6857075332999	14.6376093514358	14.8076575661683
+COMMD5	14.9729052768571	12.0119703280403	10.1518732721567	10.6240689329861
+FAM114A1	10.9614110026776	10.6768022497942	14.9010459406044	12.1095165055568
+GRWD1	8.13231664985954	8.50209199369757	6.91781807161184	8.18598869761708
+FAM114A2	12.7070834818734	13.5273777637497	14.000301626201	16.5049843578312
+METTL13	4.66237668907224	4.45263582848967	4.22166534269016	3.34234547634677
+NADK2	54.8159931271154	52.6332284940626	47.723223058269	47.9553164239419
+C8H9orf64	14.5302311481385	15.1689462703979	15.9533725986414	15.6793108137285
+TMED2	250.98492168902	245.229752263095	249.936636136819	239.138468221124
+CAMK2D	18.7884764987695	16.7699130914659	17.4368419615483	21.0532777003412
+PTGR1	728.696161850511	750.221196300767	495.366183414484	501.366318588195
+PTGR2	97.046283254187	106.374231616666	124.486181953854	125.05017515939
+DNAH17	0.0109092959600218	0.262945783363648	0.15619315768194	0.101126162192876
+MTUS2	4.31718926531321	5.54641885151013	7.38959579507357	6.88167947570886
+MACROD1	71.3409101946829	56.6765415914034	61.2466842310515	66.1484926170904
+COQ8A	23.9487750736404	22.2144870984009	20.140197488807	18.2001640230715
+ENSBTAG00000032350	814.833615049731	862.160755335367	834.393616949251	846.807463464239
+CYP3A4	146.068094305871	148.678559492607	209.960572459571	215.552890791339
+CYP3A5	2650.92568427163	2822.95728007586	3104.9676213905	3065.56732713001
+UBE4B	14.0926461344646	12.3794305253518	14.9016206806154	14.6225200903442
+UBE4A	28.4702742009415	31.1338448614896	31.9628644503406	35.8269852048431
+AKAP2	20.4793594806008	22.9233539157229	22.7779453437442	22.2099296365008
+TUBB4B	112.093821930856	102.462282787532	44.1243213418541	43.9310024417296
+TUBB4A	217.162920683109	199.26521356582	116.15526810975	108.810364912596
+AKAP9	7.4913571170672	8.7323281105844	8.85776793859657	9.42303492817262
+EIF2A	34.9875734942932	32.0505331201576	37.0853447783662	36.1133229327545
+MTREX	6.90808150195829	8.32357076755438	10.7170103796345	10.0672229266973
+ENSBTAG00000048013	331.754579222598	359.827410382149	304.035714488791	310.334461003324
+STARD4	101.605810464958	115.698789576689	90.803439582177	93.4816079378502
+STARD5	20.3422620375773	20.4404606723093	16.5704862916314	18.8236605467884
+CAPZB	52.0510055090945	56.3445745451837	59.6470091326416	51.4380298805275
+ENSBTAG00000047632	0.0768529813312971	0.364114005526894	0.363463933908203	0.930332115479812
+C5H12orf10	5.00383898895227	8.18684479577235	7.24231241708538	7.4771152117753
+NTN4	0.437671141825327	0.49257043239633	0.389281370404683	0.254815966281363
+HSP90B1	529.749449487542	558.107289634185	273.953517489806	268.078279629498
+TANGO2	14.2002202152655	14.2006518370555	22.39373419956	14.0855878751688
+PTGDS	41.8861934582015	34.2050077643528	30.5413911612852	23.9432920680568
+STIP1	43.8469359741177	42.760932885763	29.9000390318798	29.6895986042318
+HIP1R	9.69122839482908	6.79727210896662	5.96980665961365	4.90301748935779
+PIKFYVE	2.9653036010696	2.59690924386061	3.75056548627301	3.64681689681478
+PEPD	56.2130501761185	53.9755344052818	56.2522569559011	58.0814672888588
+AHSA1	51.4445821432798	50.8848861521773	44.7811816147132	44.6500708064545
+H3F3A	225.303842823568	244.433907480341	254.79898483949	245.838914193061
+MRI1	10.8976568071377	9.11153183309112	9.67317602882818	12.0588202970203
+GTF2I	34.1177433031055	36.3557636248256	37.9522942584999	38.9292289822082
+ATP1A2	-0.0349324249447941	0.134890184156165	-0.00542455267001526	0.00657082332543535
+NMRAL1	62.4420154252066	57.2880298346563	51.4896876139228	52.6963777765173
+UCK1	10.6189688597911	7.62972382477382	8.0676926243714	7.76291448538602
+PRPF39	13.4955095592332	15.5856609733065	14.9433242898817	14.8182053536539
+DSP	23.2482415933666	22.5945403700082	27.2420982167781	26.5315189009892
+SAMM50	47.1562419350304	44.4575168328968	54.5163783747121	50.1480343496199
+RNF40	8.39437492670073	7.41720397857919	8.75947234367798	7.43479091332121
+GSTO1	23.9425293404154	26.3024627671921	22.4249246482248	18.54566506549
+DNAJC9	6.9674834314421	8.60217897859582	11.365013964634	9.59291442335075
+GLYATL3	88.3069651281587	96.3898545694085	166.25009894012	171.481526558662
+ENSBTAG00000023978	3.94359952176421	1.99618469037055	1.96462804870536	2.70838143219408
+DNAJC3	81.4550274854325	92.6973842945913	76.6373671543527	78.099066125512
+EML2	5.82370486506516	6.35287145098209	3.8982812388996	3.95215882656903
+TTC36	174.031450285321	187.41842547038	271.49687537705	271.448599792076
+GOSR2	20.117230072993	21.2788436658423	40.0852849876115	39.3904573502129
+GFPT2	0.259374658927593	0.683549921357554	0.492655490072378	0.774472320831338
+TTC38	51.547947866303	43.584223667273	53.5103979194969	58.9812317792432
+ECHDC3	86.7908655131638	78.8997697344205	143.794159305775	156.892095646374
+ECHDC2	108.868406937957	107.219721131948	137.233129511055	139.514787955081
+ACP6	18.0225880202357	18.4044114256317	20.716893615756	20.8768584237341
+ACP1	44.3739721220789	42.0193985682398	45.7929408149619	45.5636851062907
+RAP1B	31.9646413856528	32.8393258833764	45.9772741268579	46.4082042485821
+RAP1A	51.9239423204728	64.3117082817351	71.8486976076003	70.9906569388079
+ENSBTAG00000016551	11.2351360898322	12.4023476480082	12.2812090084989	13.9183912973504
+ACO1	83.0880251448824	86.2651542051764	93.381209742703	95.4248823149936
+CHDH	19.0566218189403	17.7467915147982	17.9703360727163	16.6044094046569
+RHOA	177.382073759642	171.018922395861	189.297872811329	181.368605583589
+NCOA2	11.40396876407	10.2829911201532	12.9978790945243	14.1935224099012
+ACO2	64.7859019499235	66.3275466812052	55.0700701053573	55.0120885074504
+SPCS2	126.545530609058	141.751704078963	135.340268256128	128.916427250438
+FAM91A1	24.4433677061076	24.7884717307621	26.3538034565623	27.0748405477942
+NT5C3A	15.1841115005913	15.5858111069821	22.2490253608455	20.7390259403289
+ACAT1	489.602002890684	519.86938801814	420.149296258797	425.228381256268
+ACAT2	195.308056900315	191.042368742265	120.170851890242	126.558366653556
+CXHXorf38	3.97441389177732	4.1959472931092	3.31802592472746	4.51454285172491
+F11R	82.6984484302132	75.9448090710253	72.5316115639844	72.8997309283194
+HMGB2	51.1842110024397	54.3047196202446	31.3117852613693	27.0998763019091
+MECR	17.0329859357908	16.0683156676074	12.6503975155539	14.1126923602747
+DDB1	52.0831348656605	49.6164760100048	55.5255128845548	53.2761660866717
+IVD	117.437999517947	109.627657090786	111.084565099932	110.115985742377
+AUH	23.3900962779598	27.3591409144889	35.3077780751563	27.4302775396912
+MCAT	12.5461352503799	13.2412443883375	9.02911962755199	9.01958265727919
+SLC27A4	61.5206797570006	62.372138511593	33.3114214279186	34.3609783602649
+SLC27A6	26.2531260070431	28.4824296877476	36.7413575061241	35.3697280293143
+SLC27A2	257.156239280773	266.881214256398	224.07909068803	223.526861810721
+CAPZA2	31.4458481906727	30.4883806165139	38.9993713943618	40.2667943405838
+CAPZA1	50.1115252174051	62.9045557184224	74.7959735190969	75.6628599928533
+TBCK	3.41929887683785	4.30344695711142	5.30579151489301	5.74095514981314
+RAB33B	4.16796946169389	4.65442274246733	7.02988746440271	5.93145204997593
+AK3	46.173978076315	52.3888904532144	43.2224955032579	43.4933840373909
+AK2	222.537831858195	228.571207549421	169.377551667491	162.904866007264
+TBCE	6.37062376806766	6.87428971526879	7.63402195694968	7.14459950008612
+TBCD	10.6953464008815	9.16509778771906	8.63575910345812	8.54621017739418
+TBCB	34.1965030345606	26.7317587178981	31.3628264049507	28.5980193099219
+AK4	7.76497547595988	8.48970065339455	22.458509074793	24.2310628243043
+HSPE1	518.339663980174	597.560049634359	490.363685148162	482.584072720364
+SARS	68.3339519576348	65.7467356833616	73.2616767797978	79.2576361202072
+PRKD2	19.7995488152355	18.5829753728697	13.2967738649923	14.6057965784618
+ERBB2	80.89987373852	75.3128206333502	73.8438791224619	71.4840881390561
+CTTN	65.3990428902827	61.9350864769601	57.9331811496338	55.6300452255334
+DHFR	64.9888897186434	68.9628591609435	95.4245687849823	92.1335013888862
+ERC1	10.3071484091179	8.68389145227236	9.02271277260123	9.27599868673225
+BAX	25.0920419852159	26.4930656501213	15.9593834684537	15.9404397840304
+PLCG2	5.10690630154994	5.70035796092815	8.76241606701157	9.23147743495307
+ATPAF1	59.7403948290439	64.451186651078	64.2084954758691	65.0835121408842
+EPS8	24.3821329999891	22.2296638669543	16.069631819506	17.964715624175
+LARS2	10.673016473139	9.78328628231382	10.8800006542056	9.55122497171578
+EIF2S1	21.1432263942459	23.3878263474377	24.0586753631992	24.4871269943974
+EIF2S3	82.3343568409042	75.4662431620278	93.795658716553	94.2737314822754
+DDX17	95.9516156630263	93.4600835165741	132.388155939231	142.348444688966
+PMPCB	35.3758346711433	37.3939720549373	47.2488622757306	46.8891259074851
+PMPCA	61.180596186105	57.8924014295674	65.1461047261414	62.4226932622692
+SELENOO	15.6241283341212	16.0015843380694	19.7894652690836	18.683118109433
+IDH2	63.7100190593585	54.6024026375344	31.0630334327757	27.7005770466503
+PSMC1	52.4709142451307	47.9861166886689	51.041744803913	45.5475133112596
+ATP6V1B2	21.1359790167711	22.2503142681739	24.7225445839001	19.5827985136971
+PSMC3	76.7499965778751	69.6110658331639	65.334036418072	57.2325007440945
+PSMC4	49.6387997053276	50.4577133984424	33.3434473424666	34.4901254676218
+PSMC5	79.0577614371833	72.6859298624197	67.7184258642264	70.6957119456496
+PSMC6	48.767770672386	50.5296452135104	44.2002602649418	46.5400024629664
+ENSBTAG00000015330	37.7070103301179	41.0109438709832	52.4032627556581	53.31515053203
+ENSBTAG00000015557	102.867289352565	100.678781285115	126.738517081229	126.690283716048
+ENSBTAG00000044081	37.8830705943603	32.6548551120065	53.3483775834695	53.9060722214156
+SH3GLB2	34.2094202547462	29.7064573099832	16.9732780754076	15.5507250194187
+STS	16.7648229963417	18.5392890139074	33.9867643726532	33.9482829374452
+SEC61B	130.587966017303	150.436116656372	120.475539894937	119.861203337435
+LACTB2	52.3576926784436	68.2593927728241	71.072074838188	78.6027599928103
+LSM1	14.3743750617304	14.4390646788682	14.4515125649412	13.2373131655272
+TFG	40.1194159774449	40.2999752690575	33.1247602075221	34.0978358395755
+FN3KRP	38.535540693097	33.7865150797019	35.5623062263299	31.0640537960551
+NCLN	40.1700305563799	32.9112649248107	25.814929349322	26.3587089058125
+EEA1	20.9674013132962	18.1673895453813	36.9280717367423	34.8614263233564
+NCL	95.9698231659148	100.518140287276	108.489774936337	108.454712677967
+ENSBTAG00000039362	388.480250231945	424.807689435474	198.154153237478	197.074203974707
+LIN7C	15.5862887685137	14.1426833964025	16.8187547631312	17.4775928382262
+OMA1	7.38701301586147	7.86180241633434	6.86279981192594	7.14706472147297
+ENSBTAG00000047986	77.0203361197023	84.2558523740238	20.6928038561653	17.8202310008206
+KDM1A	9.30172116842288	11.3126427454206	10.5845148357702	9.25938497886522
+IDI1	270.362201833483	280.584006333223	135.011942010611	130.74160994635
+SPTB	6.08801362707421	5.21144623386942	3.78665703544318	3.87610964060425
+DHTKD1	63.3244147553428	66.2727975110486	93.0618081233863	91.3521322258346
+OSBPL1A	22.8768394170994	22.9220871486793	31.2454279406409	33.584476519901
+LRRC47	8.98057737837651	10.131740525183	8.18863700879118	9.86037035129819
+ENSBTAG00000005217	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+EIF3H	79.3089899585012	73.5040311215211	89.303623193585	88.5982915814854
+EIF3I	114.088588131364	118.270055685175	124.767273978458	116.937715608197
+EIF3J	42.5741729162025	38.9118403582351	48.6951059364602	47.6481443978879
+EIF3K	115.231566761848	118.623627430059	126.824511803468	127.612939544605
+EIF3L	57.8273192143157	54.2319402431576	59.7494866060072	55.7183666803711
+TSFM	13.9686891135	18.2519180897033	16.1897982700765	15.1866275356074
+DHRS7	631.553718721641	631.205899498994	853.164030252418	830.507528128141
+DHRS4	572.41792066641	542.102037464868	489.384268399516	488.641564846354
+EIF3D	48.1198607156594	45.5329114154673	53.7198989382275	51.8389398727379
+DHRS3	231.244304779365	226.69742993739	221.249647499439	216.903296478988
+EIF3F	72.6156697544155	71.5917933088769	82.9364109834598	82.3791831772733
+EIF3G	69.2070593969054	74.0065986360044	81.0698678143449	77.707311645006
+RARS	20.8739748894315	24.2008221050474	22.8069402991518	20.761825127966
+FADD	38.1021460926764	37.1983485428799	32.2083720857245	26.4745211455088
+ARMC10	18.1187911287447	18.8655705648939	20.347293942896	22.0160351699576
+SMUG1	13.2356235792929	14.6702435707577	11.2596629634186	11.8036902431529
+NAAA	15.887726526398	18.3106008348636	33.4958173186671	32.2878723611945
+DAAM1	14.6005672639221	13.706930717315	12.6164748150137	11.5550958117317
+PCYT2	121.716466203374	115.631321750572	55.7544069989008	57.1663052447836
+ENSBTAG00000040409	3642.81826177629	3986.87109144914	3575.62411687168	3454.83057797176
+FCHSD1	22.9471493356585	25.3236544033384	26.0046791523171	27.4918952242118
+IMPA2	85.7495739784571	81.6195534704444	52.1872870908096	52.7720917328713
+GUK1	66.514401805586	64.3763919357044	58.0703593841949	54.9151054306932
+TPR	11.5879898971592	12.2569382116712	13.4868419935552	13.2109626010818
+PHGDH	101.928876662233	95.8148130423083	72.3439893852177	69.1087338648757
+HRG	1342.28164619526	1333.76359121042	1780.13557248079	1746.00848210092
+NTPCR	24.9108964908337	19.1428315586221	22.1640064065062	20.7274735708832
+VAT1	43.9510781610967	39.509533493394	59.0260163990115	59.1720644944455
+MTCH2	111.825110261924	115.884527472094	112.366252134885	110.352241167265
+FN1	430.834081616661	432.33455174828	677.242235329568	679.837034056787
+PTGES3	132.418715990432	154.456263837405	147.062404283312	147.832727268838
+PTGES2	39.9411175036807	33.1672265822469	18.2522122739351	18.3452192528111
+ECHS1	1205.61006711327	1163.57219939394	1042.55555782428	1049.20223783287
+TIAL1	56.3450968547158	58.0410694027574	72.709964907475	72.2456411611393
+CAVIN2	31.6296313467552	29.883607547196	37.5865845072096	36.4440874861828
+CAVIN1	14.0850433725362	12.2479742130271	7.49097048728428	8.62793411942651
+FUBP3	15.5479965871368	14.0596474726751	18.1669132507592	19.6976462632236
+FUBP1	23.4841399881297	24.9711476727051	22.9956316187974	22.1909544986458
+CCAR1	24.5566795579161	23.8875668126191	23.0142569842389	20.4576296643361
+CCAR2	33.995317551519	29.082968451669	31.7009858687608	30.8887561860281
+MTDH	40.6117352716085	40.6034089044199	44.350907439522	44.8841795260189
+AP2B1	23.1107181255078	18.7896648451411	29.3743842702834	28.4168943672371
+EXOSC4	12.5862740395964	13.6092675346644	8.76499349961407	10.8509333110407
+EXOSC5	11.8808916331351	11.1567770748366	9.79549382102322	9.30801328291301
+HCCS	10.2887267742598	10.6884415570165	7.81892969043089	9.24558891266734
+GFER	17.8253827602257	13.9577194745042	9.6425548002615	9.50871067465274
+NCOR2	6.03487607568843	5.56790995887333	3.88870821636784	4.53334321546119
+CEACAM1	40.1779107926503	43.4760045769739	60.7460595997956	64.2044593158198
+NID2	5.96970818722828	6.23309226046528	4.06582537746576	3.87559220203014
+NID1	52.9705235659317	52.6710046095159	57.2874248309873	58.8771082307562
+ENSBTAG00000015047	536.488203976578	576.252902313882	484.686165649257	491.254333062634
+PLEK2	10.0032463599796	8.75457149644676	6.89251524908072	5.32653138148207
+PALM3	29.808704459807	31.3262350583532	21.2689774526378	21.5923014122513
+FARP1	51.8867570238684	46.4744986418871	45.065665420364	45.1574811093893
+MBNL1	18.2650726150367	19.191090135862	22.142907424981	23.3502274020621
+AGMAT	166.752737503077	158.70550624864	183.733987603998	181.530803921037
+F10	437.338384169004	394.479916044307	522.633054293112	517.582414547523
+EXOG	1.32753091035198	1.87507915719945	1.58554599451868	1.85541389483128
+MARC2	310.519598749897	338.109020323337	483.219565274969	492.097364105722
+RALY	63.9077234222977	52.8815876864748	56.5477237068926	58.2081773292813
+SRRT	24.1202886961495	20.2939036361896	19.2266981062274	18.2342419627984
+SARDH	18.2318179637154	15.0614134243257	26.2706393230255	23.9593411167966
+VPS53	4.84953407154577	4.97056757034682	5.16961324142711	5.39952115018413
+ALKBH7	31.6069154774617	31.1079725318752	23.4388367474727	30.6741048078656
+RALB	19.0190241651869	15.3341738562443	23.2635967284838	22.8923477734633
+RALA	14.8252504548386	15.5583345005018	16.3635644091086	13.9968041836226
+KRT75	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+TMEM126A	36.7925489384036	33.9313812885924	34.0938264468805	35.3674433303855
+PSMB10	22.366296126555	23.612589331904	28.2570801068124	32.3990389745477
+MOCOS	16.4814607154525	14.6645364021038	21.2436162679388	20.2020312348938
+SCYL1	23.9866069970233	22.3846238593466	18.777383072665	20.4583604001099
+STXBP3	16.9095252776294	17.2795852664765	20.4352533962585	22.31052819091
+STXBP2	42.1813176144312	39.7138692180028	35.5165006169736	31.964436423108
+HAAO	459.603924040606	424.946645314015	349.223699609901	354.737072400721
+FASN	12.1832618330706	11.2247034797068	4.27945679990593	4.40423732144923
+SKP1	172.638979476066	187.23836973001	194.932231556146	188.851038986175
+DNAJB2	26.8275140377282	25.2643390314589	20.7258774211276	20.9682715269717
+DNAJB1	31.9466957513415	32.8673759682631	33.3947007333481	31.7801042682247
+H1FX	121.968462071309	112.153540090506	62.4402817598069	75.4370965398784
+CRYBG1	10.1445664579257	11.5679578993255	13.3334724088827	12.3784885028081
+OXSM	7.6228094874408	7.96477625843329	5.50347667809366	5.50196476166338
+CRYBG2	12.1844836645202	11.5961897375428	15.3821940910318	13.9603803800814
+AMDHD1	102.616657806076	100.178802222146	82.2651559352772	89.3076850200113
+AMDHD2	11.0266054969547	12.6368243330249	14.8520323528994	12.2749472031564
+HNRNPAB	58.4931656036547	58.872708391073	61.0977018293284	59.23907055398
+TTC23	5.66273536557649	5.10939575141991	5.29403428620502	5.80502277104746
+CARS	8.63159727468553	8.67099986067082	7.00775758668853	6.64636979257245
+HNRNPA0	18.0590508815221	13.0812366331197	13.7133261420312	13.6802402929556
+HNRNPA1	179.599284626945	185.257107758138	180.665595882705	187.094981139306
+ENO1	381.271673116926	366.544215762049	290.683161669903	297.069573014612
+PDF	9.98823405856843	7.79911837651794	6.78665799142329	5.92236329530247
+RACK1	858.768353483779	863.298892222446	792.30313084731	788.639455047502
+ENSBTAG00000017949	0.498767525923125	0.533024558582954	0.540926003393814	0.800136244720405
+LLGL2	15.7040417050766	14.3229464877066	10.934839431655	11.6243376604496
+LRRFIP1	11.7069059683775	10.7098891171545	11.5718771670195	11.8211079728934
+ACOX2	369.239691982888	362.043238782978	284.378340136321	279.632009330622
+ACOX3	28.564097830672	22.0908326836887	26.9991769038382	27.4157763902516
+ACOX1	160.843721968091	170.113006293914	217.296098160017	221.679804531668
+CDK1	26.8078130719742	24.9661267619084	9.4299068879976	8.75778737238034
+CDK3	46.1012215060919	42.6313076187989	19.7538653526083	22.9339695107235
+SGSH	14.3795799922517	13.5187125977655	15.9800592512645	16.1613623814089
+IGLL1	401.356057836198	354.597367865997	113.195325924581	117.868124772962
+SRP68	24.9280846010669	20.2569535851394	19.1882469479339	20.4417834823388
+ANKFY1	6.35230598835986	5.59461556148715	7.3865616250483	8.19927612110851
+RAP2B	5.7188758156169	4.86010082844554	6.07220289207095	6.0606600804375
+LCN2	27.6448749726907	29.5490425639249	13.9730232499535	15.1713694127732
+PHB2	92.942748182426	93.4374806978708	82.8127531916424	85.9196062696196
+PNPT1	18.1215245356395	19.5717558122056	16.8688779280532	15.0657719684472
+MSH3	8.58071822834958	10.5039161457776	9.48457065554682	9.7880547819692
+SF3B1	52.8328516699784	56.4055522916201	67.4304755562418	65.5551156949989
+PRKAA2	8.33696801454716	7.65058526125221	10.4331557276127	9.35690520556767
+SF3B3	31.046759674103	29.0967761499223	29.5103373226005	29.8734123675225
+SF3B2	27.4038352654791	27.330588140953	30.3499288798422	29.8337281364214
+LIMS2	35.9067484532959	36.7104852570305	73.0056102408556	67.5372220994988
+LIMS1	7.65045437056355	6.72065549017984	7.88575126301273	8.6286388533318
+SORBS3	29.1839945621072	27.478734696872	35.2306324520116	36.6891652272683
+SORBS2	10.4388283587913	10.9216983993387	9.41738676968242	11.218564328747
+ELAC2	11.7342084066535	11.8392185317158	10.4371764324317	12.4229452823288
+SUN2	23.5508062877979	21.558577377586	21.5133400458983	19.8936978070011
+ENSBTAG00000008248	24.5301101133031	26.1418176581525	26.4397802440541	26.4136448100022
+HSPD1	265.176486911651	279.419646945023	217.862220501207	213.880109063015
+OGN	10.0323584694161	2.88025662944508	3.59361781818193	2.69948053858597
+ARHGDIB	40.2843454083653	33.5174894975693	44.9829110964024	46.1503311168694
+MTX2	26.8438511509804	23.6807550888286	22.0346567625514	23.6516316685903
+MTX1	24.2443591345995	22.029337501554	14.985943206831	15.1024374909547
+ARHGDIA	116.136359765553	93.4479564153374	106.138774049532	118.676721255044
+NANS	30.8805848799376	30.631920596469	20.4549926972727	18.1753387957135
+PACSIN3	52.0022154367677	48.918333146788	34.8080003422947	33.125976712411
+PACSIN2	14.7471629387524	15.6295734237452	10.7673856930762	10.7535760149493
+COPA	56.5415738802033	55.1256349911717	59.5736165463659	57.2298175454171
+LIAS	11.4033181279969	13.369431512345	15.6750135607123	12.9808526303874
+COPE	84.0280129674988	70.3895232782106	69.3245758404472	68.7023785018489
+SUPT16H	11.5242636917864	12.9155682746774	14.5472654540232	13.9574394323376
+PRKCB	3.21874393718854	3.94655740230675	6.11051104069738	7.21764276294812
+ENDOG	53.5022302586054	49.6857399257231	46.4330997826011	43.421912315742
+PRKCD	5.00578394864492	4.6918278090674	3.66059038197226	5.34387392539858
+CES1	657.627525020876	645.113744458743	1780.82900875901	1783.12269981632
+CES3	491.326380942713	479.875880044093	346.501787723459	345.556496749204
+CES2	269.345374656252	272.426147883064	399.135434336173	411.244856640026
+LMAN1	143.225437363508	144.70618069192	163.811896775314	163.413612002755
+LMAN2	224.511321710313	211.07428677687	236.22629840472	232.685072717047
+LMNA	58.6718154654327	56.6237587975677	15.0504714839894	16.1063338484974
+BDH2	76.2779815592127	86.5451785896173	74.5052816498982	73.3640631609913
+PM20D2	5.28776860982995	10.0892114703451	7.13084947987655	9.14304234079105
+DDX23	17.6510594072614	17.2421228729002	19.258056836745	20.423728013516
+DDX21	14.1198720265609	16.8848365824287	18.8782007448005	19.1080380422885
+BOLA-DQB	7.11003161494104	5.98707518262986	11.8219558959748	8.60228490340021
+PFKFB1	76.258179950693	83.6738581001602	112.508978482779	110.158386210505
+ASPG	19.8435058719096	19.4333187389306	6.14557250854855	6.41487103899518
+SCRIB	7.56128349348843	7.97634272205834	4.82583808172263	5.61074099781179
+GSTP1	50.164595219918	55.6096606485813	49.9341488774493	49.9782822763684
+VTI1B	36.9612140329229	30.1580886580028	41.8905029070371	43.9724228065818
+ATP6V1C1	12.1531778429436	13.6985132004281	16.1947606731877	16.6816055398607
+SCIN	2.43022472649464	3.15030770131924	4.15087424891336	5.57303135951839
+FKBP15	15.5827501488651	15.182494857953	18.5298122428994	17.9998346070168
+ADD3	16.2284808832673	17.0067107777246	18.8383192029129	18.03258130514
+ACTG1	332.905066429476	323.803491566089	234.933479504726	242.255984963068
+ADD1	20.2769619449455	19.0185220960693	20.8765149918836	21.4507590248491
+FKBP11	119.451402855498	121.106508368478	82.3490471015213	81.9294726730359
+FAM3C	13.8394889891584	12.2064087000794	13.7446799387303	14.284096533087
+PPP4R1	75.9596157508561	77.2259080287634	70.6664219879239	65.6209543658932
+PPIL1	25.7591026693066	29.2239652085702	28.2683682551615	25.6620339660294
+TPI1	174.704116713492	168.008171577484	111.765311584812	114.716460023874
+KCNB2	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+TMED10	113.324011011411	114.806591635016	125.119069048464	131.297657927284
+OCIAD2	83.413192447094	97.8456241248504	119.032188444695	124.304488007789
+PPP1R7	16.5036944688331	16.9798261447558	16.2051725194055	17.3712157210292
+OCIAD1	120.067439339414	124.172598304355	151.718112662913	140.434056160894
+MAP3K2	5.3388304431554	4.08884668809775	7.72950727915985	6.55158883607604
+CCDC93	10.4744142506418	12.2453601138503	12.50153253235	12.8139742587717
+NUP210	6.05924668423472	6.71940654735698	8.41891148576624	10.2328964962645
+PRTN3	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+CTSH	47.5009627819062	44.865042237459	61.009324435394	57.2936768866237
+FMO3	630.985421074896	655.303897016885	792.12018490243	806.071245143242
+IARS	12.5301840849552	15.266079791919	12.8718969246571	12.3387449979931
+HAL	41.9909713317432	43.8608863841128	30.4500124369469	31.9505132265284
+FMO4	30.5709421708989	30.6842007934004	46.9155837815718	44.0697967391927
+FMO5	128.802107549929	142.861212110502	258.182788519966	255.776198154426
+CTSA	81.4948452904226	67.4211591022967	93.401289960485	90.1077900243812
+IDH1	276.10158286935	284.131384009262	173.573685830234	168.004141288397
+CTSC	161.913079057291	162.633117730462	180.553495776479	178.874998814862
+CTSD	205.678730487267	174.40706307611	182.852341247966	187.800623878286
+SH3GLB1	22.4508047043908	20.5707965158703	22.888952815586	26.5118269240245
+CTSF	60.2928988716415	57.2058662122831	49.0740056447364	50.3703117701687
+RPL14	652.679807705753	648.194194810739	652.171425409546	646.210253637788
+RPL15	88.6826231836054	92.3096643628748	115.757066224389	117.153663003458
+CTSZ	419.138065664984	402.824752380718	359.227403838114	357.836325071414
+RPL17	665.794994906517	583.742385133022	609.205365673252	652.60370574181
+RPL10	1629.11999538505	1545.64267134026	1417.58724443746	1396.08223035725
+RPL11	606.158067235754	581.654965716056	501.971887981769	482.140547104801
+RPL12	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+RPL13	305.77090011712	290.842367929273	256.411254453948	262.811767225611
+CTSS	87.1374661748081	87.3507358688656	163.56120889591	162.933867440271
+RPL18	702.212378098988	631.869936608947	585.118214463508	589.927860133852
+RPL19	947.297736720385	943.127688010831	930.633496912332	958.253187628406
+CTSW	12.2892923106459	8.84949421569506	16.6406302558684	15.9989948869977
+PCYT1A	10.5104443871559	14.4420739245679	17.4758176833643	16.8090676593813
+SMPDL3A	68.9682456594669	72.2141212642125	69.2770639943969	62.2882666404987
+INPP5D	4.46326753674894	4.21179296196122	5.93485715572042	6.59390280008222
+EMILIN1	44.3919651026962	38.2498543712809	45.0158465191836	47.5653887747132
+NME2	75.4805917044064	65.6337564557777	58.8593685855017	51.1889279420248
+RAI14	9.42152731551424	10.2252883612002	10.186513309741	9.83680714824442
+LXN	3.10684204894733	4.50859677174486	2.67773532797147	2.56816000323145
+ENSBTAG00000000258	1160.3382098293	1188.6342982147	1379.42097438099	1400.97838591565
+ENSBTAG00000040418	0.401143024675626	0.647887817038831	0.491760196427325	0.194339814969575
+JDP2	6.50449120586652	5.77358417265287	6.58595297804334	6.48798672504579
+EPB42	0.119997791340842	0.345517962994695	0.341370988110041	0.286752507293721
+EPB41	24.1502211857368	19.9720920322015	26.4334434487252	26.8056451704305
+GATD3A	92.3797355579327	79.572467069227	89.76143579413	94.3248888981986
+MATR3	61.3385523843579	63.3652682542377	71.9890652925929	68.4883789301482
+PRPF3	20.9232405079524	19.6467292419969	26.3277439664518	25.3165708540006
+RGN	1009.70981334055	1025.62857420514	1251.79484006022	1245.21256345165
+ENSBTAG00000046076	93.6376332353904	96.1118045614768	19.0096839095121	23.351309018035
+AHNAK	25.4881711501906	25.9997170077043	37.1099321618289	37.310588053659
+ECH1	217.215620382344	224.087469149211	209.067973316987	208.324260089591
+ALDH16A1	72.0006032158355	67.4583150264986	70.7817192209612	67.4528975785357
+CLUH	45.0673846737799	41.2996524527532	30.3326758003316	33.3284862794173
+ENSBTAG00000035915	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+PDCL3	16.8024263357314	14.161232298828	11.0673779124181	14.3469108216772
+ERP29	100.244193595539	101.19492733397	97.4212377828514	99.2194363936814
+PSMB8	36.7597788527108	31.3644167760726	48.1466216974714	45.5905901632791
+KATNAL2	0.483795449667477	0.322483462316373	0.100530990971139	0.112825692968048
+PHKA2	8.81093161280088	9.44103199746286	9.14485053473185	9.4010520837502
+UBA6	5.47864028725934	5.82177630335361	7.30779150636192	6.15168180187787
+UBA7	12.0310860679826	12.0916205932916	11.6505662508943	11.7876444276797
+SFPQ	37.9314505259498	36.591949910297	36.7098017568095	34.4559574072378
+UBA5	18.6438957873492	19.2406562946691	21.1899429640531	20.4580037451133
+UBA2	14.1261367199376	16.1104614308802	16.4785571640803	15.9276527995276
+UBA3	19.0393901520512	23.4313386309023	21.8994107756724	22.332189396936
+UBA1	43.8144925756225	43.6487065496451	42.1384904588888	40.7767772886139
+DECR1	126.997980191995	131.122421049726	199.174434341353	206.392976997819
+UBE2K	53.2466971009806	51.9181751946097	43.3584853348651	41.0952296475917
+NAA15	6.14865145176971	8.0614418672985	8.04844455994983	7.7134769194334
+UBE2M	22.5747642344538	20.3593434004248	15.1468157993139	17.7733067552239
+GNAQ	11.6136991753553	8.1651146204697	12.5257486951333	12.4851346306178
+GNAS	182.618990333848	180.230851206132	153.637007123569	152.001185576341
+MOGS	22.5514292311476	27.65401227448	19.1688474702656	20.0647773668326
+HYOU1	25.8353431419396	24.5033443792191	15.0267089658434	14.423674557674
+PTCD3	11.2462150337538	11.8831089371259	12.1017701609723	12.7301238995557
+GNAZ	25.7453735807559	20.6571204946724	26.2589107385617	25.8059663644884
+GULO	372.75116117371	362.192758859547	454.243951131631	457.682476756914
+UBE2Z	23.2739631750086	20.1547318679898	24.6216289962725	23.6921954214776
+FGGY	25.5682382168423	27.2343244798227	34.3811516543247	30.5311735501625
+UBE2S	39.991012430999	40.1153571360755	12.9786605374214	11.8624746361031
+AGFG2	38.9218893505428	38.6245726803028	46.3295686446519	52.2445772035387
+AGFG1	29.8905730317607	32.1661724141668	27.7553479342287	26.2566141489647
+FARS2	62.5182594287738	53.4562912024214	63.1873219654332	60.9626679280191
+ASNA1	59.4803144964307	53.2220006466034	49.79073160127	46.3226823379286
+LIPT1	3.9019589697194	3.92452291974253	4.81603979414554	5.7161453637328
+SEC14L3	19.8111953403584	15.6694649077659	26.9339398084139	26.132710288661
+SEC14L2	302.579543919248	280.562880510244	276.829413021666	287.845160445533
+RPL18A	491.948714387137	484.796650907269	459.230244182188	445.197980897527
+ILK	58.5036018136718	56.3243148720487	43.8601668501454	44.9838066473857
+SEC14L4	28.6346522556473	22.7050433119988	26.7538670257538	25.4665729139255
+ATP5PB	183.607106690882	202.414225856232	164.942008471332	163.614536956921
+KRT7	10.6143361717877	9.42299404506042	1.52860645229135	2.08860357978643
+GLUL	73.2924055276477	70.5745451668881	167.836154288379	164.708748839296
+KRT8	177.674592237015	170.140068918274	86.0535275560603	79.1073740309155
+NLRX1	7.76482102310629	8.23620489529551	8.61210661625393	8.87229294779666
+VPS45	7.26787784439713	9.04442744394242	9.40974106137658	9.48455216616009
+SRPRB	28.7157409949337	30.0781412260209	22.764330093084	25.6718809330068
+RBM8A	25.9587139117452	28.4121157457581	35.2669408052121	33.56658425038
+SRPRA	122.869913787197	128.816299327919	108.024619751145	105.955011360999
+TALDO1	80.9514908647053	69.2512733279015	69.4089252702687	78.0366391507369
+PGLYRP1	0.306285721166918	0.398309851059885	0.27275694995289	0.532239625935164
+EHHADH	344.673451380902	352.46265992912	317.689864121286	314.444011277087
+CAST	32.1406292401761	38.463799194025	49.236074860295	44.382176544649
+VCPIP1	8.16975718803256	8.10534075715221	11.1247248167971	11.4782877197701
+ARL3	30.3935052980604	28.8393499884189	23.0845329852236	28.7214236264465
+ENSBTAG00000003523	45.2635014371261	42.7833762814734	139.554414607733	140.636760888034
+EPB41L2	19.8859118918539	21.0205346501446	24.9083777377921	24.0005546980718
+EPB41L5	17.7976250172803	18.3167373319711	21.8665658316818	20.0064079418271
+THRAP3	45.8381074333885	40.7671327784696	48.1969785701551	47.7255989676176
+ACSS3	77.1834018320601	79.5635771624491	105.647102529185	107.874260816178
+ACSS2	55.0811633563026	57.3682822866631	13.6384000535754	12.3993797238629
+NDUFA8	60.9726279342233	53.9293113306046	44.2487957140513	44.9480426584674
+NDUFA9	44.6303126581316	44.3811193656566	45.1970755888405	44.3535846590977
+UAP1L1	7.71160104439764	8.39728700353465	6.36327212737617	6.43819322097666
+VPS4A	46.0230925254958	39.3164822807516	35.2361903863122	33.3275845885829
+VPS4B	16.3031079414598	17.4974136812618	21.1547131134337	21.3090912678599
+TARDBP	39.1576302217017	40.8162691932239	46.5156792615457	46.9270754925124
+RAB9A	27.2884943261745	26.7547605043245	25.0120032454061	29.4092355671113
+CYP1A1	443.899667555243	425.353424933626	538.602541270491	543.974061642154
+CYP1A2	1712.94255994408	1695.13136780727	1892.36800791136	1904.7017615886
+MTR	7.26503158991253	7.11442495892321	9.75525307923587	9.4553737455498
+LGMN	403.59885776665	508.113066543034	742.166541055438	681.613138779251
+GSTM1	233.935030978651	231.590878163071	643.684679976937	623.360715109503
+GSTM3	380.175451710196	383.8041405072	596.347855935607	565.102335028194
+AGXT	76.9307419582239	72.7453294967533	76.2014885678422	77.8008372388022
+FARSB	30.1694868322304	29.0886418670674	24.3049468420069	27.8309594923758
+PALLD	3.21342857432873	3.53476526437626	2.09596048920819	1.87866458391469
+STX12	12.2866322632326	13.808164770057	16.0159566206302	16.6778734449686
+BLMH	33.6831024616265	30.3610744835523	38.3951134132686	37.6743452774858
+STX17	8.0090607202102	8.38021024964989	9.42333864618234	10.6331719145541
+EFHD2	23.9406573909224	19.210727800325	20.4579489742126	21.1754495297849
+ECPAS	23.4961957758673	23.0375138590539	25.6029837954262	24.0401182104356
+SAT2	35.4258650293568	42.3125233284582	40.9798580121844	42.6891871517284
+COLGALT1	14.1450218704896	13.6174411602918	12.3686719919197	13.9735242088829
+CUTC	25.8801448189538	23.6285150997845	24.4066993459989	26.1872977101469
+GPRIN3	11.7930484074464	10.3858341729735	8.57716682880559	9.65318872893883
+EIF5	81.2421900161006	87.1618406539649	120.897484112723	118.089344374093
+EIF6	45.4119598431191	39.7629909315891	37.6532730192512	42.4391878569412
+PDCD6	31.0390251542234	25.8189967212042	29.0736401351352	32.3549412353386
+INSR	11.1519635330785	12.5248924547245	15.7292231765415	15.5317652269998
+HIST2H2BE	128.671959967897	128.599399576766	231.28653332908	228.414237336389
+GNE	36.4126998250622	39.3953246059016	32.4425250590848	32.3549412527921
+LTA4H	17.8212107299761	17.3741864401897	16.951605530818	17.4975192823876
+SPTBN5	0.105293397282788	0.311206137751401	0.157412427722463	0.179459705128839
+SPTBN1	85.4342472068267	83.5803913612639	82.7958822141318	84.6962313459788
+RNF170	76.9358965517475	77.6305444845545	84.5153618512971	83.3899372284203
+CBR4	40.380488223499	40.5934013228527	44.8045729189248	44.0926570141464
+CBR1	450.058066733913	437.149207881359	306.72691715598	310.569929892312
+NSF	7.63741313574406	7.97845640008284	10.3345732490862	10.5292007459013
+TLN1	37.8573234474103	35.9340273142161	45.2624396436996	46.4904833967905
+DPP8	23.5670908117968	25.4519293471639	29.9501619230439	29.8021587827566
+DPP9	8.79198936609015	7.9471403852368	6.8205905095014	6.58529839955077
+GBE1	31.0981990876793	30.3339933337954	52.8352902056074	55.8780002476793
+DPP3	74.5816200894726	69.8069259057225	55.4029626596484	54.404525717796
+SUOX	69.9750129098994	74.1447137457669	35.520914921309	36.1279257092413
+FDPS	168.508949393078	166.222491621599	53.9694040636652	53.4189226654697
+DPP7	30.5771144461343	31.5387153515276	31.5244149912696	29.6539651855152
+PCNA	32.3751738086243	33.8650091592008	26.6420266635535	25.2061922983274
+ANXA3	33.3306962685079	30.8335619206099	43.3136361664653	47.5673069013433
+ANXA2	164.723671962807	162.258669502639	113.744222095844	118.605528539905
+ANXA5	22.9553637697725	23.436727937923	19.085321355623	18.9210629732804
+ANXA4	299.63502969593	312.600094901225	361.189262557472	376.995534914541
+ANXA7	26.1461749741735	29.0767347069687	33.5594344150329	35.4497988844126
+ANXA6	327.924598477858	324.894474489593	367.891551743615	361.933220243367
+ANXA9	15.6712182556697	17.5415063290891	15.270935745688	13.9909315383123
+MCM7	30.0771825102943	27.9731848723569	24.0156383886894	25.1037325262421
+MCM6	11.4507999121514	11.6475441556253	12.1865506738817	12.1536835104322
+MCM5	12.895537270858	13.7679272209016	8.99729556970095	9.37542433488583
+GCLM	49.563823447331	52.3842664376996	53.2851860839546	48.7282699955746
+MCM3	11.8043417316323	13.1241478202336	10.0659697536689	8.69323649899029
+MCM2	10.7884756708815	10.9824207040605	6.73530110462466	8.15292782784232
+MESD	45.2073530885482	51.4055365699161	43.2751419493926	42.8911609830404
+SAMHD1	9.87601403936964	13.2224529275359	16.175095705697	15.5717278010429
+AMACR	125.900995217333	119.723871071229	102.420956699298	101.648173571527
+DNPH1	42.3106931787044	45.3957085778143	37.5904857573449	41.3487379287758
+RPA1	25.7446781992929	24.3186990145693	25.4087830091423	23.8092056700958
+RPA2	26.8169652084513	27.176249279213	30.2206952721277	29.9782321054014
+NDUFS1	50.9131433544962	56.870791517286	49.3076230582132	49.8245169840024
+NDUFS2	141.356940674559	148.787701316479	124.765993407787	126.122315402446
+NDUFS3	64.8104079676586	69.6185410694643	53.297872416595	52.516759800929
+COQ9	52.0898490205684	45.5527591500852	33.5681972079694	32.6296167658119
+ENSBTAG00000024700	13.9427368441999	13.3413099439875	40.6443219356815	42.6540704008321
+NDUFS7	71.5767359980036	77.8601813009976	58.0608806354797	61.0962587086881
+COQ5	16.6952559028035	15.6999811317943	13.1497099581853	13.2159938909836
+CGNL1	27.4971722491166	27.427334013067	44.2059628407178	42.4493365316552
+COQ7	14.7282831315524	11.8008751719291	10.873816913233	10.2273605599149
+AHCY	1075.7833914108	1036.32503519194	1362.40216551934	1337.60136587828
+COQ3	10.8836458706678	12.710522410934	12.4853160846636	12.3348080808325
+M6PR	42.4810707223336	40.9331114011853	56.8377046794483	52.2443676937292
+AOC1	124.287122225925	116.969121918782	126.552117326659	128.383423360012
+AOC3	82.752325832058	80.9777292172397	119.063933155219	116.20408669294
+PEX11G	87.2694831920995	75.171215216832	62.4988607596056	56.8685272512562
+PARS2	4.68673332954398	5.30457898459843	3.77833973926001	5.0752129175389
+BHLHE22	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+AOX1	102.733468954366	109.961362564846	806.66820101381	800.38889971733
+CHMP2A	67.677709155545	60.9821193132537	64.4621388507266	71.3742386304634
+DHX15	37.7787950290722	40.5166340313269	34.9127338131303	34.8579132675829
+HIBADH	157.523372682206	174.566175649235	205.09820413991	212.469955999916
+ZFYVE1	11.2752520873893	12.4481622608495	10.7110245059276	9.05496567895166
+NHLRC3	10.5610606562933	8.84949592654071	12.6047495372917	13.6911245627275
+NHLRC2	3.26101405298056	2.97943490053291	4.85714908394091	3.99538498357043
+PPT1	35.7925861702565	34.7568355177783	46.1681445353371	43.7370417071857
+CPT2	135.976064870997	129.548095158476	107.475574550724	100.824230812536
+DSC2	15.1939402379469	14.4662394875957	19.3041072510751	18.5531940536754
+DDX31	35.4863679339364	35.3834299570322	36.3098926016816	34.3104597810253
+NDUFB11	130.868120364589	136.261543038474	122.919297261004	119.22502634895
+NDUFB10	82.2753036274055	76.3295278239464	63.6830130206243	64.6583836833978
+PYGB	3.67985487413328	4.27943505208412	2.93315199885531	2.25689882925156
+PITRM1	11.3557100643103	9.92016642490198	10.3344091410629	10.27083965996
+GOT2	275.627465766641	289.021190595176	244.397354626054	241.278368591505
+LYN	16.2391525757194	17.5909905688496	20.3131284952545	18.9463350468372
+GOT1	56.6022365307647	60.4055243110375	42.5011183408445	43.3046383816003
+PYGL	297.898531330771	294.880177758199	323.649741593138	327.770485002234
+PYGM	-0.0769323453192576	0.18923177843539	-0.00517053422262956	0.00684012553343591
+PFAS	6.70939472118538	5.74943018537561	5.04826581328738	5.30314990317455
+ENSBTAG00000017021	13.2822858434524	13.6600779598427	11.8308426531706	10.4426369009846
+SOD2	153.219010653418	151.215867921246	142.052357950188	147.634745414601
+SOD3	40.148183212177	32.4443766784912	28.8093103264457	32.9126527785487
+VWA8	13.6275087382427	12.6862051589027	21.5212763665898	21.9883525283246
+SOD1	1258.46356022663	1313.64373941506	1151.95852088622	1168.77561876479
+ENSBTAG00000017759	55.6661931681582	53.4457869865507	63.2326316589409	61.8193964410471
+SAFB	45.8039633803415	45.3019156452053	50.1069523392496	48.0850156088276
+RANGAP1	8.47630533949733	6.85706641241272	5.69781873761296	5.73970813448496
+EMC10	60.1278692861128	56.926933485549	57.8798737781184	57.3271787808046
+ENSBTAG00000013274	19.5577682790022	16.9625179359788	12.7198905649467	10.4707601038537
+QTRT1	14.7111239310352	14.0623312027342	13.9809446846452	11.9211751560379
+CGN1	59.8959820340656	64.8505768837625	822.322562118294	814.892549682636
+DOHH	6.49865874360731	9.12568204760417	7.37033808166123	7.1466716138784
+OTUD6B	25.5165256032837	30.0592819881018	28.1318873305827	31.2690562887288
+FBXL8	1.57021064865016	1.72548196579781	0.772943404124361	1.00938841846148
+H2AFV	71.2491063702323	68.9436134699632	46.5512294427361	44.9079097628623
+SNRNP200	19.4738627410618	18.9230359362622	22.7970497340846	22.3956303725583
+H2AFY	33.7973049322195	31.7343547421404	33.2109419607054	32.5094461572555
+ZADH2	97.1399818519836	92.8115010239574	103.452702803166	104.739677527632
+NIPSNAP3A	14.5095664261366	17.844026209425	17.4090718175393	21.110845621011
+DDX5	150.53508073967	157.261412029361	161.741313880937	158.718460479188
+C2H2orf72	58.4378866706282	58.0465878006198	72.7303669707528	65.9082313611542
+SERPING1	2276.45172636688	2214.28451466993	2334.93653037392	2360.72775043987
+DDX1	33.6508739371051	34.1300063088136	33.6863330745163	37.5534664947234
+ENSBTAG00000025929	35.507971772993	39.4190065532083	36.1344360082726	36.4983139156419
+UPF1	19.9703314868369	19.5655384471988	21.3143304264167	21.3557673190804
+H2AFJ	93.8221664693598	86.4614150597589	66.4626359742784	59.183258953057
+NIT2	35.6374840535149	38.6378672094194	40.8610685288077	44.3824540378467
+NIT1	39.7218110555908	37.7353527235568	24.1427126852696	25.2951406795984
+ENSBTAG00000031788	4.65435107074956	2.89389650819564	17.6779738410606	17.8883697315023
+TYSND1	13.6877488720825	10.1822307301862	11.5094129970269	11.0625918687686
+ENSBTAG00000031785	17.8646144655059	18.7189837614614	14.3794513437632	14.6523784856856
+NFKBIA	31.8211500737653	29.4691586042785	44.8277251117133	43.9278566081369
+CLTA	104.042237609863	96.535855906566	111.719263521584	118.989426414204
+PPP1R21	3.78209777028062	4.92718293516536	5.34622286995244	5.67632977680842
+CLTC	59.4774548523343	64.088583334139	69.315343705365	70.7135727882897
+CLTB	42.7694092140025	31.2259885301891	23.9498685123986	29.2311307892676
+ENSBTAG00000047121	15.6372002237913	13.9554426669834	7.55498842498236	6.32019396160384
+MMS19	6.74148090551658	7.26789540052148	7.45646382120185	8.55273149071924
+RMDN3	35.4228804299488	34.0565464360632	25.6103035882313	24.5422029560503
+SFN	-0.0963349494882589	0.708094506695131	0.0150851447237865	0.512991546470017
+CRYZ	191.72642283072	208.495239590713	210.1420962902	222.558729204986
+HARS	23.4144040014137	24.9125621123514	21.0163686881168	21.894735822337
+UBE3A	17.4150378297982	17.8684495731657	19.5032409167397	19.8634013875112
+IBA57	18.0521816716128	10.6635899583737	13.0770571008646	13.6886449891804
+UBXN4	63.9340219455416	64.8073921387844	59.3118635198746	58.4496871233339
+MYD88	16.1019936805274	13.298477402365	16.4851614013262	16.5902587375968
+ENSBTAG00000039237	33.962678507336	30.2999325371126	13.6803792151597	20.4923968436393
+MPDZ	21.5550659088513	24.3460489423034	27.7693560448046	29.7726228860686
+TOP2A	17.6398484647668	17.7284884194965	7.6401199915487	7.62634998422592
+NACA	216.758826345751	225.873377986558	219.668502043375	221.928325268381
+FAF1	27.5457477182602	28.7255609327267	28.4339068862941	29.2393495955795
+PGM5	3.14055159468528	3.88513549808029	3.78555928709256	4.54358626707121
+FAF2	13.3631235626173	18.1826012160272	15.3864303053348	16.0232973658267
+PGM1	106.83810504441	104.178556533575	139.285078358258	144.601751869936
+PGM2	91.7832879201739	98.0064269425717	145.61055316558	140.68298638189
+PGM3	5.36581829040781	5.73894902071761	6.22623280659722	4.71028336661263
+MIA3	31.4081906119669	32.9233341582063	26.2559574851452	27.5581911590976
+SART3	13.5947943169208	15.4777337017369	12.7347952360775	12.1718984318032
+SART1	10.6104099874089	10.3541523040046	9.14329630852987	9.38871395151218
+VPS41	15.7221967265523	17.3578157592108	25.9025727354923	25.7578205696069
+SLC25A42	40.4956391966204	33.7013320146768	26.2217374913245	28.1032983682868
+BCAM	73.9602492862762	68.4832393914644	56.0298387242394	55.4885235698296
+SEC23B	18.4204844663377	16.733244357285	15.6486816376737	15.1741377945215
+GLOD4	67.7350388070704	65.3898284071843	82.0273881353335	75.8950309020101
+GCH1	28.7442316845179	26.6260788796454	23.7634372647621	26.4101999445856
+ENSBTAG00000004632	32.6137859075936	29.3241004390034	23.1434789089707	22.6222072476627
+DBT	47.7341195182196	48.774786005712	58.3875947324081	60.3747146600391
+ECI2	214.054684068514	191.153260195821	205.689891380882	200.799103048577
+ECI1	249.711998507453	246.378204970446	277.28002143386	267.783946535384
+HTT	8.21557440157481	8.17671823043362	7.5411152875953	7.43799013037993
+NUP155	6.27149394128322	7.68145339800434	7.96923278536158	8.84437907267453
+IPO7	26.3553887632009	26.8123921625124	32.4000009340567	31.4253653937539
+IPO4	6.07273134195166	3.74646251576061	4.23242549148284	3.45091396440679
+IPO5	66.1701618388335	68.9249532438128	88.888525220087	91.5477553886893
+ACTR3	49.3235903755028	52.9464264676339	65.0015511619401	62.1023252326438
+ACTR2	52.962946845363	53.592566504524	70.3580399484652	75.9645372743112
+NRBP1	34.588575115151	34.0729560130648	37.0425586245903	35.2728160636513
+VPS11	12.0156919785196	12.321758368833	13.6931354239811	12.5067496194385
+ENSBTAG00000047815	1914.89456712222	1826.52893508468	2698.8804439788	2663.4886871732
+SDCBP	117.011131773351	118.164693966374	95.3771238570286	97.1388018104789
+CARS2	35.4496472592801	38.8250862497742	29.1529652470442	29.9475918803669
+CASK	4.3474459788588	4.55134344894944	3.82122554953055	4.55967928711654
+ENSBTAG00000009029	23.6233642958436	18.4564215854565	20.4833926025748	18.3139508200565
+RAB8B	7.45007197079153	8.40200170768099	11.2176911552558	11.3406984880565
+TNPO3	13.966668431471	13.0160863235972	9.9637921672025	10.7686336104246
+RAB8A	39.510212707651	36.5908055694139	29.1569942481081	31.1169845669939
+NAA25	6.23487817285695	6.36728448050951	6.20518990908178	6.15250777176107
+ENSBTAG00000032899	86.049166873706	67.5311644963553	62.3016390245488	69.7285228189408
+POLDIP2	95.8293803680038	94.3638421154156	96.7891518667553	96.5475650827064
+MARS2	3.73243645211188	3.96912529990429	3.82016258981908	3.93912551946043
+SCPEP1	77.6735604769274	78.028657653609	123.100914675852	121.974918846306
+MAPK3	15.2601694058016	14.6775235091189	10.1899148572533	10.6224117238592
+MAPK1	33.2305991366516	30.8778082388604	39.5644027700186	37.2658147308851
+ALDH18A1	18.7105816416791	20.6396121565089	11.8149376717101	11.1474910428878
+DUSP3	11.6496074943803	12.2441487374417	13.9359790110954	14.8470649151555
+SHPK	18.0821238851871	17.86672233679	23.5248615698827	23.3618464185427
+DAZAP1	37.8799959922539	35.1017600879671	29.7070405517912	29.7533586095969
+PHYHD1	43.7640725851585	37.9154305729229	55.4423437539559	51.8159793147709
+COPS6	58.5072403458031	69.899403876857	63.3172580003413	57.1996572980885
+RDX	52.6114337651328	52.6383755468234	54.197390700969	55.1147680352122
+FERMT2	33.6563829957111	34.3396695730615	33.0263000103357	35.4440989781716
+COPS4	21.9027116951481	26.0631455003078	24.7749027495421	25.4020728201235
+GGCT	14.1354791001096	13.7306956035679	9.37381109444689	9.72912619972028
+VKORC1	244.598024152129	260.708785290349	322.425876764236	314.772096966896
+BCAP31	205.576206057289	203.797581185292	184.744358268161	182.189194472508
+VPS35	28.3515055144866	30.0703266555904	35.5157165214611	34.1579707262157
+WDR91	12.0015961797457	12.1753528734745	13.7798343105851	12.4640100528449
+GLB1	24.1186771013819	21.4963637300747	25.4394109602212	25.0123146402644
+DECR2	234.498467252074	218.584994292019	216.701219333293	218.137855982775
+STAT5B	13.400427909547	11.5227065237043	17.2319743558418	16.6496102976457
+DGUOK	23.5663100186018	26.7228852019182	26.322864904498	26.6542216911251
+CSE1L	19.0651511666332	18.9337096350393	19.1241954346929	18.48653575763
+XYLB	55.5269378923534	53.1366763951751	81.6654146460998	80.9069213191195
+TBC1D17	13.6058512642526	12.7791142260874	11.3584127022527	10.913843300906
+FBL	23.8832355116646	22.3803330562889	19.2812957474872	18.0673032216579
+RPL35	424.031485648653	393.001117108773	360.099003700202	364.4762514406
+NUMA1	23.0880065188302	19.5328025194935	21.6247122004114	21.6364161871588
+PMVK	46.0953044695285	47.3419722831166	45.1591379970778	45.3221105710339
+DHX30	9.24769956280675	8.93721297521457	9.83587875804571	8.70152254996966
+HSPA1A	269.787667094603	251.62731274422	151.967281979127	151.411924088173
+ACAD10	26.7656413487035	27.1422180359745	48.6043692940848	47.0952799880001
+ACAD11	53.9998408989374	51.7309397173514	70.5512088842909	66.4501527074877
+CARNS1	15.6302265518341	16.0248747143022	11.3198373520649	10.7329281750751
+HSPA1L	0.745640524782395	0.909313549921272	0.583470486473317	0.708626880529932
+IDH3A	7.98267611204176	8.59905183254676	6.26930684691533	6.10716478232173
+IDH3B	73.5787024764148	76.6955142250045	67.9649117515735	67.9225303369715
+HCFC1	9.71268088516249	7.96676510401859	8.41291714497422	8.18721694125244
+HAGH	320.7643502379	312.845433510488	369.020940733264	356.313873331614
+PLOD3	58.4839679218677	56.0555857844664	39.7814005583258	36.0023821210492
+CPNE1	12.6584851433062	15.3308487269693	16.9940715379856	18.0956854823587
+PLOD1	25.4993363509329	22.7168297072226	27.9973099100409	26.898082884018
+NRAS	21.062305878805	21.8364993205667	22.4184696010274	23.8798120231592
+DNASE2	23.0060626572951	17.9502746169507	18.7487874682989	19.9613073636686
+FOXRED1	247.949400068112	230.423744158118	241.680842707501	245.408309677521
+PXN	17.9686453778687	17.4658525963449	14.9077565941345	16.038192587493
+G3BP1	42.3631049415128	38.9104119829863	42.4684767499064	42.7866899931716
+ATP5ME	353.469370628812	355.115755786409	265.308687030963	287.535871367604
+UFL1	11.0830041419632	14.3944034345299	18.7493671424354	19.1103876787092
+RAD21	45.1066142155301	47.0146701935376	37.5060685919954	38.9470121282241
+USP13	0.275238628793402	0.597230149983868	0.832887629950203	1.13256037078046
+ALDH6A1	229.868536315757	237.42997240001	327.836632218327	325.082053837238
+USP15	14.7313553673598	15.9566693668984	17.3948503622875	17.3400488070756
+SNRPB	56.1619731611772	52.1524904081311	39.6830594154143	39.8775323923097
+SNRPA	15.7769976314685	15.91336966994	16.152232120541	15.204107592499
+INPP1	14.5153103253809	15.1938151008945	14.5161673833787	15.1090825629054
+SMU1	29.6912275425723	27.7397382417829	31.5369443617382	35.219155278466
+AKR1D1	272.776873701169	286.136890053903	396.580420859608	384.327656269065
+TXNDC12	59.8893200171482	64.8618765837679	63.898332782617	64.1876815429761
+LYZ1	-0.0791865853159649	0.131950374533308	0.171057817999771	0.00933507405476486
+ALOX15B	5.90597239295678	6.64600921505115	8.91429322014961	10.4894722762914
+PUDP	8.20294617120969	6.92291387945383	5.91452581587276	5.36723363299174
+SCFD1	25.3953776576008	28.7260751714317	26.117264513947	27.7983890947664
+SCFD2	14.8099688276845	15.5152629667191	14.5649305008591	16.6987823344383
+PRKAG1	39.1939294064121	40.4711391343886	25.6325420662137	27.7878243476727
+ENSBTAG00000033457	18.3643717601474	15.9427632893241	17.4396460141839	16.9375190111486
+OXNAD1	8.44374448268986	10.2522524603183	7.07022019916684	8.49731092547635
+OR5C1	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+P4HA1	16.226135794672	16.8902057511662	12.8499006631271	15.1163427356115
+ANP32B	156.413158557593	148.055175300332	197.661655659312	187.283829181702
+ANP32A	43.3393416051972	41.4532019130243	41.9735295808989	39.2689563573176
+FDXR	13.38130604377	11.9678987901052	14.2547230161169	16.070299898422
+TYK2	17.916728597918	18.6132924524872	19.9918698650355	21.1583301189447
+TAT	312.635085955465	322.882100227592	399.850669778947	399.025515351158
+SUPT5H	27.0309880502502	30.4088766967618	24.5851986356352	25.6086039261571
+NAPG	15.8586773767002	15.867244718366	18.6888015046724	17.3810188850619
+NAPA	44.4273080599416	38.4604605383033	37.4563715208489	31.3906094012176
+THY1	2.06688196006302	2.65307666238319	0.238813469976397	0.25559446030567
+MRPL58	38.1602957762955	35.6843938429714	33.9022095506651	33.0755835333021
+CDC42BPA	5.20061572065387	5.65462185434249	5.85087253904838	6.47418625939765
+LARP1	30.2230349543118	26.4890485792889	29.496503224176	30.6023512171672
+SF3A3	13.2814819874267	19.5421581404608	19.9684501511313	18.4348438263926
+SCCPDH	75.1189543171997	88.4702602383857	104.995829525089	103.943472925424
+FXR1	35.7963199133122	36.1702086397207	34.9800897733499	33.5203413906148
+FXR2	17.7997161488082	16.3221969985267	15.6028274030886	14.9018798301877
+AGXT2	76.3330682487137	67.0619586697834	128.406507266834	122.84393586023
+TNS1	8.05464576772701	7.34207938928769	8.52471448341095	7.79937443643016
+CNDP2	168.943055039002	155.712548305087	128.142519589125	137.693124447983
+ISOC2	279.120450643257	244.819753076326	212.067367063981	197.989625291036
+NPL	4.26733602150732	6.64288844308209	7.93848833288657	7.81428954774587
+D2HGDH	17.1330069309869	15.3412170538919	14.1927388748035	16.2787944173193
+PTER	1.52660879490687	2.66229430670648	2.0456570213599	1.598227726124
+MITD1	11.6730269692544	8.40382298929611	16.1245519550127	15.8409541322142
+LDAH	18.1327944329541	21.2154592226544	23.808010911847	24.8200690652319
+GADD45GIP1	28.8741525319805	22.9320060211582	15.5733162001729	20.3664346068878
+ANGPTL2	7.02581160916126	8.08212901025634	9.59813641412471	10.7519962738355
+ENSBTAG00000045947	228.874846534089	164.472204363617	178.679685533762	172.451894588149
+ACE2	21.1633297909585	22.1612401771336	42.3245830087515	40.1504095905197
+ENSBTAG00000038755	0.890303810104046	1.48680811674711	2.10337376667357	1.77907546013779
+TSN	20.6237145934396	25.0770096123819	24.7835516598695	29.0436672573912
+PBDC1	15.0052110785941	15.6204680330454	21.1493578023958	22.6227184495619
+ELAVL1	19.9766125313715	21.4132969886373	19.4958410221921	19.3860801379889
+ELAVL2	1.26627903567099	1.79934921210608	1.90302572329506	1.52802912033218
+EXOC4	8.85004988583434	8.78706656170444	12.8287961797467	11.0747221920717
+PDS5A	11.7532103657767	12.5475050899883	12.5414327908691	14.0748980872679
+PDS5B	3.83826837028904	3.99934301025724	4.65470665025829	5.17639254366795
+MYO18A	22.1197965105939	21.0519495142151	25.0360417343663	24.9129454933122
+GPLD1	42.4981699578478	42.8085074978598	76.4602634091007	82.1480124253853
+TST	691.816469841369	665.802393734005	494.821134446626	496.283477588978
+MTSS1	53.6475357792436	54.0286549863711	85.7889474042031	82.0165981195736
+HSCB	8.42537635950705	6.45569254675281	8.68938315364616	9.48430784956467
+CHCHD3	26.8844727351995	27.1670813272387	22.0879108968381	24.1309085100989
+RPL7A	716.562454728101	693.239868197911	597.993749420658	610.867904961583
+ENSBTAG00000013919	162.06680236321	163.391124435519	281.303999495638	298.28504384042
+FARSA	15.5269383561278	12.2265621784344	9.79438138150653	9.18017010477135
+FAM151B	6.86630748723827	8.7671083295479	8.67164073476318	9.65006507068972
+PAICS	42.5384267883883	48.9751636315352	43.3122102310231	43.7263975470076
+OVCA2	12.0489171296806	11.7804471307654	13.6971254298013	11.9467754976929
+KYAT3	30.7759316490574	34.4595698519317	40.1962011289136	37.5883858923874
+VTA1	14.9000730407052	17.0127105476118	17.0477105279358	19.3219060632302
+NUDT2	12.178668724112	13.1648781700133	11.2819435629191	10.286010225291
+KIF1BP	9.8947853187642	8.34490925065103	9.36703047297306	10.5904844577957
+DLG1	14.0445877897505	12.5653575824165	18.7782275560994	20.2868254682669
+NUDT3	20.0236992850512	20.4422450970993	24.5768516283314	26.1690876521419
+ENSBTAG00000047973	55.8159204356326	45.2901640729245	45.4459719160515	42.8379446657739
+ALDH8A1	165.737996550188	174.448557611868	214.017679136199	209.699425423819
+PPP1R18	9.210099240885	10.3649660491827	8.51922046034667	7.53416272770807
+BNIP1	6.54708368554672	6.61939776777978	5.87377879303622	6.56224011941991
+XIRP2	-0.0761500202387796	0.148768431771444	-0.00598725580927131	0.00597426351094174
+MBL2	692.454521865675	673.167947103898	781.202585196523	779.593918835038
+GZMA	7.18555342468225	8.19486299609431	8.02515307236541	10.9082435377862
+MTHFD1L	2.15908014528977	2.65677605565207	2.57080785242417	2.24055035645694
+EMC9	25.0342376059896	27.7493877921097	28.0366595116193	24.0360052463318
+EMC8	18.3780098214678	18.1300160681639	16.2542641610091	14.1857744903103
+FBXO30	7.19306378757013	7.33383419681894	8.91175494933049	9.56707139041302
+FLOT1	31.675228847069	27.9016216539107	29.8822590628392	32.7028641474601
+FLOT2	61.2135185794843	59.6123369633461	61.1174174960802	53.55706985902
+EMC2	49.5931131643632	54.5980341810805	52.7020579481873	50.3892871822289
+EMC1	16.0180607575666	16.2103847127139	15.771427872736	15.5986589193972
+CNRIP1	5.54807426390459	6.11431408850286	6.43977886374382	7.57326683618093
+EMC7	77.969064124163	71.395856349921	86.0272111680281	82.1694532245806
+MYH10	10.0424972480164	11.0336112245796	11.9582033677161	11.3377931990329
+MYH11	9.54526719697538	7.97567792321246	12.4759936458325	12.2829979572714
+MYH14	34.314147615669	32.2896025021737	44.9870143628713	43.1291987112099
+GNS	38.237035406298	41.265487694016	65.4294459699096	63.5654185132283
+AP3M2	1.49782630742806	0.634787745255	0.96057261620705	1.3437219776556
+SMG8	3.42942015551812	3.32948325360438	4.09795959293307	4.55673438609611
+HTRA2	16.1158005729517	16.9573470310132	14.9753872310936	14.7072170450256
+RTRAF	144.336433784021	145.395233195248	168.823297201046	166.77200558296
+PIK3AP1	26.6016701370613	26.8706247633894	41.9838810086615	43.6175774808822
+HINT3	15.8364298753516	18.206633671654	22.4491049291387	21.8330314253157
+HMBS	28.632254359892	27.0605874638744	26.9188252336884	26.0717176004218
+SMC3	19.0261605826906	20.8060073984646	22.6410322521543	21.3332705608157
+SMC2	5.22845758071772	6.07343967691474	4.73752304037056	5.14747858170804
+CDC37	64.3929065579936	61.913064486355	74.0834418372789	70.7212997265451
+ALAS1	115.151311365731	117.564034533738	188.101611007038	184.892687742198
+ENSBTAG00000009788	66.6716065398352	60.2745299885807	60.8189980141157	57.4379773775794
+NMT1	16.6263632182399	19.8180755552473	16.5355619763702	17.8778171373445
+KIAA0513	2.25546082683113	3.40155218045331	1.83057803025047	2.18875890786124
+CPOX	43.7262357492148	47.9594285073224	55.8309454370466	54.8475316136716
+GRIPAP1	13.5672267054925	13.8275267856184	13.2981545786103	12.0738173148676
+TNKS1BP1	23.7226340255756	19.7916498294943	19.3870739913957	19.6005624791865
+LTF	10.3084872927472	12.5679847138765	2.30029510717804	2.92694790516449
+HIBCH	45.0253869917549	44.706247216597	63.962113850094	64.2069576428387
+LASP1	51.5960615471965	49.3791038451155	41.6664430364045	40.2693185720373
+AFDN	14.601516193562	14.6907632670863	16.3270983281382	16.807737718302
+PGLS	21.3143763864552	28.4281764687648	17.6100151290137	18.7371659804247
+C8B	584.708425105681	589.934500705681	805.991833122348	800.275215216112
+PPP5C	25.7239620604616	19.5444846670231	18.8173510691401	17.219718214928
+LMOD1	3.89684747844057	2.58521281765856	1.98254722658432	2.20486794867369
+GLS2	90.6882344914224	87.7774139289737	44.3225653611859	42.7323821279058
+MAP7	15.1013959736674	16.4561456062753	16.5496709733891	13.7816709377647
+RBM4	49.6437292819515	48.2618384299899	41.35334339525	41.9300732433284
+GALK2	9.75121408205385	10.800225316101	14.0168225909383	12.3725640922194
+RPL23A	5.45836351912194	17.23416893446	0.689583398455034	11.9182959545004
+SPCS3	47.6611040990013	66.2068179781569	48.5553527980865	43.278804483277
+ARL8B	32.1411742513569	39.6606214713402	39.6217613999586	43.8660224590803
+EGFR	18.2993414471952	18.0597191447969	20.6242005177636	21.2302943791021
+CAT	3043.50616857322	3290.12459735644	4103.40586418831	4069.54420624465
+ACADM	460.844151581568	471.190802190025	554.240560825634	567.411278729941
+WDR82	29.1717843119969	33.0869586713391	27.2258085467776	26.8902209902222
+ENSBTAG00000011511	14.4748992268253	17.2478033894467	16.4148310545917	17.795936033628
+CAD	6.13118779650012	5.92388540082527	5.49075417907794	4.91740602041326
+NUBP2	13.9584158469089	10.0465298220048	7.75053843772039	6.70447457157033
+PGD	27.803762722824	28.9698405619714	19.2165523511764	20.1090946223767
+DYSF	8.05211567286547	7.32127858727145	9.62201999338516	8.43953636020681
+VPS25	85.1639692932175	80.9779055316256	75.2576841878936	78.059880917959
+DYNC1I1	1.12405083373023	1.57811736229263	1.3975737412591	0.833401635473123
+C29H11orf54	98.2518450666073	105.806457287064	139.906489028691	139.969777056134
+VPS28	89.1867140887223	79.6191625413365	87.3319384221159	89.2955925226863
+VPS29	39.1129337506061	52.055587948604	52.0876556424385	50.5797101560396
+NUDC	53.4168915395692	48.511659872358	45.4088477483401	50.2864023470896
+ESYT1	6.56885975463931	5.9794391051439	5.95556644910963	6.21322589929178
+TOP1	17.9413089222926	17.0843333752423	22.8222843602739	22.4716802347571
+PGP	16.3011630943011	13.6197612938371	5.92179130135984	6.80225928241133
+ENSBTAG00000047700	5.63372071555166	6.90791249774946	5.57740321762006	6.45101798641369
+PTPN23	7.59365718306159	6.66732240133969	6.46370644326997	6.38238521705865
+COA7	10.1336219699518	13.6216450242057	9.41704550537074	8.71875783909898
+TMEM214	42.882540023939	37.0858758078196	29.5938399501398	29.6664204724946
+LGALS3BP	259.312287275707	256.189369706832	172.9705660128	179.692502039848
+SEPSECS	31.2598147182094	30.2295989859232	47.9051957464545	44.3013635827781
+PLEKHO2	7.13624183248456	7.83420722644858	11.0851408075128	12.630876034533
+PDE12	4.43438730317842	4.12903803419116	4.11170154395176	3.61524996113017
+EXOC2	9.80001792685146	12.1179731300847	11.8133455818426	10.9569109941749
+ARSB	4.19208066997401	5.26835172101796	6.25634735463443	6.84993212958509
+CA3	200.50286674435	201.529477131609	383.542978272754	372.123286920197
+CA2	4.28857278985168	4.71910519997514	3.34186084477428	4.34343755481715
+EXOC8	2.26233733143659	3.64009551293126	5.25464235132341	3.34250327956854
+HEXB	22.556231193828	21.828233383309	31.8368485939138	33.7851127487918
+RBMX	59.1571359759493	61.0362441362078	73.860422392453	73.1004799975219
+ACBD3	12.0573857089373	12.7488087239471	13.3178402205299	14.5761238746005
+ANK3	23.9246949087038	24.8005618993006	31.085911290525	32.0633167207318
+ACBD5	54.9224167240282	52.4946428066308	71.506654491822	69.8229135924418
+ACBD4	28.6060197073528	24.6880926872964	19.9638067757714	21.0512223773584
+MON2	13.4187592329722	15.0428472956015	17.2981940908923	16.8342317802328
+BZW1	98.4201826611042	101.870279881068	99.4614346589457	102.399670582266
+EEF2	464.873006205065	440.631162659564	522.026595660998	517.930663268099
+BZW2	11.5952412368381	14.3153964746484	8.64683022275341	10.489081301486
+PDGFRB	5.74724391377519	6.00566356213018	5.08742979883997	5.22814266855956
+GSTA4	107.923912074506	103.029470989961	154.743621511414	148.31367620496
+GSTA5	2.58280817622381	2.16879730206223	1.21669786459656	1.22740170771268
+EVA1B	19.563052974285	19.7454383493801	20.758125181339	20.2347994447742
+UFC1	65.0251565954642	59.8574217366757	72.1390318431269	71.1308753247691
+GSTA2	746.165690027507	760.998427529931	893.01019903362	881.497799194092
+GSTA3	2194.26943875842	2151.19929340886	1742.03238343128	1750.81749807887
+CTSB	277.529282895953	262.097250048635	369.477036183516	375.196406008177
+CBR3	4.68174074496991	2.90972335152856	3.80876797581614	3.95200186850223
+ENSBTAG00000012096	141.353130437225	137.392960462823	147.817200093637	150.235882465174
+PYCR3	26.6337799060266	23.4078075450408	20.2782299408329	20.121150107428
+PYCR2	13.8970209089096	13.0619985614703	11.6647567579557	11.3727284403322
+FAM234A	18.1354438980281	17.229181447792	13.4165937373404	14.3952233364429
+RSU1	23.6863625828217	29.3802705384851	29.5815599917143	28.371728190695
+DDX39B	83.5001189404008	87.6720905213936	79.8341536668904	81.1028785059972
+DDX39A	29.9893582363234	26.670285962177	32.5532123589436	31.2519371743461
+ADAMTS9	0.461399489204719	1.03241458394676	1.20274367225382	1.2307546275034
+STRAP	23.3579343570105	24.9639482071855	21.4965142899058	23.1945900449521
+CBFB	9.83904558031536	11.2885129639892	16.0033111666979	12.5999672327801
+ENSBTAG00000014567	29.9455027795893	28.0392974221504	32.8366040630885	32.3253791128518
+DMAC2	21.258374419596	18.8866371616887	16.3079991458764	16.8680807039819
+EEFSEC	8.66630368922915	6.73379875337805	7.80551548916725	8.20124246162128
+CDH2	52.3716337776693	47.871330141565	45.8575352794363	45.0653177186628
+BOLA-DRA	269.746300611459	273.599019304188	449.29074642074	437.240156990022
+ENSBTAG00000022715	194.954587809153	185.128285510435	117.075768166606	117.275128242666
+LIPA	55.9201062998632	54.2755852407464	79.0904828262186	76.8227985915992
+EIF2B5	20.7314187941979	18.7782936948476	17.014598011362	17.4500556673231
+RAB5A	24.326517083206	32.4932060896124	36.1037826604373	36.1072479342914
+RAB5C	66.1240710703252	62.4897608188321	59.4728972964248	60.5602680349971
+RAB5B	34.7153665154458	39.9185065552528	44.6292797682759	43.2545278941998
+SEC24D	34.5627031001292	37.865355101177	22.7576180677007	22.927613269238
+ENSBTAG00000019516	1593.42569168947	1475.40754102913	1064.54557083712	1022.63957911623
+PEX11B	14.3289325296461	12.3172380631616	17.0934113512467	15.3556924761085
+SEC24A	21.1913145513025	22.6411085225091	25.1542308694847	25.4655163909051
+SSH3	13.2399324422478	14.0419298442952	11.6393403208284	11.0694049974257
+SEC24C	44.9473492302388	44.990282878581	44.1869425299255	42.6379136500773
+SEC24B	15.2643910793443	15.9978756759114	15.7842556232459	16.8623553638853
+PAFAH1B3	4.22414995051723	4.75245070298287	3.0568538214363	2.07419913846492
+PAFAH1B2	10.2959121016432	10.5214496934152	12.7203033993658	11.5738716841611
+HOGA1	119.29743718086	105.186383842129	68.0101936801624	69.9896036260331
+PDXDC1	27.8376593718009	27.3256138451865	29.0216207008965	27.8662139613178
+MIF4GD	39.9333339691813	44.5361193722865	49.9681367782293	43.7426922539626
+SCARB1	63.76932559426	63.3647829781403	37.5677711771305	36.4784509732474
+AZU1	-0.168766967791324	0.271787770038126	0.608567783367161	4.25792088067845
+PLEKHA4	7.64457247680194	7.64370592718686	3.26989216334445	4.49751784801494
+PLEKHA6	21.7653603037882	17.7486360365284	22.4102150789175	21.9213998869546
+PLEKHA7	8.64523590333559	6.42725573887565	6.64847222342864	6.14912747381297
+MRPL47	18.3294614105564	19.7708224902998	21.9067408058261	21.5258780897139
+MRPL46	20.0629978400843	19.8013812393094	22.3149920326568	20.5412403279916
+ALAD	476.132408558242	466.601757759162	497.227816637707	496.630111752031
+MRPL44	18.1286589264515	22.0991363543603	20.1565358298267	21.7408767789366
+ACTB	597.023464771475	567.094229726717	508.283639734785	514.451111817721
+DGKQ	17.6276724287978	15.7834617007724	15.07793297539	13.6865736106266
+PPA2	81.3551086745368	95.3945806034225	96.9676839444458	94.3722538928443
+STARD10	108.511232151823	105.842155934883	147.025020002826	151.232387385504
+CPT1A	93.45724518619	91.6018867756667	108.351279152493	118.73078286594
+ERAP1	9.1976970377989	9.65071619739146	12.8121519509035	12.769710890077
+ENSBTAG00000023939	1551.04184545605	1613.20166307851	1568.73058560263	1548.91483462648
+NMRK1	43.4174837843657	47.0209374228533	68.0416833239088	65.6333078832547
+RRAS	16.747358073746	11.2466461750735	8.08080923813226	7.37937857834195
+ARFGAP2	23.9178549853905	21.6018030645818	19.8226327745419	19.2998638852488
+ARFGAP3	107.657693422812	102.924304776232	87.4463397618231	87.5470830332536
+LAMB1	17.8314710998546	17.5071012743703	11.8372887719559	12.4196642006376
+DHX36	11.0812839673695	11.7939233409708	12.4994168075923	12.2445642109765
+COPZ1	42.8643593009195	44.0091262280175	39.037375209072	41.8838925575294
+NEK7	7.00203343128985	4.7401467204656	11.2385201701388	11.678370806126
+DDX58	15.9466038901161	16.1155481779031	16.4913742502218	15.9944332273497
+COPZ2	184.029755042505	176.236640796662	200.100030494792	216.917346104584
+RUVBL1	20.9850902426134	19.7343833271478	18.2222380356119	16.6097693219375
+RUVBL2	10.10349527469	11.7323713197849	8.24964604733889	8.80380226129257
+U2AF1	79.0225596857751	65.9037159399053	59.4520615672312	58.402123021419
+PLA2G12B	68.214827846587	73.8632204821886	79.8439640043979	88.3239149761369
+ADAR	19.9172442585958	19.3360158984386	19.1943577126566	18.2747800617694
+NEK9	18.5121898757576	19.3162063600013	22.1740883811258	23.3054344045816
+GATM	1451.70619846257	1531.12097581928	1688.58615102444	1655.55893450301
+ADAL	5.2949046022207	6.09538183991149	9.70073930745554	8.9506143826316
+SF3A1	19.4064252370544	19.5497371961641	16.299397330698	16.0801201972793
+CDC42BPB	16.2853683607784	15.5625538426832	15.2719614540943	15.3256226927902
+FAM129B	5.5781468477214	5.9319714747475	3.39794433269901	2.99654046915471
+TXNRD1	18.8910911747571	18.9334181531627	19.0201244307085	20.5856277298196
+CAPG	6.1577307043204	5.98868293221782	4.43070791083378	4.07824198209847
+ENSBTAG00000045566	-0.100636525687332	0.481398239656842	0.647550848430002	0.338959446459785
+TPT1	4167.96247295675	4364.17605555881	4214.18264356917	4112.72310414556
+BUB3	41.8148850031452	44.76915695045	34.8090720590334	33.4411922482451
+ALYREF	19.9029461999935	22.1567964703724	16.7983855634929	13.5709073490524
+PEX16	18.9464146158561	22.4602231849199	17.4453639022667	20.3675529020563
+ABCF2	11.0408273926693	13.6730729123146	10.871915799766	9.58307221873345
+BLVRB	235.809716527245	218.009721473805	199.136190755556	195.899646295322
+ADSSL1	10.185433438194	10.0022388734457	10.9262795009281	11.4691439687937
+GLTPD2	55.7732278177319	50.350797477041	32.9372277866993	33.6893327208316
+EGLN1	24.0317041751955	25.003596829216	22.2487521189855	25.7065533315377
+OGT	23.5532056144214	26.0613894691983	31.9383321303467	32.2511078883491
+MTHFD1	249.862799908138	260.387087757432	224.558973225771	224.264397982218
+YBX1	311.150043121433	313.959622514081	312.305636925062	307.799054556906
+IK	42.2600738142463	38.2609890622335	42.7405259082495	44.1305649638424
+C13H20orf194	2.50195381249191	1.95149861802315	3.71553108019402	3.36896055289964
+ANXA1	32.9433357467567	29.8281850816687	34.7200024218719	35.3133513944752
+NSD1	13.1043955777185	12.4053630044316	11.2691244219694	10.6229135614559
+METAP2	21.9610461744528	22.0177768587135	24.5151438714469	25.2903359586766
+ATP6V1D	38.3251155540862	44.7985862559749	41.1273798700801	40.8029512113646
+CCDC47	50.7916568541861	56.904021246753	53.4415432892393	52.3132000934562
+TCERG1	7.61881572932312	7.68093337105659	9.06109832065556	8.71139378455371
+RNPEP	18.1481792369084	21.0975987114168	16.3629904445153	15.9038234844754
+HSD17B11	720.126650663004	789.440442987638	981.093161015549	986.801507993493
+TPM1	39.6149672090899	42.9448532796675	29.4028023266716	35.6713684593632
+ADSL	37.738584722205	34.9224960591259	29.9779822698863	31.1625153379327
+ENSBTAG00000005146	142.632754326678	146.36350247103	160.247022650006	157.495604717641
+AS3MT	53.6342784779255	51.8329833963492	61.716968079246	62.6767207798227
+MYH3	0.377748603289295	0.678412638261083	0.167016951854105	0.179247312640433
+COASY	26.1115750902764	25.6162990148731	19.8600033670184	20.1381501997898
+MYH9	56.5325205021765	55.2021117388132	53.6173954288969	52.9275893726469
+USF3	3.73258083212244	4.09291722782957	5.01318470471699	4.6622913252654
+NAE1	16.2089803119349	16.2200100011975	19.5023977159276	17.6671568461672
+RANBP1	34.9478105337381	30.7441077125288	19.9048830776794	17.8122094279139
+RANBP3	15.5157765218109	13.3259178718281	11.9182400938753	12.7708104941484
+CADM1	53.6167299973857	45.2465665517338	48.9991185414415	49.5320006272506
+GNB4	1.56426562274267	3.0336373622038	4.0624725987958	6.37859433023665
+SIPA1	8.83511772342155	9.6778353921789	7.31700380320934	7.68419426120918
+GNB1	73.4397198734745	70.3356292224685	70.0507048786498	67.9589439408933
+GNB2	70.3880800659396	67.2627624402296	59.8720959242864	63.2790068801495
+NUDT12	26.8662408330596	30.4242546649299	43.4226718059195	42.5232135271289
+GCN1	8.73753388118199	7.72950258318686	7.6061976594968	7.63710516835211
+NUDT16	17.0766779150841	18.7594759136459	19.0253353318258	18.7237807369695
+NUDT14	21.7305887086463	20.7390277926729	15.2712159048222	19.9467849456411
+ZW10	9.8206403550648	13.3008855163681	11.9964348330285	12.3502028172176
+NUDT19	11.0521265686541	11.5266932395112	12.8082184486694	12.0448433295045
+BREH1	107.038062723323	112.515626585482	69.6885628428017	69.0260649626382
+STX8	28.4226310137582	29.6871561499444	32.8579794838751	34.5885170475618
+RTCB	21.0299665327876	19.8857115234504	18.0915988608337	20.9180262980403
+SDS	11.2792048203494	7.3122946532961	16.6575733290508	18.9569459622985
+STX5	13.2432969574451	14.0396132581579	12.6291160118079	10.9687181811043
+STX4	13.5694620350002	17.7268259318808	17.2205629368392	15.7266602257681
+STX7	13.9343203916639	15.2267517326069	16.9085677650935	17.2878124059977
+GDPD1	5.95673864994867	6.30189261901867	10.3220101179838	6.31239063359186
+RPS3A	1102.2138573474	1133.61431452022	1103.12897690816	1088.79025033585
+RANBP2	11.7456222992426	12.8686371729041	16.6092777646507	16.3759819151538
+POLR1E	8.84664490286323	7.40911599682581	9.03184801932564	9.58710484122523
+PON1	722.84121376508	749.240037480132	1527.5722190213	1494.50425695651
+ECE1	50.96192498049	46.6874896393058	46.8543539887573	45.4353390833999
+ENSBTAG00000046839	19.9704379772827	21.6014019152386	10.6758532434096	12.6527109286553
+IQGAP1	14.094713085053	14.0874041278241	16.3284980009982	16.5895609720785
+IQGAP2	108.195955565215	108.112694694243	153.295822286217	150.276759282708
+YWHAZ	35.7513197103977	33.0056378499006	32.4197826656751	30.5027947218532
+DRG2	21.806658222967	20.7792610904073	17.0530723873735	15.0735069531667
+DRG1	14.4278886587384	14.8313920432564	14.6593982701881	12.1017264154863
+XXYLT1	12.1792664513887	8.76798348012679	8.75550663254394	8.3949924571805
+NOP58	25.5404948860646	27.6887492834947	25.536492343637	27.6419811920143
+PITHD1	18.8327590445844	15.8775641040008	19.338822041748	20.4835429906437
+YWHAQ	87.6021627285568	94.2071569428554	80.6424631121312	81.2659790058946
+NOP56	30.3600371136979	35.0522588379546	30.4314793360742	33.2070684770747
+IL18	17.1966230927025	18.9979553961519	25.8126355923144	24.0430395406267
+YWHAH	52.2746631092813	47.6495137316778	34.8644302140325	36.5642746597297
+RPE	49.0172584294339	22.4865179032657	29.336634699936	26.2583046905056
+YWHAB	75.818204664902	79.388536206019	80.0510401163798	81.5455813959536
+AP1B1	29.3651823302642	25.9299380772506	23.4655960585232	24.7502435256201
+YWHAG	48.2432589715145	44.6536912920625	45.3283521704977	43.9719798880936
+YWHAE	153.789670924713	168.554364894442	176.509489027861	169.480312773708
+CARD19	40.5565702088783	34.8010332249099	29.1240315707088	29.7225429316196
+MAT2A	259.609041007302	272.361507409075	188.111519701177	185.28772254327
+ATAD3A	11.7176365023869	11.6624087831022	6.39011377890363	5.95519116665532
+MAT2B	16.106332062348	17.7150574219731	20.9147667728911	20.1786416725368
+ENSBTAG00000045888	101.5360065608	86.9723270194096	112.021157047948	123.203431867392
+C1S	1465.30564548207	1492.8643850453	1544.58076845833	1500.76866824101
+C1R	1674.18532299522	1616.67922409427	1749.46165032558	1725.4701347112
+TUBA4A	24.2064087946824	21.348041776019	9.37022814075834	11.2092012094228
+CALD1	143.159142736314	144.079409368674	160.587392277131	157.939496406888
+TBKBP1	6.07981493775676	4.866658506718	4.15698467038144	4.87967011842902
+PANK4	5.28010423675179	5.64529285493253	5.25853139771096	5.15330553892368
+COQ6	24.7670319181669	23.2394692002396	25.2508595539399	24.3768253463715
+NUDT13	26.2586693290747	24.701318941922	19.6889881224672	19.2479619762367
+ENSBTAG00000037775	56.5866034455041	60.777939340137	30.8366605500124	33.3381065888778
+ABI1	9.85873244413817	9.155815643071	12.1372287025666	10.5272491250953
+ROCK1	24.6046285531245	27.8511957456694	24.0942721601134	22.5382655302225
+ROCK2	6.33575876567178	8.59683457797186	6.85607059922114	7.35762198336447
+CUL4A	40.7600937635882	39.6779456699511	38.0356104527654	37.7401695193642
+CYP2C19	251.640550336004	264.912902809589	910.867404310532	905.853677592549
+ILF3	13.3286416200016	11.7178025790517	13.272152098537	13.9820611407458
+TGFBI	16.0231514413726	17.3484949740316	22.6544884603896	19.6595792172507
+ENSBTAG00000036298	30.0064153881646	30.2550705738295	30.5395600233094	31.8269187105473
+ILF2	32.9398079127156	38.2943271539656	32.406888411994	33.4427207305576
+IMMT	29.7583495004426	28.6764248242735	24.5600131446648	22.4213239534422
+ACADVL	499.834325892169	483.136365885181	268.275497078815	270.024973639581
+NDUFB9	61.3398961507635	61.9887837166286	52.4649489299104	50.6983993118949
+RAB4A	38.6818005374118	31.396877126783	35.8170975355001	32.7533895916115
+PCCB	103.056891134536	103.58679430511	152.562737125279	148.884885545609
+PCCA	101.403807291895	100.248215775016	107.728706222255	106.114594680476
+FCHO2	15.0094615815073	14.1160220365189	21.5460012244107	21.5663959158532
+URAD	181.437928396917	168.795654013073	113.543661019836	119.653799483808
+FAM213B	57.1964031603454	45.4155298123075	43.0105291215037	41.8914730834738
+PECAM1	18.2109359310846	17.901841389797	17.0119399511446	17.9143103914047
+SUGT1	22.4199411997145	19.3469351080393	19.4072984551161	17.8747817824602
+TPD52	37.4535569935823	41.0490113542293	45.6669922069146	50.3771529613047
+UHRF1	6.13782741005227	6.15997491151925	2.960613703176	2.97079547809642
+ENSBTAG00000045976	125.928492093844	133.810301642365	119.475404045969	113.570037052155
+CLN5	61.2711874947036	71.344534239867	94.058059640302	97.8287476178275
+ZC3HAV1	16.6000391514384	17.2762857621998	26.495240811036	25.704275157306
+CLINT1	57.3729468350151	57.3099971045518	54.6012197494238	55.0691292896223
+ANKRD44	3.83124036886285	3.98688165823551	5.19289922531702	4.87964880913485
+ANKRD46	12.2080456838422	14.0760922388937	16.2915087603436	17.2538621640987
+CXADR	17.7848467863998	20.6446561438112	21.9137482038652	20.3391751118881
+CRYL1	50.4356628136954	46.1901739273595	45.8089250267373	44.7852197684208
+WNK1	13.0549345725011	12.2870040300054	16.2717927559205	17.5818930977723
+ACSM2B	379.700701873801	379.91791697982	493.730228441923	492.952449046954
+ACOT8	54.5629104279831	45.1588128045967	33.4055343247354	31.3126660972256
+ACOT4	15.2882252443574	14.6391614335321	15.1750416398358	17.3876558374735
+ACOT2	12.9022268293266	13.3530953148082	14.7480935949725	15.0572695933055
+SHMT2	81.5831103595995	84.3367990513396	51.1548586279581	53.4594316132415
+SHMT1	499.892552012384	466.070171884811	457.567906212046	465.517094467215
+ENSBTAG00000026758	32.0129132061911	25.0126466018106	26.4189333229507	26.6421928276723
+TOR1AIP1	17.8454934056741	14.5764865804986	30.6593348641338	29.2373457516012
+PLD2	5.52476393781964	6.319230931883	3.91391852717314	4.01219090034932
+PLD3	49.3112855988844	46.398204302993	40.9724962684793	42.4737105476049
+LIMA1	10.4879621734404	12.5857429358066	13.3185905714769	13.4539837845945
+KIF27	0.958625116108231	1.46584741856612	1.14935258311329	1.43522865951815
+PPFIBP2	12.4478078993624	11.7623430296473	14.5588191029214	13.2109471019818
+ETNPPL	36.1217442411747	37.6297500537244	64.9205850603537	59.059968256713
+PNPO	29.4450150585223	36.3621405825968	54.2518006782147	48.7233652690943
+ZBTB20	1.0741269010279	1.10489439632338	1.82835134674583	2.43337829574747
+SRSF3	82.1195532145628	93.6157354569517	102.403336521822	111.954246576419
+STX2	17.3370182368451	24.3975092178476	35.2124054880508	30.2262036628323
+DDI2	27.8754994082985	26.8854118893385	34.1378577699646	37.7959478052815
+IRGQ	2.13971341675044	1.9874238194671	1.76791871541826	1.57975113494392
+HRAS	57.0000873796712	119.311174266392	99.0776768101059	67.1844131314663
+CC2D1A	12.5332425114758	10.3653144339098	7.4613094941218	8.59039811696047
+SEPT8	7.23317808184199	6.79303605369923	6.94181394364397	7.61625766514621
+SEPT7	55.785472803575	59.2791402435722	68.6637177702567	66.388434610262
+SEPT6	3.8816159463909	3.47312890504789	5.04464534110768	4.24266155209036
+PITPNA	18.5629245595785	17.0333919660458	15.3707281154023	17.0376937853597
+SEPT2	55.138458499998	50.1155620143685	61.9264659527804	57.8436724894304
+HSPH1	10.9070154824509	12.8044295140681	10.5829964799565	9.83877250596654
+MFF	76.1423456802817	74.0735513789318	64.1125847320973	57.8429027117005
+ENSBTAG00000006819	114.72770109981	115.227908124335	144.78330705169	144.67701559681
+GK5	211.423087900709	217.687281761935	192.269483782548	186.015083268121
+MFN1	25.6693837247363	28.1908644486733	34.8524051448348	33.8112401943172
+NARS	65.0910923751265	61.8139487472203	62.1653995865162	61.2885041384407
+JUP	15.9989934687477	12.0796293556165	16.4918452596892	18.4870335557856
+YARS	25.6652458190392	26.3529118889239	26.4465266057152	25.6403798753906
+RBM39	82.9133962295662	81.8192729094509	98.9548295621155	102.758446797963
+AGPS	14.5110230412325	16.404766627175	16.831953232856	17.1587381376166
+FAM98B	12.1144167864278	11.2281358089138	13.2159799899944	13.040058947016
+TFR2	70.5774289549649	65.0979164814302	75.5982365919779	73.0858340924811
+PARP9	11.122586010732	15.6768301682487	15.52767752725	11.6208435567228
+ENSBTAG00000039643	607.588623596141	645.053482300114	639.45162333932	650.343886885262
+SEC13	43.1461076676243	34.1737248360144	32.7079337340619	32.4014164947019
+EPN1	65.125578009105	64.3370801738586	47.2625855559386	50.2700338040036
+PARP1	21.3481467390293	20.4241246965649	24.2881271441509	24.0968102021456
+EPN3	0.680695611362103	0.915719765958501	0.538524748572583	0.657401345415665
+DDT	456.140859335508	461.076431482139	405.842447579189	390.619258078315
+MPP1	56.1575732443173	53.7773195522338	65.6345620265985	67.6262565752931
+GIMAP8	52.418621261932	53.5244731580421	71.4533196205006	72.8217369076633
+GIMAP4	163.902925354278	168.039801817497	224.586579564619	220.650844298731
+GIMAP5	10.8084860752459	14.1655143924013	15.3592837801596	17.590673367266
+GIMAP7	34.1417077540259	36.2692955857571	55.3327157597768	54.9171481987596
+GPHN	12.4854530498343	16.9456536003351	15.3482134939232	14.8134055966408
+LMNB2	9.80591161629618	10.5376288141908	5.9340962168183	6.14977561656177
+ENSBTAG00000010033	18.5048225333198	23.8293074774158	26.5203258090674	25.4809726398062
+ALDH4A1	188.764128310987	181.584121100204	133.63064647398	133.58536307802
+GSTT2	154.530175778565	137.774162961773	97.4911934420664	98.1815662569734
+TOLLIP	63.3779746794835	55.1006853087437	46.579907518088	45.1233813394448
+MRPS26	39.5272673178502	38.4483629119456	29.5747001896468	35.6317774339382
+WARS	14.6751388423804	17.0370705187884	22.5425859750506	20.2102265355975
+MRPS25	29.7546221628323	23.9383836107144	24.1949673899487	19.0223732526572
+MRPS22	24.786736836429	24.6735752844437	23.8307250914322	20.6999627371634
+MRPS23	83.3850122660442	75.4382114559938	76.5610296579299	74.5611235724088
+LAMTOR1	35.0355120509502	36.8403600157567	38.0416189906403	41.7588875256681
+LCMT1	18.5278231988461	19.9963998497432	25.8536833206248	24.4957414935736
+RASIP1	6.79255980027564	6.87837005557046	4.97674559956816	4.85387096865022
+EARS2	0.971824474837355	1.57246484781682	2.27138088185709	2.00642086729512
+ACTC1	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+NAMPT	38.9589035095105	40.6541827038555	50.8852874879381	48.7885576753385
+ENSBTAG00000016032	31.2444465380257	35.8225260337061	50.0791569567943	46.7631583278899
+CTNND1	27.8174111805192	25.4189638501312	25.2318638913447	25.7602638074172
+GAREM1	5.22199228605201	5.4510134708088	5.07878651936323	4.03796223722093
+SH3GL1	23.3422689331258	21.5583363400783	14.4490415710475	16.0602045999279
+A2M	157.958754224679	161.866071725067	342.903703376926	338.436076079355
+OPTN	66.7039529250351	73.9532103765072	51.4290251578203	51.8825380573127
+BHMT	755.459028063828	762.088905266398	485.905844829927	490.335617971772
+THOP1	85.483907005801	79.1738854028349	105.177269723523	100.760817128123
+GOLGA2	15.3003897967169	13.8613345376293	15.0628470696857	14.3812467148659
+TTC24	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+FTL	4700.5375644698	4672.76061765461	4015.72534841193	3965.60362753349
+VARS2	5.5028278873002	7.12317835198444	4.55554038456043	4.92849262721275
+FHL1	4.31513962277386	4.96225267628503	1.75778521280258	1.77499844153788
+DCXR	300.055572439801	305.504028399992	265.759837958271	257.939262985731
+FTH1	2640.39841870471	2507.39669726747	3492.96774687286	3453.91687615061
+UGGT2	0.0498156499183176	0.253699590689055	0.203844394056743	0.242667698355064
+UGGT1	12.737230703257	12.8531792017474	15.803340262683	15.4492456548219
+RPS25	1262.26949165852	1297.5898683836	1253.54623373784	1227.30818522197
+APPL2	18.8551603324056	18.4594051613982	23.7146040847652	23.4646589823115
+ALDH7A1	53.0222837285836	50.6601879329357	61.8291588180666	59.3779554804581
+TOMM70	34.1711637691063	36.9920653244559	40.186834921149	43.6545574467661
+MEMO1	18.9079198181827	24.1440961995689	28.3763486785549	24.1338529488712
+NT5DC1	35.6134514901466	38.0223576878052	32.9657671254383	35.9204601974167
+PPIF	97.7068337839493	89.1364178211414	113.612052135248	125.348787526871
+PPIE	6.25929821131159	5.31403458478402	6.58224400333557	6.07569629604576
+PPID	35.1210950899941	28.2607017941829	32.5234580812798	31.7466853089409
+SIGMAR1	77.6520527205585	76.6092865671267	38.5977533253211	42.8456485156958
+PPIA	1034.35019844318	1020.13434868876	772.515482349054	751.145693114705
+SARS2	11.0916480960254	10.1542241810923	9.1588015156475	8.78322244764339
+SIRT3	22.7674286556364	18.8961932997058	27.7276111237912	27.3390030133762
+CYFIP1	24.5200446139301	22.1631199917117	29.6515214186433	28.4842227438395
+SNTB1	59.5404491323339	51.5312835067093	53.2925441809757	51.6032913842737
+HYI	40.2585599045089	33.2577691166209	50.4552498225121	46.3187319217738
+AIMP2	13.501989372869	13.0711861031751	10.1455379093704	11.6298317970372
+KIAA0408	0.265486069753887	0.241814480262823	0.455131303501472	0.19204910332876
+AIMP1	37.1971494618183	39.8419793191808	43.6164207792951	42.4922174549254
+CORO1B	42.558050898828	39.6751337369581	33.1869194532228	33.4859668310759
+CORO1C	25.2422522369417	26.6684375155322	19.7530171077342	18.9690651402694
+CORO1A	17.7215135762406	14.4539449859356	23.1897048067267	22.348632948456
+ZBTB8OS	32.3762631477558	47.9720890550815	42.1564576982225	38.5151665343183
+MDH2	221.170772581968	230.79241300938	162.314805032393	166.060620496365
+MDH1	112.107013928413	116.459303263565	69.3533046399373	69.2391687438853
+MOXD1	76.4649234720073	72.0721712445999	102.374107442164	98.3444023563963
+DDX3X	73.9263403987162	71.6539543506195	91.8204247450065	89.7690814721301
+TTPAL	4.1898077270929	4.02096272999204	5.34221934771448	5.93404543161027
+DCPS	3.48004029602297	3.97528538819521	3.24305467732726	3.44679457011092
+THUMPD3	23.7645238346924	24.2273848504228	23.4233110605197	21.9419957630896
+KYNU	40.460266630843	43.3559778114317	67.4912355059149	68.5188669824548
+LHPP	49.5384774706164	43.6060232463584	54.177050070137	48.9653163756007
+UVRAG	7.10645035697105	7.83621349044726	8.54626392671575	7.98419962513033
+SMARCA5	23.2521482729566	23.4351497927815	30.8226224950681	29.719787877834
+FAH	262.588648852183	254.328408913691	332.60223579053	322.934341527019
+COPG2	3.6941803903453	4.89291097917079	6.56985842847109	6.41259856176545
+HNRNPA2B1	350.441670238391	379.307631535797	344.743800118154	339.154002032841
+COPG1	53.2807286570002	49.7338941279748	45.838441949253	43.3969123831918
+CYP4A22	2.46753530422916	2.07474869786093	2.60767796403849	1.75003352368046
+NBAS	5.41598821324479	4.97331838195157	4.68955496059768	5.305396956002
+PDZK1	132.835872270642	142.378934621004	143.05088005242	144.255752391207
+RENBP	20.1291969648876	19.9718651384863	19.9883891991432	15.1708745899588
+ENSBTAG00000001851	4.96888983574246	3.92919420355106	12.5421033267194	11.9316246842058
+SORT1	25.5364273355186	22.1845796919739	28.5714491744467	27.6972654158288
+GTPBP1	13.0583846982455	12.0103235771002	9.72315354395715	9.78182285418381
+NIF3L1	17.1351945260441	19.3420861315404	21.8143344631773	21.5899098913782
+GTPBP3	8.78793542825082	9.81751826284006	8.99460008887479	7.18157632632933
+GTPBP2	7.71415311926382	6.88755073988943	4.37972235698723	5.06136072599241
+HELLS	3.07584724189016	3.38195802124624	2.98131060368764	3.07404164111412
+CASP6	30.103493119971	25.0565260097277	39.0410858686213	40.9377075861795
+UPP2	75.4060996877082	82.0654953624369	111.966040790801	115.545280159526
+SNRNP40	13.0399665224397	12.6968421234781	12.2138786617923	13.4498183133513
+BPNT1	20.0910266148906	19.9066516511147	20.7471005387983	22.3814306892582
+SHTN1	21.5464549400895	22.3440754973299	27.6059257546359	28.3254405724441
+ENSBTAG00000031738	0.734573971264471	0.117437725779074	0.0100543503631274	0.0229810596966554
+CASP8	10.658798438012	12.6455137866218	16.3874406215285	15.429300326113
+PURB	5.75048191983693	2.33572988678973	6.04701346675588	5.52013714925041
+PURA	3.65174795764468	7.70207283455392	7.67111405081849	5.74723893972894
+CFDP2	40.1525945258458	45.311133940249	44.8061005638147	45.6548763883384
+EIF4A2	188.050223012901	209.774181287971	294.522804066963	295.815543757548
+PICALM	147.16771180242	150.396521745931	162.835437194455	164.723045292576
+HECTD3	14.3189924343358	12.4683965744063	12.2809208337099	12.2938148883325
+HECTD1	26.372651217564	26.3468331929756	26.5393070552693	26.6330830760713
+ADPRHL2	9.39752883549689	8.8303290686298	7.07432691653351	6.04042756161582
+MAN2B1	72.4700051846057	70.131726460536	113.608472124417	116.791477649484
+DARS	38.7224080599416	34.3533605383033	37.8409715208489	40.8180094012176
+LYPLA1	93.4001823759454	93.7952703532382	110.207003230437	110.723737076862
+NPEPL1	11.1632999525471	11.411934144719	8.63404108137208	7.81197403479475
+CLMN	12.5467232858162	10.4012280846921	14.2745285958042	16.1101636493898
+CCS	19.2485876030541	17.2478068892439	14.486814840687	13.9066399867751
+GLRX3	51.3850823935252	47.6172579509854	59.4405830022299	51.8390756843507
+AKT2	39.9786849937726	35.9228388330875	40.9413837100873	41.1320350111131
+LRFN4	5.34899711497463	4.25752145132734	2.66538471320064	2.45874014925214
+UPB1	137.978978939196	117.601515985786	180.572225672557	179.599232945968
+MRC1	28.4250340467392	28.2415990516146	54.7160669245901	53.6058504720389
+AHCYL2	3.14236397784828	3.2466131871954	3.44395538021302	2.92255430767174
+STUB1	68.7602393743469	60.2286653440648	53.8368877804345	56.9809862383841
+GRK2	15.4424443741516	12.4465089076506	14.6096205697856	14.6979459524562
+OTC	138.466156338252	157.57799348469	273.808880613112	270.052942255212
+CAPN5	21.2091673020992	18.8875021284175	9.46963318385199	10.5951609536104
+FLII	16.1000398425055	15.977897746186	13.2168400146394	13.9640154014491
+CAPN2	15.0516943283234	15.9438152608355	22.5452008449594	22.211470565265
+CAPN1	13.0308394293735	13.7726319291778	11.9358814901519	11.7901864237316
+PIR	15.2946068503444	15.9577617737012	14.4557060586665	12.2676571541403
+SEPT11	12.1716981005475	11.5179918501659	8.8053138616636	9.01664543880227
+SEPT10	33.3858108594322	33.6869348724123	28.7685437918761	26.4009442263406
+ENTPD5	295.080059799864	294.350284733747	223.765640687606	218.668397525718
+SPAG9	9.39790471228059	13.2371224901889	14.1408299994527	14.612054689517
+COG3	11.697956701029	13.9581192902399	10.8186555200671	10.7493535362385
+SMS	57.4371276473835	61.9864574684399	74.5484192211007	74.2507461783843
+P4HB	1447.78091838092	1399.47746106023	598.515886351566	615.429739393368
+CHTOP	43.309920545955	40.467826724763	51.2290345038511	49.4078965132042
+COG7	7.17257278743795	6.11541636546198	6.73774243610311	6.43388202282192
+SARAF	185.583976326125	191.213173803603	177.075509770733	179.809417970622
+ENTPD8	72.6921074732973	64.6388182353148	58.2568482012416	63.1454014347341
+OSTF1	38.4311153166049	36.4337419554113	39.4525968704377	37.2159956043741
+SERPINB1	9.70591634395183	12.9350331288031	15.2544376665142	18.9272188352807
+SERPINB2	3.36774443407445	3.97574712494179	4.71205691991618	4.58658322589248
+SERPINB4	-0.079047357682769	0.132114255551186	-0.0029625310582175	0.175690979646858
+SERPINB6	162.369611934834	161.940232439158	183.684335742308	180.968287661977
+NFS1	30.9683740880421	29.2402474692227	28.4601785077488	31.7671330363925
+ENSBTAG00000048257	0.559431411320046	0.390026669491505	0.263614598678864	0.275281043168892
+UBC	1306.11381614139	1228.08585929291	1045.93308779187	1039.44809370649
+ELP2	17.5944837571123	14.7766978755244	18.2182386109071	16.2965752014127
+ELP1	73.2041064135595	80.7819713180969	56.2647918431716	54.8709648767207
+SPC24	86.1397068760754	72.7344787397279	20.3332128267164	17.3105536637349
+NRDC	22.1661984379327	24.1618529101052	24.5454870617835	22.6647869248971
+METAP1	5.17419288094435	5.99570353591726	7.07168660528538	7.59782938588372
+DES	5.26185003078461	5.56901216174059	6.36068772714828	7.13056794448223
+MSH2	6.64893482014723	7.30223379281484	5.73180848539311	6.43761531104763
+DCTN2	80.2842285464399	74.9257488465867	79.3876186822184	77.8795203321137
+AKR1A1	147.873392942131	142.696667547484	165.983285967683	159.274330419476
+SPRYD4	23.0067002331194	19.1468818185694	22.2044904337328	22.692682989685
+ST13	87.0669283980403	91.5086119883478	91.6834698239056	91.9448474108569
+PTGFRN	5.73416939018536	5.03098184103303	9.06727716933296	8.63705450374878
+PLXNB2	48.1564434456056	43.4556075122238	46.1731564130092	44.9997823336943
+TRIM56	2.74196888595672	3.22997464425685	3.88701020634711	2.65570302490392
+TCTN3	1.37332802360419	2.80599521456911	2.59419533594251	2.29494403644991
+DDX6	27.0966481220196	29.3211086323724	34.9288770618356	34.467821336165
+ENSBTAG00000022590	76.7461540081417	79.9509449949744	100.880974689103	103.339624303716
+HDDC3	13.1484680090362	13.0004662107067	15.8692797328677	16.7209377799052
+CMAS	67.6653261821093	76.8772043563647	60.1290182027096	61.8646415071146
+LANCL1	13.7590502930066	14.1162526414281	17.8112926819781	18.0975442325741
+PCBP2	286.876453642224	287.232570350163	297.36452601442	289.712150031604
+PCBP1	195.593312761682	183.448512196927	171.049128586068	171.065887188144
+GBA3	119.667137044925	128.548174445968	199.465584574088	188.450597724014
+NPEPPS	13.3064761799487	14.9107892176481	12.6302260365787	12.0646615424779
+AMT	39.578926327583	35.4897873667742	23.1374715107363	23.6069621857005
+SMC1A	14.4820471921868	17.0341152087521	18.7425067260268	17.9399727555068
+SIRT2	90.9545287654828	78.5697906924449	77.3881523531207	75.3460744535111
+RAB7A	97.6443843580372	79.0139903102592	88.8245674864513	86.3231924596
+NR4A1	0.798369184271407	0.563778483476415	0.840433072033014	0.952806971960205
+GNPNAT1	28.789991598033	29.7986842095603	24.1037290013149	24.9579941692512
+SIRT5	29.8358541205021	29.4789259254726	32.8573233601972	32.743199431297
+NDUFV2	116.507947118683	127.593259652414	93.8320711894945	98.4922249395658
+SGTA	27.9843254888222	27.3284315762744	27.1685366631665	26.0608612474229
+TMEM11	13.7691597725947	11.8109772587446	11.3788685462792	11.1743267586244
+TRIM47	9.65115652325246	10.4699729838649	8.09976244810246	7.55098511026538
+PLEK	30.8323882786404	30.4111674296428	57.2282908228883	58.5159295875576
+KIF3A	4.89786567524035	4.28368246721868	3.49175850451969	4.60957602997618
+PEX1	15.4544197838958	16.0244906457564	18.9561782921643	18.2255231472698
+HADH	210.689026188234	217.9191795525	249.708589160134	254.125083762801
+PEX5	32.1369626101149	31.9458648987082	29.1619532182806	29.7444510949946
+PEX6	11.5789877435837	11.7746629922933	12.4246599050693	10.8149484928433
+TKFC	113.413234004007	106.441641387868	113.764144436118	114.423299096433
+NWD2	0.0087352876352545	0.164049820185391	0.0231257392180691	0.00873832802978505
+RBM25	15.1477331274945	16.1323097339573	18.1302063803734	20.502739073014
+PPP2R1A	52.6290620342151	52.3267720036388	44.4479961627477	43.07173459743
+ENSBTAG00000012692	0.763230968602553	0.363473722405054	2.21189803338214	1.50967310374531
+ATP5S	9.52186499214402	8.37182392681633	10.8649920755077	10.750845107456
+ENSBTAG00000026812	0.216520059278631	0.599221559684165	0.107533575916178	0.119803628735598
+STAMBP	6.82228858025201	11.202332123536	10.3726215272431	11.6931646522005
+NEB	-0.0486945133955257	0.175696734303736	0.0326596235567223	0.0384734738321251
+APOOL	19.9277057841037	25.1628668643323	21.6014542614713	22.2459889042822
+HNRNPH1	159.531708330291	172.906314087914	185.661697361728	181.74399171698
+HNRNPH3	46.9982939180379	46.2490424151402	55.050384311013	52.1387804290025
+HNRNPH2	33.0032853362216	28.8578692242181	31.6099306421129	32.933576088082
+PLRG1	22.269317819574	23.0818556408505	22.2341588839468	19.4486314912393
+GNAI2	49.3856108025701	48.1374939930287	49.4805540435982	45.4799019776422
+GNAI3	39.3498009708115	38.6076017598183	40.8273707028315	40.9975692158404
+GNAI1	5.38717079521801	6.55105101163798	5.7904173013258	5.74007366365365
+MRPS34	52.705045705434	45.7650214449315	45.3620274487769	43.1297154798177
+AFMID	14.220222829881	19.8597985643439	37.6868628464579	38.366878278672
+MRPS30	11.7492006541413	14.1029736098962	13.274926142087	15.6184397328951
+HSPA12B	2.9030654336603	3.77027914129879	1.80896022062297	2.09210800717526
+STRN3	8.13498273725566	9.03287948300691	9.96295487170499	9.74576994193983
+ABHD16A	25.3054122555458	26.233175139912	26.234971162757	24.540897169109
+MTHFR	43.7095678334941	40.3222262829902	34.7976976778121	30.7237438948094
+MTHFS	70.3833137291695	70.679509811558	102.556433076768	100.724993245525
+PDSS2	5.25999828472556	5.84962797660508	8.22558650975668	7.80933981180359
+DTNB	27.4313027239405	26.4798904549263	28.3829068441411	27.5076278153581
+VCAM1	13.680654708315	17.3293688002081	38.4925311352473	37.6009766180847
+PREP	15.4744582349564	16.4324443864566	16.7954108709843	15.594271211927
+SYNE1	11.0916406094501	9.21704055885757	16.3298111824976	15.1668017273714
+SYNE3	3.4446382739788	4.01611649224488	3.8549713323667	4.07364934958814
+GOPC	6.33820876794039	7.8874717583141	12.4015336870358	12.6362543998745
+HNRNPUL1	42.40032600177	38.6102688921157	40.5058304569221	39.0894072854499
+YTHDC1	21.5377532702991	23.7265581376159	32.8803561238731	30.9353196589496
+PCMT1	41.61148897908	37.4395975309916	35.7497783754378	32.2292270688327
+BSG	663.785069995599	632.722524179613	601.694224705993	601.133236499985
+CNTLN	2.23485941057118	1.97886648814255	1.99177526945859	2.63606441370194
+DCHS1	1.36557467048848	1.25064183852721	1.40062046026667	1.2296385964705
+STOML2	56.8286035016604	50.5260871677952	48.7696370839438	44.9884366104539
+PDE4DIP	11.1423223963941	13.7719434810164	10.4336922887578	10.2364032945622
+ADA	26.338096785246	22.9731678890392	42.8827458443435	43.2618442115953
+VPS16	12.5295200567067	11.6675007150994	10.373029920922	10.4987674553771
+EP400	3.47402502081295	3.22421262142185	4.2240158951896	4.26426291360327
+RNH1	35.9380261163109	32.4428801804597	28.1988346840832	32.0434157279718
+RPS13	522.867553382692	476.389183703835	583.955752581489	542.373904666156
+CLPX	82.8384393793781	86.7446804663212	78.4926414724142	75.1445061085399
+RPS11	1300.27222977494	1263.75677368172	1107.3997992002	1075.72506242072
+RPS10	773.66442045445	700.250863105942	621.707706799805	599.645940406373
+RPS17	1097.80248416591	1074.74808676663	994.761525464613	1023.29527693177
+RPS16	693.49583992307	659.756831891863	596.849837193293	608.448053821041
+RPS14	814.303129173723	769.076385732174	804.065056879404	806.113208187967
+ARL1	55.3318944653916	55.5839765995688	54.2862288307767	56.5737763704549
+CLPP	38.0094932542324	32.2076248154063	28.53859864377	29.7845812505223
+RPS19	944.557320387324	910.016421179541	682.146812911003	657.995562380484
+CCDC22	5.90040309658244	5.08327308934923	5.68813930547208	4.7336845474858
+CCDC25	32.4659933535804	27.1194858920637	43.1976813779266	43.6545262873574
+FIBP	25.8057688206942	23.4025493699871	22.6728081635671	22.0077244549518
+ALDH3B1	4.46352587715083	4.09715096214455	2.42315710412378	2.37007095906671
+DCAF11	136.885754549088	131.757345348128	95.4010531900795	97.1412219513151
+DDOST	85.0129547809851	73.5086852947942	67.239745678429	68.1401793610268
+MGC152281	102.415875552095	104.685711832215	129.315818173451	125.232138372636
+RRM1	48.3806745577983	49.1148715360649	39.0920661012792	37.5880640591606
+CLPB	3.50635886825423	3.78197143718082	5.29679088433362	5.22156068923039
+PUSL1	2.13622208970231	1.99192840696824	1.19592393393788	1.55894630451249
+DERA	49.1860075519892	54.8260709502859	47.0988173171878	49.2614372027992
+BROX	14.7426855767455	15.3451037982629	16.6553714851895	18.2604718071955
+TXN	506.086095336058	515.47711746809	447.946314697442	444.253307951748
+PAPSS2	71.7393450568925	70.6035600964772	69.7786480109247	70.5873847244192
+SLC9A3R2	66.4374827655652	56.7694377822109	69.8254270255267	69.1811549274692
+SLC9A3R1	185.615220840609	175.391593167531	137.437815169588	136.489240314059
+UBQLN1	83.882327080875	86.0749610529681	94.0960493344733	87.9742133526067
+LSM12	19.918177286138	18.6245000221205	21.2007742447329	19.2031389600604
+GCLC	44.7367346882868	39.8881248318436	45.1429474689259	50.5907908082858
+CASP7	10.419954448464	13.060099156642	15.3134620135647	14.6167893297013
+TF	8599.29461693456	9413.46115141257	14863.2413697457	14658.9887904924
+CYP2C18	37.6036495412475	39.973800687212	87.4972610661016	86.6294637668997
+OAS1Y	71.4302797075208	58.6873827460939	41.5782295485235	42.8477851529766
+OAS1X	13.8527954937797	13.6602642078607	10.2841849717523	13.4172035850375
+TFAM	10.4472318537323	11.2605458526036	16.0983068607753	17.4348089370442
+TXNL1	103.952552838255	115.038879495926	108.137244958645	112.278541020715
+SSSCA1	13.2121493626686	13.4288704338149	12.106571944501	10.4596059211301
+ENSBTAG00000000229	119.736087504913	125.132146656163	166.191572173849	164.294745269921
+GGT1	40.0843787247375	36.8874604868939	33.9901946014926	36.1954946909655
+TMX1	15.9009292608672	13.8914500843861	14.9617040218007	15.5309986516919
+NAGA	26.6121506957114	21.7050881819476	17.3447774476791	16.7438518243868
+NAGK	13.5529503195623	13.2757539739551	14.522493003992	13.5344730711148
+ACTN2	0.159043176887113	0.357710597533324	0.215480557633423	0.226665004259558
+ACTN1	24.1018203431991	22.019177687976	26.4045345156663	26.2671766468744
+CYP4A11	579.085869415823	587.848406930167	512.732683446841	514.542921241511
+ACTN4	100.633352280165	89.499926365866	67.1056812644732	68.4497784723153
+EZR	17.5041415080775	17.6369564693945	20.3298980060406	21.5370597198522
+GLYAT	1620.75641806911	1632.20607950237	1680.52602930246	1642.67906576899
+G3BP2	20.2581753634458	23.5313252466533	26.5404963119162	25.8373194464335
+PTPRM	9.15356066519333	8.57338509420922	13.8393657908032	13.0773782679421
+MYO7B	0.317952609778197	0.385858442819635	0.290044468187566	0.281728139410924
+STK10	15.4438125974873	15.1764646706086	17.0622387797986	16.8332595219954
+FKBP4	109.962968327887	102.241124718474	75.9741798496794	79.6174005777913
+SRSF10	48.3568872566459	51.4706979283994	50.5540306357587	49.1405405017313
+SEC23IP	9.77200823083704	11.0708718455968	11.213586181304	11.2258813683553
+FKBP3	43.266105478479	45.0021463291844	44.3906742907561	45.8929712493271
+FKBP8	99.574923967891	87.9015166600516	79.1429696024693	82.8317968948386
+GAPVD1	9.86245274838146	9.32589783262592	11.5069316375072	10.7711795313778
+SGPL1	35.1386435476099	30.9329642058262	54.1032160617031	54.0236410927655
+NDUFB8	116.834440126871	106.77329850885	108.730135845698	105.119014894694
+PPME1	14.5423492080999	17.2466823738509	14.8535177466358	15.9678749096679
+MANF	126.068146487134	126.773584164756	58.1224386487062	55.5531406663572
+HEBP1	155.206094699601	179.329719859147	208.236513315194	210.049818840196
+HBS1L	27.2220885680969	28.0024864704943	25.6632174505036	24.7007330892689
+VAC14	13.2801399855225	10.3819795490546	10.3087606047789	11.9164104939034
+WDR5	34.4262631249817	31.8444048037985	28.299631022021	33.1309167894989
+MAN2C1	8.23484281989396	8.05661177788604	7.93201461056424	8.63637774766572
+WDR1	30.7775670697141	28.4040154313901	26.3602696218109	25.6153008535878
+ZFYVE21	68.3132874381588	52.4480368665496	59.2629841310042	61.0504589739928
+APRT	77.4568082297743	67.9739048495469	77.492231948105	83.0519088357615
+CSNK1A1	51.2260737435172	54.0172337031947	58.5773442109201	61.1836671772787
+ABLIM1	20.9208625745434	20.1022950185073	24.4217838324811	22.7551418029438
+JCHAIN	30.0430054978903	23.5539451773765	22.3582374231222	25.7092912501054
+SULT1E1	10.8335871648389	12.9503437186598	18.0102528899749	15.7331713087382
+L2HGDH	4.47577243397739	4.79422041196904	7.36094951756975	6.69809994979611
+SNAP23	15.9538302317801	16.9981803623118	23.6728808248383	23.8363449567666
+TOP2B	17.0653177217484	17.9526171454953	26.278514094742	26.5253226266516
+GM2A	18.2362831739595	21.117271532756	36.731549162245	32.3249918586048
+LACTB	16.1950415825112	15.1687301096019	16.9444987027527	16.5549321922178
+CSRP1	19.1158506905572	14.4858187010906	12.0871307380947	12.8503511823462
+CSRP2	42.7902963085357	44.4432386922299	47.2066861371693	39.1844294702836
+SUCLA2	10.4391346986634	13.5307853969249	11.0637850299061	8.76010784363216
+HHIP	14.5039157346216	11.8517190223921	17.4821834687607	18.8113867036974
+HSD17B12	77.7719103294517	82.3126812575161	48.2217763211841	46.7361450055157
+HSD17B13	1614.69404422453	1690.40087160756	721.683579870367	723.524640259076
+HSD17B10	891.400486239166	840.692626126069	673.07621316047	658.419640203595
+20ALPHA-HSD	1.94219504579959	0.855479552240382	1.37886004846924	0.973692840855602
+ATP6V1A	21.9172580964765	21.0254969442724	27.0481564564741	27.9115409524926
+HSD17B14	47.1228561730785	43.7225291170798	53.8278653093109	60.2647092117435
+BBOX1	208.791109755464	218.781940540238	261.552208259923	259.24452608955
+EMD	25.3227991241643	26.3464811374135	18.2107640920701	20.2162347649282
+ATP6V1E1	36.2535465594273	30.4338578853761	31.1395105692237	33.3171865243901
+UOX	16.9418883020323	12.9545322847907	81.251734915381	77.1966659797797
+ATP6V1H	10.1054999422333	10.7974511717945	11.8287212195442	11.6651404038888
+RAB6B	-0.0796433237878804	0.29498976023963	0.0321186379033785	0.00984058321829792
+MX1	13.5871860929952	11.9785586416949	13.2066483556842	16.4032429052869
+SFXN5	4.79762115778554	6.98575552079888	8.17098087735151	6.15268160158786
+SFXN2	17.6044106332051	19.7122601039609	13.2443461514536	13.1194745665728
+SFXN1	41.5031262618955	45.8867996687204	47.4492995083688	47.3756481245606
+UROD	57.3160850539888	56.333613544218	56.2698947638903	57.4559948253489
+IFIT5	31.8349872983945	34.995449472613	37.6889524507771	36.2242327459588
+LMO7	15.8348911355402	15.2718539418278	16.6079589370498	16.5589920860694
+CCT8	65.2096353452967	75.0874590546435	63.6872681420151	63.3444330706543
+ENSBTAG00000032453	-0.109586111976307	1.05907792777529	0.440291921400709	0.450676672660541
+CCT2	73.4862288415183	71.6893477904709	71.3385445545297	73.86749649934
+CCT3	76.5428835932819	78.7147281760493	62.7291075803548	63.7578986708214
+CCT7	65.2982449940596	59.3812202066599	48.765886822457	47.1382178885552
+CCT4	78.3678484120151	82.3677441349927	66.3962409609487	70.2438018787458
+CCT5	53.5370726039037	50.5769668076478	40.8800204518481	37.6624937890349
+EFTUD2	14.1034930826789	12.2061057315692	12.9859663721995	12.3626121406912
+C4A	801.169854757233	775.852008407187	1038.39579920479	1038.7108087384
+ENSBTAG00000026133	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+C14H8orf82	12.9685783409366	11.7896829341325	10.8945936531737	9.76712837584875
+PDLIM5	24.4523194909809	26.21478008159	30.2204227493468	30.5144087803354
+PDLIM1	48.9441650688375	48.4924288013859	51.109801888032	44.4207242959783
+PDLIM3	4.98471758129181	6.0683167986955	4.9344709988019	4.36717785844193
+BRCC3	18.3537614112121	20.6539025650382	24.099741237318	28.4432797609603
+AKTIP	10.202903112929	11.2959771811719	10.2591814243062	11.0434153316157
+ENSBTAG00000048287	149.05477666269	99.7346905915885	141.419375673324	115.214214044895
+RAP1GDS1	7.57914208897516	10.0291935433649	6.46253529867549	7.36991257217177
+GDI2	188.676057401403	200.45626894746	172.647652487407	168.412847546611
+DHRS1	171.909874851457	160.762362121018	106.672713726251	102.789276421766
+GDI1	47.0244804225268	45.2204308839204	45.855978939476	48.0025472140323
+MCCC2	16.0314104791439	20.865612904431	23.9911712685723	22.4239222791931
+MCCC1	38.0454538940768	36.8027989657298	42.8439918204121	44.7044962684895
+PAFAH2	44.0469544575759	41.3618576212055	32.9528830772532	35.4582251643708
+ERLIN2	68.0978853046623	65.3694653269437	78.6288219066459	78.4463650261116
+GFM1	29.9801082462597	31.6974498499095	36.7371995301849	35.6763765938689
+GFM2	18.1180888512257	19.0706325565877	18.6437316190765	18.8678516983431
+CBS	50.275469678549	50.7061605026127	41.8564919045229	41.1033917891441
+ENSBTAG00000034850	7.19255438753177	9.07771322969325	4.89673347612519	7.23189695492511
+FLNB	15.1599416220712	13.5285964590462	14.9154961383453	14.4015827376836
+EIF4A1	95.0807961297107	94.5152709723596	77.0997675129749	75.6243230370453
+EIF4A3	35.6749587239255	35.3978151101994	33.8199276975183	32.2993887324336
+KRT18	218.093238702214	216.3618602256	116.427632225427	113.747637654905
+CAPNS1	86.9562244268314	84.7842609047457	88.1861844618468	89.3024479094432
+CROT	225.143883617479	239.268141825478	200.295875820315	195.980140971379
+LETM1	18.7933925033172	16.6379513377632	12.5957388231499	10.9328391475656
+TMPRSS3	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+PRKCSH	99.6668486746383	94.4108487755093	86.6658798074426	88.5917296376608
+TAF15	37.4864719347854	34.6520579740238	44.8786809555305	46.7109671660824
+FH	99.427560200047	108.767823645757	111.589459406576	109.787671728654
+DCTN3	28.2141590590715	30.347221263962	30.639630320406	25.2663941692082
+DCTN1	16.8835816086212	17.8557283155233	17.7829887929069	17.6683513508846
+RNASET2	28.0397273261063	27.7651311363531	35.3051340456282	35.2290014780888
+NDUFV3	45.1067976349019	47.4721643782035	36.2475069858111	35.4449385592524
+PKLR	40.281523908341	34.2991045623882	68.7811449831403	66.0826426071171
+NDUFV1	89.7912403998105	79.4699969480042	65.7334369347194	66.2146523215109
+RPS4Y1	59.6872774571047	50.357517369007	36.6320736415744	41.3407159445932
+ASPA	2.62833635034221	2.88632930108215	2.74381609101679	2.91334361050854
+FAM186A	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+ASPN	23.4557853898405	25.9195127497061	33.3056106011246	32.1552124892458
+SERF2	1220.89729708647	1159.98486074744	831.972393427435	838.48508352013
+ASPH	72.0647703953054	66.9963068048453	68.3878682774177	70.5719675637984
+CYP39A1	23.9290557700249	24.6572744691595	26.892708348116	27.7742496982802
+RBM15	5.37528324737828	4.17041563941325	5.01944209583531	6.21856864373041
+RBM14	29.3536158786837	24.5546159293507	22.3542103480944	21.2932829280388
+PARVA	19.7052744111987	20.084570326936	32.1304426470257	36.2068742144069
+GGH	68.1429129930792	73.4535733281278	54.0227443123657	56.2613565928326
+NEXN	0.605094853940956	0.756782756357016	0.345223717661467	0.356747857340383
+MVP	35.5323014157723	33.4652297049853	28.2955565985349	28.560847775963
+LAMA2	0.170572527481738	0.543253387069354	0.17315800626322	0.131801598359233
+PSMD6	42.9764534127594	40.4951715867558	40.7268914985099	39.5200663098277
+LAMA5	5.37977218063479	5.09480839712849	3.8840305439793	3.64405317823273
+ARVCF	28.4167579749895	21.144480988249	20.6116172053356	21.7296136533985
+NAT1	45.3624929481399	45.0042938580826	53.3196661379433	49.0306915720927
+QPCTL	10.8934317641201	10.3611675832642	6.14801335202803	7.31840758432045
+FAM96A	83.5604033977766	81.8753339485662	100.705098471446	97.7509813736637
+ALDH9A1	369.60100412425	375.652906892365	467.513663330321	468.29409380829
+BPHL	37.0957702822177	36.3848642677326	36.8457200777081	37.6934445546045
+GLO1	224.717787601532	249.987787205914	256.943179224681	262.72104028686
+MVK	125.60023181104	108.228518627115	40.4961111521754	44.7611642620467
+ASRGL1	33.5773968102396	38.1004162020057	31.506081441533	23.8969301772807
+CMBL	244.547761199155	247.824305499274	212.5544579795	219.650090922384
+F7	89.3108883537718	79.657979284652	82.7400359105883	79.2599059032245
+F9	426.804996325805	449.261708949094	657.682836206112	671.683971414569
+LSP1	10.685143012409	9.16574359799813	9.44647670536338	8.79633772094805
+GSTZ1	481.724381644991	455.349139899186	373.854825072395	374.300472586966
+MARS	15.3764472503945	13.8439726646603	10.945887674502	11.726932700481
+TUBGCP2	15.5505209369877	16.5477224752994	14.9213950249214	12.7635934511203
+CUL3	15.8704700674725	17.4373319348964	19.5001816059124	20.0057604295144
+NBEAL1	4.9137281277519	4.53394265347196	5.67717614153071	5.75377544684986
+CFD	169.572889666805	153.74770435413	271.203175210289	265.400065153213
+VAV2	12.6516175724925	12.0941203194214	11.3925137259513	12.1189190596617
+PSMD9	23.584959735025	25.9427439127782	24.1683615907499	25.4170844088805
+PSMD8	78.9155023047106	72.084579475786	64.5484277164876	66.7238457648302
+PSMD5	19.2251994427441	19.7371391961841	18.1467352758453	19.6527044093147
+PSMD4	74.0916859676512	69.8503533971009	53.2759828432836	56.7207402594667
+PSMD7	66.3621270037664	67.8644378082165	56.0752946369566	56.8458842451995
+FLAD1	50.2968340545894	44.4697945876749	23.6174173285843	24.7786715369235
+PSMD1	45.6762609644219	49.9714910712316	42.9877891606649	41.2035152789946
+PSMD3	68.7214343109245	63.8492567116916	52.5687704959083	51.2853211038092
+PSMD2	66.4527031810412	69.9147686122521	54.8433695195866	53.3526890528518
+CTNNB1	90.4023761157358	94.2750388257147	108.506696375932	113.964268569156
+NGFR	19.1774697255707	18.0444728424581	26.6718407687433	27.510004777236
+CPSF7	13.8229252870417	12.5535338220972	14.0785685250771	14.13059212865
+MOB1A	17.1161090658869	19.8665198600251	27.3172587044961	25.489204435624
+CPSF3	13.5551056525383	10.815894113857	12.0101451807324	13.4628356627835
+CPSF2	12.7661162149239	11.993364680498	11.7267251606951	12.3843592141942
+CPSF1	10.5691038631671	9.71324877219874	8.44757539251843	8.37712425810752
+EPS15	26.6887488463586	28.6326444493031	28.1434880218617	29.9773339337446
+QKI	32.2514136114333	30.7416864445002	50.0541146635714	46.8031940398972
+ENSBTAG00000014220	306.638646627431	323.210113710557	673.515631149979	668.28946463748
+MAD1L1	3.55481954610918	3.91530353255797	3.71601168804164	2.78618622837252
+CATHL2	-0.0818278270922784	0.442435441480108	-5.98126814062572e-05	0.0122583485392512
+CATHL3	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+CATHL1	-0.0829887190073607	0.50247898753471	0.00115212019722091	0.0135432008935647
+HSD17B8	60.4396472715786	58.6775582149661	52.9804491462764	53.1333013601698
+HMGCL	81.6564342326211	71.1276535423798	105.068100355329	100.787743958003
+ACAA1	666.983826883534	626.614972747982	599.533308779113	584.456666588973
+ILVBL	43.9792942485372	40.2561199484798	36.5702195393003	39.2678639478191
+CNOT7	55.8648458541427	59.7597469723131	64.9942217227111	58.8878336221171
+HSD17B6	870.388208687256	893.578986665181	743.77417131561	752.508349522779
+HSD17B7	56.1195772229482	60.9560861879787	36.8843720374126	35.7389118187248
+ITGB1	80.0144485394017	90.6487986872208	87.0877351821985	86.517405225761
+ITGB3	14.8960084727247	17.3223072479106	23.7762578498425	21.4064864572844
+ENSBTAG00000039289	32.3199552668778	35.0880352545981	13.3313286585454	11.9553262202517
+ITGB5	53.2409932243542	52.8868652524672	63.3156349727449	65.0853331632312
+ITGB6	0.249409563345128	0.423590544960952	0.273549409492523	0.0775742434811864
+RTN4	234.420300375363	248.412045892992	262.078709884684	253.338160818239
+HAX1	29.6499633498052	27.2720483057226	27.4691710571091	25.5606703788432
+KPNB1	38.5863928993263	39.5934007060507	32.8980606930222	34.0116038913187
+HGS	19.8591419118765	17.0893346072986	16.2013949614545	16.5194381610456
+R3HDM1	3.73238709317183	4.51682543882832	3.2322272091072	3.51674048192889
+MST1	187.863010724972	176.96789577774	158.925524640767	159.791818306159
+HGD	907.379627269024	936.063625032695	911.160754243876	915.2077258314
+PRMT5	19.1367468832104	18.4210129182983	14.4054343631021	15.4746265283109
+COPS7B	10.8711954237715	8.60426859215828	8.62808031838259	8.81889986745711
+COPS7A	34.1163113080537	35.5617824243021	32.8001678081673	32.891594608121
+CRAT	138.027999952401	131.944493882948	95.2372236771034	97.4378295153783
+PPFIA1	10.5155743913038	12.2298732559008	8.73034800129126	9.73573303176059
+MYO6	10.9630981523458	12.5649633983582	15.3159298780359	16.0232880966266
+RABGGTB	46.5237313596009	48.3817508110802	60.8431745012983	58.6706823906761
+NAP1L4	14.974542241789	13.9449104036876	15.7924973150127	16.7832295545638
+KIF13B	3.08733216577438	3.27128041761237	4.49878228245069	4.38267392165231
+RABGGTA	7.3595766089214	6.47852923342972	6.18478112958811	5.59796425700703
+ENSBTAG00000019601	6.38828637783438	4.695896961653	8.0658783655894	8.40329733438033
+FSHB	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+ENSBTAG00000044137	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+HUWE1	21.953457255099	22.1564759750859	23.6551714742396	24.1416329925867
+MAT1A	354.960760536584	357.690700885961	287.969854665606	286.511742610089
+EHD4	2.17321268496178	2.98809620585801	3.21592757431054	3.15273057021539
+PKP2	13.5677400574093	15.7561518320554	14.0623856059251	14.2440263289709
+EHD3	31.0561478467807	32.5178885205977	26.3449400771294	25.7492304925835
+SLC25A15	56.0156525373645	56.0884032946413	70.7452547656337	69.4521670687551
+SLC25A13	70.9358742422142	69.7139311466039	80.5462649068889	77.9229970417751
+SLC25A12	1.59243613732084	2.47469492633696	2.32810352549483	1.93522547053468
+SLC25A11	74.6674776848938	69.2909451570188	48.7072360068212	53.3902284772163
+PEBP1	599.423907718042	622.794245834889	548.395830489935	546.566290034157
+ACAA2	971.293504421636	972.813793950403	900.453388863264	895.573327805747
+CNOT9	33.4909386892945	32.0798746018683	29.7260429422648	30.4652249957747
+NDUFA10	102.853069919572	99.219581100168	90.6144432392249	92.0224578485191
+FGG	5510.2935797276	6314.27184133987	11231.9665905182	11083.1964226963
+METTL7A	145.105674790594	158.11249136213	130.85265748075	136.43344920365
+METTL7B	662.708723537358	628.777270051081	664.035031352578	661.586983281126
+TOR1AIP2	34.4303344781486	36.847490681172	36.3211496118583	34.4005219005459
+PLBD2	61.2613400394014	50.5875842503906	50.3862800788933	48.5936223986162
+ACIN1	37.3372130208879	32.8432390110725	34.1065639435825	35.9000830831859
+ATP1B3	79.6911875076286	80.8097383802677	101.637803194136	102.821955923537
+LPP	2.0848247876603	2.12852951347651	2.85692176936984	2.42292506409957
+TNFRSF21	10.0032215520589	10.4584077995179	12.6609288069883	12.5119183500425
+PSMC2	74.8535331077659	76.213667379699	73.3431290090272	76.0591654673721
+SYNCRIP	28.0498677872575	27.8974678713868	28.3510155876832	29.5605565350557
+FCGRT	339.123714831448	349.184831291228	252.702187428348	250.432301807155
+HSD17B4	175.444508237151	190.228770203727	255.669271123696	260.084718748588
+ALDH1L1	502.936375854061	464.176289612175	453.536262985667	455.274529767133
+MPV17L	66.640777442221	71.527555826463	98.3483975641913	103.652497759949
+C1QC	344.861583282395	325.421277264457	525.421953271192	533.38200242438
+C1QB	481.237144170125	490.41660242652	800.625180824222	801.875667357447
+VIM	62.9537732423271	60.8390865487559	39.9415715465352	35.3390483795712
+EFL1	6.41987287199359	6.30959028220535	6.42945242027547	7.12039780826087
+TRA2B	80.0873556873048	82.1481704720508	94.4367626688121	91.8466824543424
+PHB	225.988013266387	242.775297109345	128.77787891159	129.168363765246
+MMAA	14.5392068170328	17.7840075024986	15.0202675223713	15.3960781000958
+ALDH5A1	46.1538544226456	47.4165664771752	59.8693328624112	55.7862710350699
+MMAB	80.4271741247078	74.9685355721722	47.7027383495691	52.2156296559744
+OSBP	40.1526371964496	36.546038436398	20.138982971892	23.6795340377995
+PTPN11	19.5801355725469	20.0997703808865	21.3211932357642	21.405568562408
+DDAH2	7.85737335430685	6.86364964661057	3.3463448645452	3.35715270316569
+DIABLO	26.4695553027665	24.7689242662293	25.6650905496329	22.9606055953164
+SDR39U1	12.7669545495977	8.92022029985483	7.30008147081135	9.0899729177108
+SNX2	49.0728847319265	50.2430332838893	56.0726428143263	58.3353244967153
+PDXK	9.43592368260568	8.46579285370344	10.5317976794449	10.3115425130382
+CYB5R3	284.863861970978	262.877600327394	278.308510723211	287.532527016437
+SNX6	29.3295598153344	35.6001878862353	38.0651511896499	36.3913489088024
+CYB5R1	12.935088399628	11.6817429875198	11.1831878487094	11.0681430245406
+SNX4	14.1885086033544	14.7176591540344	19.1433618603585	17.5714956518342
+UGT3A2	89.6558611086346	94.9410548942997	103.35695433613	105.897829921947
+SPTAN1	53.1497076103341	49.9604039727133	32.196718230545	32.718008923137
+SNX9	52.9145554547342	47.9764849481738	55.6015235910902	55.6096787435439
+SPON1	3.20791943929005	3.77763378509912	1.67868013830304	2.07122925387532
+ALG5	46.1447504776606	45.3901615339994	39.5276684137686	43.1566671348597
+ITGB2	13.2880059064154	11.15881281222	25.7424553328817	23.3575050104728
+MASP2	109.757661125152	102.434375495997	122.865579874724	123.642395996841
+PDXP	7.33248210403713	9.2697633087992	14.5172984181007	13.8296738658523
+FUK	7.66025384632415	6.40299746772712	7.70002511032626	7.55087592169548
+CCDC127	22.1748049474124	22.152104953827	17.9498634537099	19.0952095629423
+NOS3	3.72382889484879	3.9860277242737	3.79252110388413	3.79126538999694
+RAB11A	46.9279198450475	44.8067862012385	44.6012944161902	52.5993270084546
+GCC2	6.97736853723239	6.72899635179618	10.0269825114493	10.2973266044703
+ENSBTAG00000046676	-0.112521348070538	0.0927129420961553	1.9692332110929	0.0462293342776494
+PKM	17.3785080980981	16.4246956212203	15.8341113511072	18.9287438762599
+TMED7	134.157735892375	142.246911243448	128.930018895078	124.344766578459
+BLA-DQB	97.7776084055453	87.8573328912113	152.652618509455	153.440733072895
+CSK	18.4433519174961	16.4010224338902	17.0602152928349	17.801201833264
+DAP3	21.1135263854204	22.4838795287676	21.0486931091096	18.5911551819558
+TNPO1	9.47597275039236	11.1399315389253	15.1471323898426	14.6272719157857
+EIF4E	20.6609628628263	22.9936105854576	19.0944447106385	18.4295610540584
+TELO2	3.14546246964801	2.3688263878156	2.36405585305046	2.21825599336677
+CALU	94.9028452589509	97.414854987449	88.4403339338871	87.678618152211
+TUBB2A	8.59531975801329	8.22962253065591	6.08753287826305	5.79280033698288
+TUBB2B	5.86211450117737	6.37282522100032	7.43380456157977	7.12017536763833
+PAAF1	19.5995846541387	21.2820258119351	22.9807208120891	22.3644344588122
+CD99	52.1795040089466	52.8855141423455	59.374104853131	58.642203282358
+COMTD1	8.78509937385784	7.4014174846471	3.35612155809923	3.52061623154079
+TUBB	154.405961026434	149.347426096824	84.809547503305	84.4688995665526
+MAOB	313.288044173735	331.49945752127	352.586432596194	350.554050348732
+NAPRT	94.2703356313118	85.714928550308	80.4823510810017	90.1778972217913
+DTYMK	15.4910330076949	18.7528832325361	9.53466378497959	9.33148441195648
+NEIL3	1.81134714542466	1.84933590678147	0.687382725378244	0.435114461437356
+ENSBTAG00000048275	150.990401747644	153.737507192872	167.932878522908	175.489792762518
+MUT	307.404569721191	336.404460663145	354.662505732003	360.423405359379
+INMT	40.3647509474395	36.5846521237996	29.8437900002751	32.0277861739224
+CLYBL	41.5810371784141	37.0854339225884	41.6034504326415	40.8423689388688
+RFC2	8.79133401656378	9.39400432564624	9.15345760559741	9.55464269573716
+PGAM5	19.9322161014377	21.4755655512804	15.7581063433743	16.9355149204452
+TECR	201.692315625296	197.012804481707	124.242744786474	128.835442610018
+FABP1	6774.63561600088	7144.63380369229	3485.39377513447	3397.22090558008
+AKR1C4	762.85989571159	760.198672061513	646.916269172403	651.015929438599
+CBX3	4.91432947028941	5.43434739387541	3.65738612892386	2.97788852074107
+LCP1	19.1399735895813	22.9356673133425	33.8343929926513	32.3969381769299
+FECH	34.0232120463036	34.1201313953337	32.3233515960398	33.5713656077101
+AKR1C3	641.816733536881	649.487047967925	1358.72655798783	1342.80956758485
+ZBTB10	2.41685010798729	1.62946323876491	1.35766235302032	1.36653105570081
+SEH1L	16.7384980139056	18.7405463944324	15.9234022433981	17.8620645378003
+ENSBTAG00000008184	63.6029537596964	67.9619088452763	47.7222987056459	47.3340025023228
+CCDC51	14.0843755794836	13.4929523681656	12.1915808727873	9.60080792394418
+MRPL22	29.7541700095955	32.2307093346447	34.1366332276666	34.4767607326511
+C1QBP	44.8920926620059	46.0439330476433	36.6769028593392	39.4134073191318
+RAB18	78.1946218985596	87.3462102371973	76.0396414355268	78.25158083585
+ENSBTAG00000018680	7.42491424900198	7.78975718515808	10.3962880124524	10.1768996614646
+TRAPPC11	6.61476491614505	6.91474970691512	7.20658085831983	7.76851993055637
+TRAPPC12	5.75213247488064	6.01890126149679	4.77479924004409	4.59427919824109
+ENSBTAG00000047699	4.61405519324348	6.72068675055137	4.52409168320208	4.25329037970321
+RAB13	35.2598703457167	33.3398667710171	37.9637677006498	32.9755169169827
+SRP72	21.6244326221986	23.1590157628849	22.8977290912495	24.3854805968318
+RAB15	0.113570192753917	0.411753713521657	0.0871831044214716	0.0588171084018919
+RAB14	80.0733613188125	100.41371948323	118.82727897307	113.687805530295
+RAB17	37.4275161543508	38.2698160250429	38.1959730880395	38.4543390944868
+ASL	255.384861494669	249.715043770811	248.558068906637	240.242618426766
+RRAS2	16.9612580637517	15.7026444100204	19.4853507949078	18.3281540237465
+RAB1A	107.287442407347	118.338973606536	100.537079995058	95.1147686529333
+NAGLU	9.93785865034672	10.4225592197143	8.68588821399643	8.67117227273624
+FYN	10.3575586554311	9.27526487909106	13.2816404844821	12.0571425304466
+GMPPA	22.7111528483813	18.9625759401958	15.1355421251685	14.4932255693984
+GMPPB	13.8849747143113	14.8445714156175	10.6256841417244	11.352210424229
+ENSBTAG00000011330	80.9133099884856	79.6037430094293	79.9286405542379	84.0609334001863
+GNL1	9.39325515351537	8.48716596767357	8.39000974116531	6.51421353676947
+MTOR	8.47464913359724	8.49061039585572	7.67668949316077	7.90667289135427
+LAMP2	227.872755928791	242.180081058573	305.852684827018	316.864081707098
+ACADSB	3.76679934353406	3.63703916973838	5.69512938890654	4.12926198622542
+ALDH2	773.347788986097	748.973408369405	904.204319521099	906.636056340635
+PTPA	28.256037869826	26.6249263447858	20.2757908874437	18.0728239564515
+SHOC2	7.72997544907354	7.74333446521108	6.90601618254973	7.98426373765273
+RPL10A	522.435543139268	485.667659145404	492.392611968451	510.423563587747
+RAD50	12.1515461178286	13.5987186088796	11.604214802404	11.419333913626
+SEPT9	23.8445875138851	25.9384052954329	28.9034309167917	28.239835798779
+PIP4P1	17.1530623159801	19.1993172614631	14.9176795058588	14.7975438366885
+USP8	15.4462306923223	14.1934080648246	15.8724871889126	14.9949455448346
+DDO	17.8797607835355	16.1935843082903	26.6348953200209	26.1806956326395
+USP4	19.548088680021	19.7445325801515	20.632171543	20.9563345101626
+USP7	28.3623272704575	27.089124169129	28.5386368266807	29.0038501805952
+RPRD1A	12.0898313043201	11.2919214359657	12.8565394528293	11.7897425704543
+MRPS15	39.7765439301264	38.7061018068351	32.5303397443051	30.9860114392826
+NUP37	6.62269236902968	8.55106219268845	6.32501106676224	6.31758246956136
+RNF31	6.79839887411567	5.57635056251201	7.27506283924423	7.07014171330764
+COQ4	60.5799369561079	43.8075052818941	45.320432552808	49.8090101563264
+ASAH1	27.9087036641586	26.9879316403361	35.1164952455482	37.4533020880166
+TPPP	2.39299626474782	1.82283540051573	2.75620140895303	3.44847635653991
+XRCC5	15.6485511994452	13.9718291334595	15.1655900119787	15.9896674277136
+BID	37.3859512843894	32.9671925958621	25.8943289715174	28.2021718354112
+PHKB	8.56482569309427	10.5995124487326	10.2142947386925	10.0748111444923
+PFKM	5.60888423279579	6.4051362199881	4.32066165415171	5.6883104843771
+PFKL	21.4230805741696	18.7286650960549	18.8488375870551	18.7033259828236
+QDPR	159.595034886458	165.936554688623	210.026785267431	197.643457678111
+PITPNB	360.197810539502	192.077860463449	95.1092192697193	163.346336795645
+LMAN2L	9.5978092676667	10.7695965051459	11.9448316939418	10.9779862378644
+TTPA	96.0018825795778	93.0917839838836	145.197288750906	162.198741051839
+SND1	43.3242585859928	42.7707389667076	35.0644793778645	36.6582438976897
+TPP1	48.2436772293794	46.3102887603243	64.7038843464638	63.2855907619374
+TPP2	21.083060107582	20.7940616594741	29.447964049677	30.9181053929673
+PSME2	84.4848305091922	83.7518316315257	104.812192128552	105.784399628393
+PSME3	33.1255727871373	35.0368805183914	41.3048457914079	37.3838819365836
+PSME1	121.686128454207	132.150969028841	144.315418677829	139.911282888582
+SRSF6	72.5125587375482	76.8721574654021	95.3146156423398	99.0768008814441
+CUL5	6.20011869437417	6.73595610836283	9.86683738611946	11.6787572668919
+SLK	5.151547952439	5.59545378396116	7.64222252739976	7.48745958689809
+CIDEB	245.85458838176	265.50657590743	183.907003807543	189.210949819046
+CTNNA1	60.3441432893955	56.7793055561829	58.9772839305747	59.0281950481608
+CTNNA2	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+PHYH	688.197844648476	721.803069405695	685.556338516354	688.712626200585
+TAMM41	8.95712938690098	8.67804745613034	6.99601856921458	6.85837380069178
+ABCF1	28.7085241890514	24.1187376610861	18.6524429164111	18.3085876976027
+TOPBP1	17.1793181676845	21.0126963732721	23.1189318405407	24.2478519343311
+CLEC4G	61.9377624554668	53.2093915875917	96.1115237269783	89.6005231604668
+GSPT1	24.1310809357523	29.4231812675696	24.8407601923392	25.311640156315
+SSR1	83.7516509397398	88.9138235038488	81.8350778924123	85.2523835276486
+SSR4	350.327953408153	369.330116755055	206.941504772693	209.812679638859
+TMEM33	32.5245965323839	23.5141309115442	35.0613943221621	33.1097323120709
+CNTRL	7.58232392639251	8.01163562613705	9.41977996803191	10.1026539081406
+SLF1	0.793706032786175	1.91075453452366	2.39083577551986	2.43203359279064
+GDA	10.7350384370192	12.9520393613239	29.4950242948124	29.1451052215487
+TM7SF2	291.542004398717	278.5850612102	184.68624125316	189.814845222148
+ADPGK	7.97956529400927	7.06799467629055	8.39975070366237	8.32851601229047
+MLEC	37.4439121045691	28.8282035412446	35.758198949652	38.077523926832
+TGM2	10.3486285771429	11.4691927760261	19.5615759072075	17.6685007483509
+BGN	60.8353824433538	57.2317328238854	78.2696470771189	74.0297208132895
+CASTOR1	48.3036674623801	44.6669702410799	55.6548796040919	54.9001456817541
+IST1	31.5457898288152	33.1486548966724	34.6837930766505	38.0501348177057
+RAPGEF1	9.12187604489521	9.41786025440413	10.396339747392	11.0048352699071
+XDH	101.202048553012	96.5856328516855	155.316130552726	157.500913001808
+ASPDH	41.5592999592046	41.9269320968054	54.1833574946159	53.9632948153111
+SELENBP1	128.386976648313	131.661185535214	195.671527818047	193.262850530665
+PARK7	196.853883832298	211.01053449687	162.970790243819	168.437443284478
+PRODH2	17.6677859326269	14.9494791902283	24.8993412860327	22.603299913956
+RORC	27.1935096584622	20.973430735189	41.5418266844208	44.6572302886651
+MPP6	9.58481720981553	10.3334615505221	14.7132789309543	13.5833340367894
+EML4	11.6499635840458	11.8791888907856	9.14166578133903	9.66746941437033
+TFRC	32.1588616445542	35.080431918295	42.9903352904979	46.4564554131505
+NSFL1C	51.6797449191978	52.1959665825351	41.9422603705059	42.264780093323
+TAGLN2	158.890476308302	154.304972363477	116.970370421136	121.106719813514
+GUSB	99.5492052096389	89.4623052117609	76.3183345014787	80.0881703157777
+GNPDA1	11.428761876332	11.6264805501862	12.0915474392299	11.8813927210383
+PRPSAP1	27.8178319082472	29.2300797841848	28.2243651101374	28.4827826845491
+LAS1L	28.6258394401495	27.4995813130676	34.2167274444323	33.3578597312871
+ENSBTAG00000040134	-0.0831700079418282	0.336369597315913	0.00134137986675392	0.189229847923004
+PRUNE1	9.18541976886155	9.95036218710292	11.3014639186498	11.2688865440148
+ETFDH	177.037886409563	183.249164696893	145.09781309468	140.832778307184
+SLC25A22	73.9589834419167	68.1724070317227	56.7679363918833	56.7843668062858
+SLC25A20	151.949348366397	142.263863061675	86.8355497020626	85.1757049610774
+ERO1A	9.25440324239461	7.3225526684309	12.0191688060105	11.7732032924544
+CFAP73	0.743363872833968	0.706085352634496	0.300861576029231	0.573142127924048
+SLC3A2	19.7087371039318	20.0718065454623	23.4094532069304	24.4615595221243
+GMPS	29.870982779832	26.7842642045823	26.0516225689546	23.7226373030927
+ENSBTAG00000030384	79.0572387982053	71.8003511502559	75.6411791013714	73.9175523889606
+IKBKB	9.39016871612226	6.42242499099261	9.63838428072726	10.0611783917461
+ATIC	46.0349639719812	41.8548056760177	48.3398152489513	46.7710974149198
+PCTP	166.359642145566	175.083299327738	292.220188583063	299.035809396551
+DHODH	10.1097257817121	29.8612453253894	53.743038156052	44.6535957158876
+ENSBTAG00000046905	294.961776845781	316.75190956572	676.812014673574	734.016393422132
+KPNA6	9.0766959981535	12.0452530588078	14.0199272555947	12.1435781793676
+REXO2	36.3754494468237	37.7208812987856	21.1090331856531	21.7792875522784
+KPNA3	11.6103727488303	12.8328785193649	15.1446676650183	11.3258290429304
+KPNA2	42.5590721305159	45.3785958412507	18.9699240936851	16.8276982964737
+COPB1	47.244652891335	48.7787065596453	45.5610876461587	43.2938003810097
+COPB2	56.7510312632977	59.8038348970272	58.9128676570453	58.4246096983358
+SEL1L	31.3911439801136	30.4874984327682	31.1533109386842	32.2169833706533
+UBE2N	15.7642475622484	18.0733111679771	18.5099683032222	17.8977958130858
+PTPMT1	15.1607116144756	22.5423568368952	9.51453227417887	10.1339818732223
+CRP	666.499088478238	713.541380069835	918.464034661118	906.318178318667
+PLCB1	5.60761456184079	6.00617402612108	8.45444961191414	10.7072765385123
+GORASP2	37.7853181123845	39.0989085134489	39.8021068170872	38.5903525584881
+CARM1	17.2473328256999	17.3610882896556	16.1464690736533	17.9103193908918
+CIAO1	29.7027226805061	31.7538104234952	33.6300821380498	33.1084546098582
+EXOC3L2	15.169530072097	11.5274532597491	12.1798066972612	11.9123200038719
+TMEM177	6.07076994331966	5.4817776815275	4.78095805328256	5.94455991314799
+CRK	28.5760679042961	33.5829530236427	33.8183896098916	36.2494518973819
+EIF5B	18.9574933256212	20.4594532930094	20.2194234505784	19.3886813783932
+NUDT21	13.3898160327846	13.7235935671389	15.8981120108481	15.7039419160264
+EIF5A	165.113608928114	150.057884441389	129.893386160744	134.418586456986
+SUMF2	11.613044248213	10.7428645877262	8.42972029406572	9.10567688491536
+NONO	101.851637823195	103.649731252405	107.904758178213	111.532225062065
+GLDC	59.209549767086	61.1548259100042	61.0569597311577	64.9902748044089
+UNC45A	12.7898362153029	10.2699815457568	9.14453674910732	9.50090834141673
+PC	226.403337366722	207.408392938572	102.763171115844	96.6632336944888
+RTN4IP1	12.1087558944506	12.3114932628181	10.2911697995303	12.1320256104594
+FNDC3A	26.3585435690512	28.5703264957545	34.402696454005	32.8930759898736
+PGK1	95.7840568382875	108.534277983341	75.0372085818883	73.7897244606472
+SULT1C4	291.430011694031	300.024996696624	440.225300844514	422.914030258642
+TUBB6	22.7059237946646	23.2839080788028	13.5079610898157	15.2799731941493
+DHRS11	52.6333820746664	46.4521446062941	30.6731140620596	27.4075045026436
+DHRS12	33.3739529991199	31.3040649093136	41.4674536590385	42.6154586080277
+ACSF3	6.11324553660114	6.52961216294506	7.86146182187559	6.7635716515776
+TUBB3	-0.0774162884737161	0.134034142258097	-0.0046653135275288	0.0876038443049007
+MAN2A1	54.8985492426166	57.0662157202894	61.5936799889028	56.6424365310961
+RPP25L	14.8985978021657	12.0865287859421	11.1641128816336	12.488246056597
+EEF1D	69.578507609549	65.6057500444713	81.5820514564535	79.4905832947988
+SPACA6	0.361573709714022	0.753604635373241	0.978151330632951	2.03827098270122
+GALK1	86.0722710369343	69.3343456711129	68.8171052003845	67.6043755797367
+SH3BGRL3	77.4599927428386	68.3687856822019	93.0551007514801	93.0099697015296
+RPAP1	7.57181758211171	6.57530826304162	5.90514325875072	6.42612515709546
+PRPF19	22.3678715758988	22.7189678577124	22.5218620446562	24.424173415435
+EIF3A	27.1023132321997	25.0313766356453	31.1330275501081	30.9017362415226
+GPD1L	1.57753639655264	2.56191737328948	2.08968319990665	2.89492795660087
+TMLHE	23.905666665915	29.1206372934861	32.796672666397	32.6729224123944
+EIF3B	24.9111665983165	24.660577468471	22.5286637437112	24.2577135567484
+OXA1L	57.3687297631895	52.6429049324472	50.9569901574072	57.3157898007743
+TINAGL1	26.8795714489404	24.9035932894017	18.7854935786453	19.2171353912864
+EIF3E	125.461055182154	140.366120904336	190.522828499359	201.652579842078
+DDC	78.0045646123552	73.5663279823455	56.3898300438292	54.78775350057
+DARS2	8.62937951535084	11.0172857388289	10.9486104386152	11.5994134749835
+RHOT1	9.20073878048794	7.91958000084078	9.30065941712892	9.27781525512538
+ARHGEF1	17.3006014247564	13.5106982766885	13.9487459721145	14.0989463908364
+TP53RK	16.6366476835055	13.7410449567384	15.6367839647921	15.5914477705035
+DNAAF5	2.87768430008665	4.0390439686093	5.23365719219573	4.60014227389485
+POFUT1	14.9784842114819	13.3895714353838	17.3626512199973	14.4667677713188
+STAT6	23.9652450416285	22.9495038451976	32.7175417815338	35.4333163013375
+LAMC1	8.29891786443087	9.27088104888158	8.41521943666484	8.90698680093423
+STAT3	61.8989986629068	62.9659633281389	66.064065393003	63.9660589328523
+STAT2	76.7001680799094	76.4820989909521	53.8704564013336	51.8834507998727
+STAT1	42.3491602526059	44.9403697501803	68.1561309804726	70.320208677919
+CD81	739.195338158362	597.149674912367	785.87986757652	988.73054984824
+ENSBTAG00000037605	112.193515718346	137.455314593375	220.373219966353	222.860096356454
+HPRT1	145.568966743949	139.590835205449	100.974238442668	106.245572789108
+USP19	10.1451441989918	8.83798777996237	10.2671576324857	9.21874454811124
+RPL13A	902.270875008053	855.77939294108	845.415841972656	831.460338493162
+ICAM1	18.5497374712207	20.106848125997	33.4743674214867	33.0954528579065
+CYP7A1	353.321091628517	360.732534452581	114.483237046987	109.379648058528
+CTDSP1	70.9515501890435	57.7823385456826	68.8600005097348	67.386575594568
+DPM1	46.6851838785596	54.3514290186536	61.396419348481	55.7110522780492
+CRYAB	71.2732915801441	64.3750079426704	34.3916038139006	33.1831103407203
+CD68	58.4412491081966	49.2080951615777	99.2358600942641	106.748736064321
+LMNB1	15.4747140613834	16.9248713718601	10.4944202917585	10.3333802981208
+TPD52L2	35.612778578019	33.6052679629902	35.5664908076217	33.950384744388
+MAIP1	16.6308546789095	23.0257225615989	22.7599012933488	22.5482155845606
+EFCAB11	17.126756551107	14.9636598506989	22.5598287168025	23.6153844427344
+AKR1B1	2.96375102454787	4.46447000733232	4.89548897048109	3.40284756391362
+LRBA	8.30205171774549	8.72658812144922	11.8142644146812	11.819947610821
+ENSBTAG00000037510	5.26791630363935	7.26875706005174	7.07208349675611	5.29304238219484
+SLBP2	0.106153018018065	0.264099615389296	0.000138702752987413	0.0124688082336339
+LRP1	75.664005908009	69.4989414331151	82.8018780142199	81.7905462001151
+GSTT1	237.940867116054	219.400278113134	212.564614939351	217.902195332073
+ISOC1	57.8055086852417	55.1754239477193	55.6141451623398	55.1416221830048
+ARPC5L	19.5132338601515	15.467451509124	14.1333202795052	12.0379447589528
+WDR13	17.747915895399	18.6134887223395	15.2689697860508	14.7304825059729
+ATP5PD	220.742913291364	230.031113412964	244.166210542019	225.905011471236
+WDR11	8.09155991029668	9.41917575128198	10.4762363940287	10.4754154133098
+TMTC3	3.60787174427426	4.73734363088774	6.07391287312021	5.19723259731821
+RHEB	64.0377060954215	74.667273342106	64.7727182132688	62.6735842421473
+STIM1	25.3824996003576	23.7695724187523	25.6999653636141	25.8769077652717
+CD276	8.82032610485212	7.41487489874305	9.02341643473609	8.0282668971264
+CREG1	319.913072806807	342.737947415642	447.198175714106	451.535394080552
+CDH17	28.5365228158618	32.1691518265585	17.3929071029114	17.5374991235819
+SPATA20	17.7694446196313	17.388960771261	40.0605742230842	40.4864088105704
+ENSBTAG00000016472	49.944069185075	53.2102174001564	292.459596135763	295.866784432293
+C8A	660.431655902735	672.394521678753	732.850192149645	749.458762514293
+USP9X	23.5800586344973	22.6792434495969	28.5871394071642	28.3273863574209
+GPD1	385.25847634567	378.051617290156	348.306883504822	350.358539264415
+MAP2K6	16.0281244996811	15.7388029790943	7.31155159786695	6.76733220905233
+MAP4	19.7915529433612	19.2116980169171	18.7842481319334	19.9511808356765
+MAP2K4	11.1418565084672	9.77476642791027	9.08703817175683	9.44286636060874
+AACS	2.19053961099219	2.07198490149911	0.821257319530993	0.455875759333
+BCL9L	12.6531228241893	11.491654839831	9.41276916266325	10.6598752288268
+MICU1	22.8984165712335	24.6844200563809	31.4418207167772	29.6078526438213
+TSNAX	13.8695786853758	15.676846328741	13.9183310652625	14.5071776485395
+ENSBTAG00000048135	484.08402799493	454.406002270589	97.4853388800538	100.646252762607
+COX2	9776.28662387725	10716.4991954506	8751.58317732455	8479.36559492404
+GAT	401.62997318607	423.149952043416	441.610012386421	446.459804749416
+MRPL18	25.6051872027575	22.0999961720271	21.2252320409981	20.6800655801328
+PPL	31.1207848637298	28.5060886639143	39.4604125743003	38.4788179418618
+APEX1	43.6918009182472	44.0686703934567	39.0362761536603	37.8022969634495
+ACY1	230.444065173502	222.593854790853	179.292840806379	173.323525673474
+KMT2C	4.91417040642701	4.92766099299135	4.94129973818734	5.2367188120538
+ITPA	20.768905538505	19.9142236859471	22.8120202685552	24.5599059443441
+HSPB1	489.133661145212	415.116092053553	355.908666527239	350.424603569664
+COL18A1	368.410583739019	341.871565459342	335.35403262039	331.354947812265
+CYP4V2	118.354003243845	132.875626717481	227.005039091725	226.84690511476
+PKN2	6.3404605649041	7.71163916198982	7.66757154376476	7.26155683733302
+SUCLG2	178.467666307121	185.538233568009	226.481912503341	224.852913184971
+SUCLG1	164.27042014621	164.596661767684	127.774652520488	126.431615365527
+ENSBTAG00000021368	4.02647067972565	4.43576670363921	1.55075729199277	2.24777849393959
+DYNC1H1	14.8380364259534	15.0025050843806	14.831443481482	14.105847481682
+ALDOA	124.976277936463	122.115887345838	65.2538414399272	66.9595360243201
+ALDOC	4.09829216945825	3.45523596146609	2.48177584667866	2.75464571638655
+ALDOB	3451.90776091453	3546.12972279887	1979.31638044482	1914.85839471516
+ENSBTAG00000019437	47.7443042926225	48.3152315271311	41.1169251165603	42.0364073161225
+ENSBTAG00000046325	3.8208399238172	4.59262319997735	4.83410506090175	4.04830802282109
+DIS3L2	2.83293057424975	3.89743145626384	3.73102802913594	3.23118022242156
+IMPA1	24.6822018888113	23.8100815639814	27.057580761204	26.1623913468736
+RAB30	7.07106445705635	6.46314624791659	5.70432488243445	5.69878596878778
+CYC1	112.436460698199	108.092615132495	64.2569995060522	54.6438213670735
+PON3	264.193717996869	284.964469147879	269.861385932438	274.686204416286
+PON2	59.3201963557475	59.5414483864432	61.7998000773936	60.3229675775943
+PSAT1	152.962937954097	151.777981630948	184.717686117615	188.459215374667
+CPNE3	9.7660026324823	9.90645535258755	15.4505012938512	15.7469105440157
+SPATA2L	4.42717641069718	3.73896054611666	2.82437087437354	2.35173687687219
+CMPK1	66.1636180044806	71.6022588490059	57.7685604645898	53.4854742296461
+HAO1	167.717894978793	160.824591236098	221.358065607454	220.443974209934
+HAO2	187.570971207434	192.025263050411	217.73488876678	214.079960086085
+CMPK2	21.230764301077	18.5762519428301	13.1526928719043	13.3668648633129
+CKAP4	18.7830557856904	17.71858363054	7.28144193655506	7.51224663588441
+EDEM3	9.08769992752261	7.87997696483823	10.2331009426204	9.96834354700514
+FAM213A	63.9696715193459	69.1517156474714	64.4878177119997	66.9365763877794
+GSS	18.9762968394914	18.975843589736	17.5396854579566	16.9979794386655
+GSR	69.2279969734355	69.0235988893484	39.3070839941253	42.0016994981447
+MRPL2	27.3686782377983	28.4758532048872	20.6787950348944	22.6522920667887
+LRPPRC	22.0277996435072	23.6862121519368	27.0438859386522	26.0147568447486
+WASHC5	14.428682492683	17.0896216732749	18.2083006603826	18.5552956019669
+PSMF1	58.4792220928866	54.3311168378969	46.082326968347	44.6353958958178
+PPCDC	16.3661652954611	15.7154079524201	14.4690673271796	12.8918609618256
+AFG3L2	29.7850318291668	28.4001775235546	25.0939970188247	24.9823882942254
+SCO2	10.0480300837977	7.43570421484117	5.62520830383061	5.84375970842581
+SCO1	24.6768359721274	27.2357998822851	25.4907485518165	24.6718904085099
+PBXIP1	26.5678841420868	25.780478902187	25.6353053086839	26.2621257671262
+UGP2	153.807479279161	167.450212271263	252.653407540392	250.892054052141
+HTATIP2	34.5750045019044	34.0791057099677	30.9804714631501	28.6460455781294
+MPST	29.0434347800226	29.6747730019902	24.5852404783233	21.526554983884
+KHK	424.121411542236	398.069851329902	287.711845022062	292.533955886127
+GOLGA5	16.9202116093515	17.1192207392601	16.5383232238207	18.728334914904
+APEH	63.0107623468651	57.1381037083468	52.9024329834931	55.4252409883236
+PTBP2	3.50437045388712	5.120321480847	5.11516862693669	3.8134774564304
+PTBP1	61.792106851724	56.9526504026376	62.5532858623853	90.5634456823494
+NNT	66.5612758120302	68.6387452544516	91.9591221488936	96.2019540925283
+ENSBTAG00000038461	145.170397917537	155.484049359575	331.569435711984	331.125799942062
+BOLA	334.1357501053	328.451874726353	347.761913356719	351.445738758055
+ENPP6	1.11352833752061	2.15750699392109	3.4183815308323	4.68374824425309
+HK3	1.96777435315938	1.90947590090858	4.43719896841559	4.34478955205684
+HK1	4.51687993326148	4.43622454982727	5.56933367307585	5.23941824766038
+ENPP1	41.6851256811112	42.8457198983143	69.1907361126924	69.5436530272398
+ENSBTAG00000015438	100.328016118494	91.3980026147465	96.5294691534659	93.6546580362091
+GIPC1	11.4277160848065	11.2773021623264	7.96787002548607	8.69118025216987
+MGC152010	527.247902239854	574.719200908395	859.523104420852	856.862759415067
+CSNK2A1	32.4656455354029	31.8142249423965	35.5107331221583	28.974282542234
+KCTD12	7.8759719298296	9.57184068445817	13.4443681453086	12.9261000270817
+MTCH1	71.6014500318977	67.6970157452901	65.3928229570774	61.7590442620856
+ENSBTAG00000001700	96.709309734878	89.3699825419507	127.489149037838	108.715602572932
+MSRA	198.979208792047	217.660540394948	280.194783446184	266.897301418176
+PPIP5K1	3.16771452170751	3.5071360385884	3.23464110022609	2.96175755469464
+ALDH1L2	17.7070197203968	18.279888142472	20.1158306692226	21.0386507848915
+DHDH	0.0581083664627774	1.06266070693223	0.659910471638891	1.62193107520772
+CPS1	1015.03495063784	1059.86766480298	1041.36139659889	1031.34079350451
+TJP3	5.33849093420849	5.94831687438961	4.28106682647141	4.19657247884915
+PLS1	12.3824735501403	11.7047922786731	16.3321758966762	17.119207733288
+PABPC1	157.175590202279	165.887868423322	201.975619550826	200.237891039401
+MACF1	10.4860303733842	11.3407338436167	12.1061646889973	11.8755609619116
+PABPC4	37.0073640188839	36.0643267010883	39.0770837735542	35.9400903011878
+H6PD	25.1824525631432	22.0817055358498	34.6497571369148	33.7804786627786
+CHCHD10	436.556921342311	386.527804386428	329.742261695376	314.466096102487
+GRHPR	140.340147500654	133.364427480606	105.373264063931	108.518650008552
+JSP.1	145.406970348444	130.858672903965	162.275328129491	162.649185902303
+DLAT	9.76486274713574	10.0629384608034	10.252222535635	9.8843259031543
+DNM2	22.6381125407442	20.7047151059998	16.8311293711382	16.9572373751209
+DLGAP5	6.94168320497557	7.00679498784597	2.15170361399677	2.25614640502072
+ADPRH	19.0551036954799	21.6633529080608	20.5196433017802	17.3422729463392
+PDHX	9.87198721613451	9.51152293393627	9.38879915168634	8.36734675092298
+C14H8orf33	6.35155588580121	8.95547696523315	5.36175740785933	6.67839143560736
+TRAP1	21.7633894261898	23.2278802326696	18.0120618706945	17.386040627109
+TRABD	41.5119353517831	40.0943537624348	34.0813877205476	34.2955447657234
+GOLPH3	17.3684332128233	18.1370240728292	18.1409333709834	19.6663049547591
+TUBA1D	2.86316992433849	1.98730260289615	0.991472233976692	0.913767360463091
+ARHGEF37	7.64007537466363	9.05655908795872	7.62489155376112	6.66173528565187
+PIK3R4	13.1027470315307	13.1144889000207	14.8492296616698	15.0618860483517
+PIK3R1	20.9302465344734	24.2368400106678	36.9054017519066	38.2380072593127
+PDHB	63.5985433226674	66.0883293891273	60.4632956869974	59.4235674015974
+OS9	190.626531539601	182.701322081904	230.402995583996	228.470274325779
+GYS1	3.45956558132797	3.22906260841617	3.31761088335026	2.91412568764841
+DSTN	118.017543387822	120.249289252258	135.970132888052	129.526156270366
+GYS2	88.501114834891	89.9220101938546	84.2792287498104	82.2392986396327
+PCBD1	303.778815408818	317.373047853574	339.076481249434	342.729239412448
+ENSBTAG00000047868	14.9011726827145	12.5492108373937	21.3059699074118	17.9134496589239
+ASMTL	43.2900545606576	39.8325034971835	34.06063474181	32.9999292710297
+AP1G1	23.4928976107536	23.5122367599228	32.7676734811657	36.2840255893495
+G6PD	9.74110175474349	9.15443642207596	10.1947423250947	10.6922396771276
+HMOX1	94.5345658311689	96.076458768341	166.025857888372	166.032163636329
+USP10	18.7755663923175	20.9416310777884	14.5605539662602	15.1311878428841
+HMOX2	51.6287102313384	49.0590585279345	38.8904436352197	35.2987847703607
+ELMO3	12.7956638592499	10.4710270918202	11.0742755464958	9.83727506578679
+AASDHPPT	19.1879741963346	22.050346679325	23.0291238356126	26.279569987493
+GATD1	17.6557301095478	15.4078952909406	12.2362333131729	12.135342251792
+SULT1B1	48.8751080416642	45.2436347257541	44.8067473580682	44.5275669504281
+TUBA8	17.5722077879855	14.9056682186825	16.3827711052815	14.8464311057785
+RAD23B	73.4193674995929	87.1377296427218	84.6984455407686	80.1680277260265
+EHD2	2.77838489510825	3.04260351258535	2.49681188702543	2.2820198577997
+EHD1	50.7645636676094	42.9372494912876	37.4893545874391	38.6283774117773
+ZER1	11.380113364983	9.67183182579823	10.8337487205005	10.2754819426689
+RPS18	1224.55008039431	1153.92892777079	1015.20806121192	1031.59513195139
+IYD	79.0421074773175	75.7748146805289	88.7538559412406	84.1982245267858
+STOM	123.375413201999	130.062763337908	180.747148384111	186.988817825313
+RBKS	20.9812744565393	22.4174383324462	14.2981464468043	16.0419242278195
+NPLOC4	20.2069825431381	19.4790287213838	17.9196243898731	19.3632395568121
+IDE	15.3826661274661	15.6786108042442	18.502163960468	19.0154116845995
+MBLAC2	2.93422751402475	3.11833731302927	4.43548152868138	3.61392008928895
+ENSBTAG00000038171	196.268578645567	207.760567600323	241.621757337222	240.881711567728
+FAHD2A	87.8083042829723	78.2576003419607	74.0486493085067	76.6994031747348
+TMED4	46.6040708253926	49.970480253914	39.3924497379826	41.1908906015733
+SNX5	58.0632176766377	64.2645769326113	69.3322021508398	71.2390044330657
+TMED1	21.1550574429793	17.9316183062525	19.2845642083999	15.3684430580934
+CGN	36.4595414913225	32.0950532381475	28.5328117882117	30.32415344131
+HNRNPR	39.6074077331533	40.6374907810351	38.7997986169393	39.81730375341
+ENSBTAG00000035584	12.2770721103672	13.6590283399985	13.1723897904586	14.5969677517862
+TMED9	124.546993815518	122.23059002418	105.468276523977	106.489434562028
+AP2M1	123.897418750213	117.027371680683	111.379756213687	107.518606639905
+HNRNPK	216.438371119715	210.869716421668	219.486206150716	215.818466293076
+HNRNPL	63.0577494611125	62.4953862674554	63.5605075649486	63.8489052278032
+HNRNPM	81.4352431238127	80.2727854827795	64.8668230991941	64.0386505254954
+PML	6.40740861999599	3.74233508171709	4.64471418122886	4.9399741753774
+HNRNPC	83.1127894198936	87.7399828792461	91.5373073681659	95.2423540512587
+HNRNPD	65.1874119065708	67.9524196027318	67.9990778723265	69.3000376964631
+RPL27A	1110.60736878681	1141.59599801037	1079.30175588219	1100.68639698477
+HNRNPF	188.635171730018	198.121645510779	236.716997853245	236.723021834018
+TMEM205	184.489398561876	174.382840841176	180.882975921995	178.962536988835
+FMO1	663.957629180915	701.06736922803	980.878173975301	979.502184481915
+ENSBTAG00000038549	108.747288945721	99.9133579846071	107.666944235911	110.615632930359
+RCC2	12.700862348812	10.5340919790125	9.70386747308079	8.69050885707611
+PBLD	55.2597272119143	56.1092389554101	66.6264020139609	63.3892449572176
+EEF1B2	391.881152100155	409.230484090909	434.488618287884	458.741411147348
+ERP44	86.621974076124	87.4279702127664	87.2204247605244	87.1048737950272
+GCAT	96.8297751911387	95.783827835909	94.1867552227682	97.4489230250513
+STAU1	36.7173904932472	40.4759046716152	41.407438398495	39.3263328220922
+FAAH	86.5698629893087	79.852719894669	70.6273918181793	76.8793186709116
+VPS26C	6.00710611891897	6.46867816243839	5.7513743141297	6.507044092946
+PSPH	16.854154708231	16.0251137708093	7.7486597488712	6.35833523027556
+UGT1A1	684.188701174059	693.882804307321	640.149009955714	639.535572756478
+ENSBTAG00000002943	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+PGPEP1	47.2686906102461	49.8973593856128	49.4809856408309	48.8566214838105
+GLUD1	656.110818700157	667.614033257216	643.845919696242	625.83289405332
+ENSBTAG00000037613	450.803459117423	485.334795333524	458.480418159638	460.051420106146
+TIMM29	6.73378809403034	4.61606265009626	5.61971147526111	5.61103274347862
+HSP90AA1	264.959876171417	281.737117804499	211.559533011189	204.419349845353
+TIMM23	48.2276937250432	49.5477610413749	38.2010716471407	39.5516764220633
+TIMM22	2.9779359455591	5.03513830922428	4.57766504719711	3.69019224325445
+TIMM21	22.9633660509231	25.5427128457841	22.9471924440751	22.7741109146881
+KARS	54.2791009534698	52.7908967916207	67.7231516102737	67.5815708119999
+HP1BP3	29.3421095840681	31.39238753324	33.7829527675812	32.7847645169075
+NDUFS8	85.4156300221413	91.7853322351507	65.392093459396	61.6781463892882
+CYP2D14	231.360921414891	224.485267054532	456.577628032366	448.65397703679
+TXNDC11	51.6403424117011	51.0785155914478	36.8772113020138	37.7219423903237
+CD58	22.8671692478851	25.164892363039	25.7169492114737	24.1581392883673
+SCP2	749.564202612591	777.679865805852	932.056096360398	939.928108070764
+MSN	14.8468265774399	18.6138096199231	21.6626739228865	21.3568084413381
+ZNF326	17.7799256975569	15.6250344604187	18.3714769148998	18.8137140847393
+CACYBP	65.8511268882502	67.8944752372627	52.7753585597001	60.9440250551207
+PDE2A	12.1014198230228	10.126228483765	12.4896304121948	9.95500686142616
+OPLAH	11.7527157254726	9.82513795202479	5.45271711808034	6.05224514488442
+SEC31A	55.4599343957457	58.5404301901295	58.8760181715344	60.7197082614718
+PRRC1	34.7463089404113	32.2595374347583	27.6716014035645	30.7583958831148
+RAB35	7.82839916809587	8.0124938651858	8.0771538438553	8.58774636109239
+SRP54	26.9210223365744	31.7450878893208	31.7787240409449	31.42668406125
+RAB32	142.550735319666	134.51170785237	117.39958831372	115.689748377378
+CAND1	12.6044607008631	14.5021655863634	15.2072452439481	14.6914434731307
+PRPS1	15.3347060001018	15.2261635475863	15.8085120424699	14.9796706811849
+DAO	50.3961515965993	41.4898908105392	77.8295602693701	77.9014073714062
+TATDN1	28.3902774962365	29.2063037345338	40.062345321928	38.8554011671924
+ENSBTAG00000037509	153.974244178864	168.577857027868	118.59223268085	119.688275843892
+RPIA	10.0411202069523	7.71295440633761	8.06876082077743	7.9312262952526
+TTLL12	26.3146835863755	23.400308321264	24.8959310699421	23.8929300367068
+LDHD	13.3865059324636	12.7769732843129	16.0981763399116	16.158255124931
+GMPR2	61.5603561075099	52.7488327338009	46.6696736465609	46.7349152524274
+LDHA	207.730032556293	226.891741973915	52.7798443855118	53.0922016798784
+LDHB	1213.63815105495	1294.32612194355	407.184967798351	410.717652900092
+LDHC	0.996700003910787	1.4243441795977	0.367575854627836	0.529836482163856
+LONP2	104.723442540721	106.230729202829	113.693254984474	116.563293627589
+PLS3	56.7198089183436	62.5935429696212	54.6704613566612	54.8233621601003
+LONP1	35.0285838875834	35.3617280286151	29.2954355019332	32.2547575935306
+PRPS1L1	-0.0758996600312405	0.135819323886117	-0.00624862361024775	0.00569716975406065
+PDIA6	237.078629510045	246.02532052621	161.475583919526	161.739154992676
+PDIA5	25.0597837080607	28.3971220939429	41.715172486751	39.338047316991
+PDIA4	211.873913148269	210.001936921539	145.23112104313	147.050443090863
+PDIA3	338.000109411079	361.355970968745	254.175745803677	263.613526088518
+GAPDHS	4.02245035382783	3.92129771588966	5.37370796946667	3.21280136749778
+CFL2	16.4395278148457	16.6215740674699	11.4464590162857	14.0380871787687
+CFL1	270.858978945402	277.97105818897	251.876578742101	259.003824894279
+PLAA	16.1144856376278	15.9790411228606	14.0881689734665	17.6164371479456
+BICD2	8.08825997009739	8.13016509366486	7.54569660889039	8.09658275324354
+SEC22B	28.0158406759932	26.2168927410539	25.8085478130071	26.2476955958624
+NFIA	18.7998060312645	20.6019630622779	25.8027529792118	24.0930147370757
+CD163	41.2947020425552	45.7036852574451	72.9594414051051	75.7918900293897
+AARS	34.2338462472451	28.8187366028439	28.2737262835897	29.253852156971
+PDCD6IP	47.5366726918095	49.4878158869482	49.3569707972503	51.6081599918002
+TSGA10	0.532544422811476	0.549561083730723	0.808442535970308	0.993907565460829
+DNM1L	10.9793186842086	11.8429623497427	10.0686886407995	10.7556465831498
+SERPINH1	15.3198304548624	15.9048127634568	8.28307047703207	9.71105820398736
+FOLR3	138.428905969161	116.281636988597	85.8755941382458	89.4439500612999
+C5orf51	17.2935605353597	15.0249063894766	19.5560379723125	22.1981123516811
+GSTK1	217.176269127719	211.304802899312	239.829423960609	229.9821520916