diff --git a/DESeq2.R b/DESeq2.R new file mode 100644 index 0000000..7af2fc9 --- /dev/null +++ b/DESeq2.R @@ -0,0 +1,574 @@ +## ----setup, echo=FALSE, results="hide"---------------------------------------- +knitr::opts_chunk$set(tidy = FALSE, + cache = FALSE, + dev = "png", + message = FALSE, error = FALSE, warning = TRUE) + +## ----quickStart, eval=FALSE--------------------------------------------------- +# dds <- DESeqDataSetFromMatrix(countData = cts, +# colData = coldata, +# design= ~ batch + condition) +# dds <- DESeq(dds) +# resultsNames(dds) # lists the coefficients +# res <- results(dds, name="condition_trt_vs_untrt") +# # or to shrink log fold changes association with condition: +# res <- lfcShrink(dds, coef="condition_trt_vs_untrt", type="apeglm") + +## ----txiSetup----------------------------------------------------------------- +library("tximport") +library("readr") +library("tximportData") +dir <- system.file("extdata", package="tximportData") +samples <- read.table(file.path(dir,"samples.txt"), header=TRUE) +samples$condition <- factor(rep(c("A","B"),each=3)) +rownames(samples) <- samples$run +samples[,c("pop","center","run","condition")] + +## ----txiFiles----------------------------------------------------------------- +files <- file.path(dir,"salmon", samples$run, "quant.sf.gz") +names(files) <- samples$run +tx2gene <- read_csv(file.path(dir, "tx2gene.gencode.v27.csv")) + +## ----tximport, results="hide"------------------------------------------------- +txi <- tximport(files, type="salmon", tx2gene=tx2gene) + +## ----txi2dds, results="hide"-------------------------------------------------- +library("DESeq2") +ddsTxi <- DESeqDataSetFromTximport(txi, + colData = samples, + design = ~ condition) + +## ----------------------------------------------------------------------------- +coldata <- samples +coldata$files <- files +coldata$names <- coldata$run + +## ----echo=FALSE--------------------------------------------------------------- +library("tximeta") +se <- tximeta(coldata, skipMeta=TRUE) +ddsTxi2 <- DESeqDataSet(se, design = ~condition) + +## ----eval=FALSE--------------------------------------------------------------- +# library("tximeta") +# se <- tximeta(coldata) +# ddsTxi <- DESeqDataSet(se, design = ~ condition) + +## ----loadPasilla-------------------------------------------------------------- +library("pasilla") +pasCts <- system.file("extdata", + "pasilla_gene_counts.tsv", + package="pasilla", mustWork=TRUE) +pasAnno <- system.file("extdata", + "pasilla_sample_annotation.csv", + package="pasilla", mustWork=TRUE) +cts <- as.matrix(read.csv(pasCts,sep="\t",row.names="gene_id")) +coldata <- read.csv(pasAnno, row.names=1) +coldata <- coldata[,c("condition","type")] +coldata$condition <- factor(coldata$condition) +coldata$type <- factor(coldata$type) + +## ----showPasilla-------------------------------------------------------------- +head(cts,2) +coldata + +## ----reorderPasila------------------------------------------------------------ +rownames(coldata) <- sub("fb", "", rownames(coldata)) +all(rownames(coldata) %in% colnames(cts)) +all(rownames(coldata) == colnames(cts)) +cts <- cts[, rownames(coldata)] +all(rownames(coldata) == colnames(cts)) + +## ----matrixInput-------------------------------------------------------------- +library("DESeq2") +dds <- DESeqDataSetFromMatrix(countData = cts, + colData = coldata, + design = ~ condition) +dds + +## ----addFeatureData----------------------------------------------------------- +featureData <- data.frame(gene=rownames(cts)) +mcols(dds) <- DataFrame(mcols(dds), featureData) +mcols(dds) + +## ----htseqDirI, eval=FALSE---------------------------------------------------- +# directory <- "/path/to/your/files/" + +## ----htseqDirII--------------------------------------------------------------- +directory <- system.file("extdata", package="pasilla", + mustWork=TRUE) + +## ----htseqInput--------------------------------------------------------------- +sampleFiles <- grep("treated",list.files(directory),value=TRUE) +sampleCondition <- sub("(.*treated).*","\\1",sampleFiles) +sampleTable <- data.frame(sampleName = sampleFiles, + fileName = sampleFiles, + condition = sampleCondition) +sampleTable$condition <- factor(sampleTable$condition) + +## ----hsteqDds----------------------------------------------------------------- +library("DESeq2") +ddsHTSeq <- DESeqDataSetFromHTSeqCount(sampleTable = sampleTable, + directory = directory, + design= ~ condition) +ddsHTSeq + +## ----loadSumExp--------------------------------------------------------------- +library("airway") +data("airway") +se <- airway + +## ----sumExpInput-------------------------------------------------------------- +library("DESeq2") +ddsSE <- DESeqDataSet(se, design = ~ cell + dex) +ddsSE + +## ----prefilter---------------------------------------------------------------- +keep <- rowSums(counts(dds)) >= 10 +dds <- dds[keep,] + +## ----factorlvl---------------------------------------------------------------- +dds$condition <- factor(dds$condition, levels = c("untreated","treated")) + +## ----relevel------------------------------------------------------------------ +dds$condition <- relevel(dds$condition, ref = "untreated") + +## ----droplevels--------------------------------------------------------------- +dds$condition <- droplevels(dds$condition) + +## ----deseq-------------------------------------------------------------------- +dds <- DESeq(dds) +res <- results(dds) +res + +## ----eval=FALSE--------------------------------------------------------------- +# res <- results(dds, name="condition_treated_vs_untreated") +# res <- results(dds, contrast=c("condition","treated","untreated")) + +## ----lfcShrink---------------------------------------------------------------- +resultsNames(dds) +resLFC <- lfcShrink(dds, coef="condition_treated_vs_untreated", type="apeglm") +resLFC + +## ----parallel, eval=FALSE----------------------------------------------------- +# library("BiocParallel") +# register(MulticoreParam(4)) + +## ----resOrder----------------------------------------------------------------- +resOrdered <- res[order(res$pvalue),] + +## ----sumRes------------------------------------------------------------------- +summary(res) + +## ----sumRes01----------------------------------------------------------------- +sum(res$padj < 0.1, na.rm=TRUE) + +## ----resAlpha05--------------------------------------------------------------- +res05 <- results(dds, alpha=0.05) +summary(res05) +sum(res05$padj < 0.05, na.rm=TRUE) + +## ----IHW, eval=FALSE---------------------------------------------------------- +# # (unevaluated code chunk) +# library("IHW") +# resIHW <- results(dds, filterFun=ihw) +# summary(resIHW) +# sum(resIHW$padj < 0.1, na.rm=TRUE) +# metadata(resIHW)$ihwResult + +## ----MA----------------------------------------------------------------------- +plotMA(res, ylim=c(-2,2)) + +## ----shrunkMA----------------------------------------------------------------- +plotMA(resLFC, ylim=c(-2,2)) + +## ----MAidentify, eval=FALSE--------------------------------------------------- +# idx <- identify(res$baseMean, res$log2FoldChange) +# rownames(res)[idx] + +## ----warning=FALSE------------------------------------------------------------ +resultsNames(dds) +# because we are interested in treated vs untreated, we set 'coef=2' +resNorm <- lfcShrink(dds, coef=2, type="normal") +resAsh <- lfcShrink(dds, coef=2, type="ashr") + +## ----fig.width=8, fig.height=3------------------------------------------------ +par(mfrow=c(1,3), mar=c(4,4,2,1)) +xlim <- c(1,1e5); ylim <- c(-3,3) +plotMA(resLFC, xlim=xlim, ylim=ylim, main="apeglm") +plotMA(resNorm, xlim=xlim, ylim=ylim, main="normal") +plotMA(resAsh, xlim=xlim, ylim=ylim, main="ashr") + +## ----plotCounts--------------------------------------------------------------- +plotCounts(dds, gene=which.min(res$padj), intgroup="condition") + +## ----plotCountsAdv------------------------------------------------------------ +d <- plotCounts(dds, gene=which.min(res$padj), intgroup="condition", + returnData=TRUE) +library("ggplot2") +ggplot(d, aes(x=condition, y=count)) + + geom_point(position=position_jitter(w=0.1,h=0)) + + scale_y_log10(breaks=c(25,100,400)) + +## ----metadata----------------------------------------------------------------- +mcols(res)$description + +## ----export, eval=FALSE------------------------------------------------------- +# write.csv(as.data.frame(resOrdered), +# file="condition_treated_results.csv") + +## ----subset------------------------------------------------------------------- +resSig <- subset(resOrdered, padj < 0.1) +resSig + +## ----multifactor-------------------------------------------------------------- +colData(dds) + +## ----copyMultifactor---------------------------------------------------------- +ddsMF <- dds + +## ----fixLevels---------------------------------------------------------------- +levels(ddsMF$type) +levels(ddsMF$type) <- sub("-.*", "", levels(ddsMF$type)) +levels(ddsMF$type) + +## ----replaceDesign------------------------------------------------------------ +design(ddsMF) <- formula(~ type + condition) +ddsMF <- DESeq(ddsMF) + +## ----multiResults------------------------------------------------------------- +resMF <- results(ddsMF) +head(resMF) + +## ----multiTypeResults--------------------------------------------------------- +resMFType <- results(ddsMF, + contrast=c("type", "single", "paired")) +head(resMFType) + +## ----rlogAndVST--------------------------------------------------------------- +vsd <- vst(dds, blind=FALSE) +rld <- rlog(dds, blind=FALSE) +head(assay(vsd), 3) + +## ----meansd------------------------------------------------------------------- +# this gives log2(n + 1) +ntd <- normTransform(dds) +library("vsn") +meanSdPlot(assay(ntd)) +meanSdPlot(assay(vsd)) +meanSdPlot(assay(rld)) + +## ----heatmap------------------------------------------------------------------ +library("pheatmap") +select <- order(rowMeans(counts(dds,normalized=TRUE)), + decreasing=TRUE)[1:20] +df <- as.data.frame(colData(dds)[,c("condition","type")]) +pheatmap(assay(ntd)[select,], cluster_rows=FALSE, show_rownames=FALSE, + cluster_cols=FALSE, annotation_col=df) +pheatmap(assay(vsd)[select,], cluster_rows=FALSE, show_rownames=FALSE, + cluster_cols=FALSE, annotation_col=df) +pheatmap(assay(rld)[select,], cluster_rows=FALSE, show_rownames=FALSE, + cluster_cols=FALSE, annotation_col=df) + +## ----sampleClust-------------------------------------------------------------- +sampleDists <- dist(t(assay(vsd))) + +## ----figHeatmapSamples, fig.height=4, fig.width=6----------------------------- +library("RColorBrewer") +sampleDistMatrix <- as.matrix(sampleDists) +rownames(sampleDistMatrix) <- paste(vsd$condition, vsd$type, sep="-") +colnames(sampleDistMatrix) <- NULL +colors <- colorRampPalette( rev(brewer.pal(9, "Blues")) )(255) +pheatmap(sampleDistMatrix, + clustering_distance_rows=sampleDists, + clustering_distance_cols=sampleDists, + col=colors) + +## ----figPCA------------------------------------------------------------------- +plotPCA(vsd, intgroup=c("condition", "type")) + +## ----figPCA2------------------------------------------------------------------ +pcaData <- plotPCA(vsd, intgroup=c("condition", "type"), returnData=TRUE) +percentVar <- round(100 * attr(pcaData, "percentVar")) +ggplot(pcaData, aes(PC1, PC2, color=condition, shape=type)) + + geom_point(size=3) + + xlab(paste0("PC1: ",percentVar[1],"% variance")) + + ylab(paste0("PC2: ",percentVar[2],"% variance")) + + coord_fixed() + +## ----WaldTest, eval=FALSE----------------------------------------------------- +# dds <- estimateSizeFactors(dds) +# dds <- estimateDispersions(dds) +# dds <- nbinomWaldTest(dds) + +## ----simpleContrast, eval=FALSE----------------------------------------------- +# results(dds, contrast=c("condition","C","B")) + +## ----combineFactors, eval=FALSE----------------------------------------------- +# dds$group <- factor(paste0(dds$genotype, dds$condition)) +# design(dds) <- ~ group +# dds <- DESeq(dds) +# resultsNames(dds) +# results(dds, contrast=c("group", "IB", "IA")) + +## ----interFig, echo=FALSE, results="hide", fig.height=3----------------------- +npg <- 20 +mu <- 2^c(8,10,9,11,10,12) +cond <- rep(rep(c("A","B"),each=npg),3) +geno <- rep(c("I","II","III"),each=2*npg) +table(cond, geno) +counts <- rnbinom(6*npg, mu=rep(mu,each=npg), size=1/.01) +d <- data.frame(log2c=log2(counts+1), cond, geno) +library("ggplot2") +plotit <- function(d, title) { + ggplot(d, aes(x=cond, y=log2c, group=geno)) + + geom_jitter(size=1.5, position = position_jitter(width=.15)) + + facet_wrap(~ geno) + + stat_summary(fun.y=mean, geom="line", colour="red", size=0.8) + + xlab("condition") + ylab("log2(counts+1)") + ggtitle(title) +} +plotit(d, "Gene 1") + ylim(7,13) +lm(log2c ~ cond + geno + geno:cond, data=d) + +## ----interFig2, echo=FALSE, results="hide", fig.height=3---------------------- +mu[4] <- 2^12 +mu[6] <- 2^8 +counts <- rnbinom(6*npg, mu=rep(mu,each=npg), size=1/.01) +d2 <- data.frame(log2c=log2(counts + 1), cond, geno) +plotit(d2, "Gene 2") + ylim(7,13) +lm(log2c ~ cond + geno + geno:cond, data=d2) + +## ----simpleLRT, eval=FALSE---------------------------------------------------- +# dds <- DESeq(dds, test="LRT", reduced=~1) +# res <- results(dds) + +## ----simpleLRT2, eval=FALSE--------------------------------------------------- +# dds <- DESeq(dds, test="LRT", reduced=~batch) +# res <- results(dds) + +## ----apeThresh---------------------------------------------------------------- +resApeT <- lfcShrink(dds, coef=2, type="apeglm", lfcThreshold=1) +plotMA(resApeT, ylim=c(-3,3), cex=.8) +abline(h=c(-1,1), col="dodgerblue", lwd=2) + +## ----------------------------------------------------------------------------- +condition <- factor(rep(c("A","B","C"),each=2)) +model.matrix(~ condition) +# to compare C vs B, make B the reference level, +# and select the last coefficient +condition <- relevel(condition, "B") +model.matrix(~ condition) + +## ----------------------------------------------------------------------------- +grp <- factor(rep(1:3,each=4)) +cnd <- factor(rep(rep(c("A","B"),each=2),3)) +model.matrix(~ grp + cnd + grp:cnd) +# to compare condition effect in group 3 vs 2, +# make group 2 the reference level, +# and select the last coefficient +grp <- relevel(grp, "2") +model.matrix(~ grp + cnd + grp:cnd) + +## ----------------------------------------------------------------------------- +grp <- factor(rep(1:2,each=4)) +ind <- factor(rep(rep(1:2,each=2),2)) +cnd <- factor(rep(c("A","B"),4)) +model.matrix(~grp + grp:ind + grp:cnd) +# to compare condition effect across group, +# add a main effect for 'cnd', +# and select the last coefficient +model.matrix(~grp + cnd + grp:ind + grp:cnd) + +## ----boxplotCooks------------------------------------------------------------- +par(mar=c(8,5,2,2)) +boxplot(log10(assays(dds)[["cooks"]]), range=0, las=2) + +## ----dispFit------------------------------------------------------------------ +plotDispEsts(dds) + +## ----dispFitCustom------------------------------------------------------------ +ddsCustom <- dds +useForMedian <- mcols(ddsCustom)$dispGeneEst > 1e-7 +medianDisp <- median(mcols(ddsCustom)$dispGeneEst[useForMedian], + na.rm=TRUE) +dispersionFunction(ddsCustom) <- function(mu) medianDisp +ddsCustom <- estimateDispersionsMAP(ddsCustom) + +## ----filtByMean--------------------------------------------------------------- +metadata(res)$alpha +metadata(res)$filterThreshold +plot(metadata(res)$filterNumRej, + type="b", ylab="number of rejections", + xlab="quantiles of filter") +lines(metadata(res)$lo.fit, col="red") +abline(v=metadata(res)$filterTheta) + +## ----noFilt------------------------------------------------------------------- +resNoFilt <- results(dds, independentFiltering=FALSE) +addmargins(table(filtering=(res$padj < .1), + noFiltering=(resNoFilt$padj < .1))) + +## ----lfcThresh---------------------------------------------------------------- +par(mfrow=c(2,2),mar=c(2,2,1,1)) +ylim <- c(-2.5,2.5) +resGA <- results(dds, lfcThreshold=.5, altHypothesis="greaterAbs") +resLA <- results(dds, lfcThreshold=.5, altHypothesis="lessAbs") +resG <- results(dds, lfcThreshold=.5, altHypothesis="greater") +resL <- results(dds, lfcThreshold=.5, altHypothesis="less") +drawLines <- function() abline(h=c(-.5,.5),col="dodgerblue",lwd=2) +plotMA(resGA, ylim=ylim); drawLines() +plotMA(resLA, ylim=ylim); drawLines() +plotMA(resG, ylim=ylim); drawLines() +plotMA(resL, ylim=ylim); drawLines() + +## ----mcols-------------------------------------------------------------------- +mcols(dds,use.names=TRUE)[1:4,1:4] +substr(names(mcols(dds)),1,10) +mcols(mcols(dds), use.names=TRUE)[1:4,] + +## ----muAndCooks--------------------------------------------------------------- +head(assays(dds)[["mu"]]) +head(assays(dds)[["cooks"]]) + +## ----dispersions-------------------------------------------------------------- +head(dispersions(dds)) +head(mcols(dds)$dispersion) + +## ----sizefactors-------------------------------------------------------------- +sizeFactors(dds) + +## ----coef--------------------------------------------------------------------- +head(coef(dds)) + +## ----betaPriorVar------------------------------------------------------------- +attr(dds, "betaPriorVar") + +## ----priorInfo---------------------------------------------------------------- +priorInfo(resLFC) +priorInfo(resNorm) +priorInfo(resAsh) + +## ----dispPriorVar------------------------------------------------------------- +dispersionFunction(dds) +attr(dispersionFunction(dds), "dispPriorVar") + +## ----versionNum--------------------------------------------------------------- +metadata(dds)[["version"]] + +## ----normFactors, eval=FALSE-------------------------------------------------- +# normFactors <- normFactors / exp(rowMeans(log(normFactors))) +# normalizationFactors(dds) <- normFactors + +## ----offsetTransform, eval=FALSE---------------------------------------------- +# cqnOffset <- cqnObject$glm.offset +# cqnNormFactors <- exp(cqnOffset) +# EDASeqNormFactors <- exp(-1 * EDASeqOffset) + +## ----lineardep, echo=FALSE---------------------------------------------------- +DataFrame(batch=factor(c(1,1,2,2)), condition=factor(c("A","A","B","B"))) + +## ----lineardep2, echo=FALSE--------------------------------------------------- +DataFrame(batch=factor(c(1,1,1,1,2,2)), condition=factor(c("A","A","B","B","C","C"))) + +## ----lineardep3, echo=FALSE--------------------------------------------------- +DataFrame(batch=factor(c(1,1,1,2,2,2)), condition=factor(c("A","B","C","A","B","C"))) + +## ----groupeffect-------------------------------------------------------------- +coldata <- DataFrame(grp=factor(rep(c("X","Y"),each=6)), + ind=factor(rep(1:6,each=2)), + cnd=factor(rep(c("A","B"),6))) +coldata + +## ----------------------------------------------------------------------------- +as.data.frame(coldata) + +## ----groupeffect2------------------------------------------------------------- +coldata$ind.n <- factor(rep(rep(1:3,each=2),2)) +as.data.frame(coldata) + +## ----groupeffect3------------------------------------------------------------- +model.matrix(~ grp + grp:ind.n + grp:cnd, coldata) + +## ----groupeffect4, eval=FALSE------------------------------------------------- +# results(dds, contrast=list("grpY.cndB","grpX.cndB")) + +## ----missingcombo------------------------------------------------------------- +group <- factor(rep(1:3,each=6)) +condition <- factor(rep(rep(c("A","B","C"),each=2),3)) +d <- DataFrame(group, condition)[-c(17,18),] +as.data.frame(d) + +## ----missingcombo2------------------------------------------------------------ +m1 <- model.matrix(~ condition*group, d) +colnames(m1) +unname(m1) +all.zero <- apply(m1, 2, function(x) all(x==0)) +all.zero + +## ----missingcombo3------------------------------------------------------------ +idx <- which(all.zero) +m1 <- m1[,-idx] +unname(m1) + +## ----cooksPlot---------------------------------------------------------------- +W <- res$stat +maxCooks <- apply(assays(dds)[["cooks"]],1,max) +idx <- !is.na(W) +plot(rank(W[idx]), maxCooks[idx], xlab="rank of Wald statistic", + ylab="maximum Cook's distance per gene", + ylim=c(0,5), cex=.4, col=rgb(0,0,0,.3)) +m <- ncol(dds) +p <- 3 +abline(h=qf(.99, p, m - p)) + +## ----indFilt------------------------------------------------------------------ +plot(res$baseMean+1, -log10(res$pvalue), + log="x", xlab="mean of normalized counts", + ylab=expression(-log[10](pvalue)), + ylim=c(0,30), + cex=.4, col=rgb(0,0,0,.3)) + +## ----histindepfilt------------------------------------------------------------ +use <- res$baseMean > metadata(res)$filterThreshold +h1 <- hist(res$pvalue[!use], breaks=0:50/50, plot=FALSE) +h2 <- hist(res$pvalue[use], breaks=0:50/50, plot=FALSE) +colori <- c(`do not pass`="khaki", `pass`="powderblue") + +## ----fighistindepfilt--------------------------------------------------------- +barplot(height = rbind(h1$counts, h2$counts), beside = FALSE, + col = colori, space = 0, main = "", ylab="frequency") +text(x = c(0, length(h1$counts)), y = 0, label = paste(c(0,1)), + adj = c(0.5,1.7), xpd=NA) +legend("topright", fill=rev(colori), legend=rev(names(colori))) + +## ----vanillaDESeq, eval=FALSE------------------------------------------------- +# dds <- DESeq(dds, minReplicatesForReplace=Inf) +# res <- results(dds, cooksCutoff=FALSE, independentFiltering=FALSE) + +## ---- eval=FALSE-------------------------------------------------------------- +# mat <- assay(vsd) +# mm <- model.matrix(~condition, colData(vsd)) +# mat <- limma::removeBatchEffect(mat, batch=vsd$batch, design=mm) +# assay(vsd) <- mat +# plotPCA(vsd) + +## ----varGroup, echo=FALSE----------------------------------------------------- +set.seed(3) +dds1 <- makeExampleDESeqDataSet(n=1000,m=12,betaSD=.3,dispMeanRel=function(x) 0.01) +dds2 <- makeExampleDESeqDataSet(n=1000,m=12, + betaSD=.3, + interceptMean=mcols(dds1)$trueIntercept, + interceptSD=0, + dispMeanRel=function(x) 0.2) +dds2 <- dds2[,7:12] +dds2$condition <- rep("C",6) +mcols(dds2) <- NULL +dds12 <- cbind(dds1, dds2) +rld <- rlog(dds12, blind=FALSE, fitType="mean") +plotPCA(rld) + +## ----convertNA, eval=FALSE---------------------------------------------------- +# res$padj <- ifelse(is.na(res$padj), 1, res$padj) + +## ----sessionInfo-------------------------------------------------------------- +sessionInfo() + diff --git a/R_workshop.2.Rmd b/R_workshop.2.Rmd index 9f66509..18ea3e5 100644 --- a/R_workshop.2.Rmd +++ b/R_workshop.2.Rmd @@ -2,8 +2,8 @@ title: "R Workshop -- Day 2" author: "Franziska Metge" output: - html_document: default pdf_document: default + html_document: default --- @@ -239,8 +239,10 @@ library(pheatmap) ### Bioconductor ```{r eval = F} -source("https://bioconductor.org/biocLite.R") -biocLite("edgeR") +if (!requireNamespace("BiocManager", quietly = TRUE)) + install.packages("BiocManager", repos='http://cran.us.r-project.org' , dependencies = TRUE) + +BiocManager::install("edgeR") library(edgeR) ``` @@ -325,8 +327,8 @@ Resources to help you choose colors for your plot: - `plot(..., log = 'xy', ...)` ```{r, eval = TRUE, echo = FALSE, collapse = TRUE, warning = FALSE} -airway.D <- read.delim2('data/airway_gene_expression.tsv', as.is = T, header = T) -airway.I <- read.delim2('data/airway_sample_info.tsv', as.is = T, header = T) +airway.D = read.delim2('data/airway_gene_expression.tsv', as.is = T, header = T) +airway.I = read.delim2('data/airway_sample_info.tsv', as.is = T, header = T) print('head(airway.D)') head(airway.D) print('head(airway.I)') @@ -368,14 +370,14 @@ Not exactly how most volcano plots look like, but this nicely represents how the ### Hands On Work on the airway dataset ```{r, collapse = T, echo = TRUE} -airway.ge <- read.delim("data/airway_gene_expression.tsv", as.is = T, header = T, sep = '\t') +airway.ge = read.delim("data/airway_gene_expression.tsv", as.is = T, header = T, sep = '\t') # make Gene ID to row names head(airway.ge, n = 5) ``` -* Remove low abundant `rowMeans < 1` genes from the airway data +* Remove low abundant `rowMeans < 5` genes from the airway data - calculate the `RM = rowMeans()` using columns `2:9` of `airway.ge` - - subset `airway.ge` using `subset(airway.ge, RM > 1)` + - subset `airway.ge` using `subset(airway.ge, RM > 5)` * Calculate a p-value for your test data frame - use a `for(i in 1:nrow(expressed.airway)){ calculate p-value for row i}` - calculate p.value using t.test `as.numieric(t.test()$p.value)` @@ -391,7 +393,7 @@ head(airway.ge, n = 5) - add legend using `legend()` ```{r, eval = T, echo = FALSE, collapse=TRUE} -airway.D = subset(airway.D, rowMeans(airway.D[, 2:9]) > 1) +airway.D = subset(airway.D, rowMeans(airway.D[, 2:9]) > 5) mean.before = rowMeans(airway.D[airway.I[airway.I$Intervention == "before",]$SampleName]) mean.after = rowMeans(airway.D[airway.I[airway.I$Intervention == "after",]$SampleName]) @@ -425,12 +427,12 @@ legend('top', c('n.s.', 'p < 0.05'), col = c('black', 'red'), pch = 19, bty = 'n ```{r, eval = T, collapse = F} # load example data -wine <- read.csv('data/wine.csv') +wine = read.csv('data/wine.csv') head(wine) # define the first column as a factor -wineClasses <- factor(wine$Cvs) +wineClasses = factor(wine$Cvs) # compute principal component -winePCA <- prcomp(scale(wine[, -1])) +winePCA = prcomp(scale(wine[, -1])) # look at the results summary(winePCA) # look at the names of the results in order to find out what you can use to plot @@ -494,7 +496,7 @@ hist(x) # sometimes it is useful to separate the data into more bins hist(x, breaks = 20) # you can also store the information generated by the histogram into a new variable -x.hist <- hist(x, breaks = 20) +x.hist = hist(x, breaks = 20) head(x.hist) ``` You can add the title, x-axis label and color like in the plot function, lets play around a bit `hist(x, main = , col = , xlab = , xlim = )` @@ -514,12 +516,12 @@ hist(y,col = '#0000FF50', add = T) ### Hands On Work on airway data: ```{r, collapse=TRUE} -airway.D <- read.delim2('data/airway_gene_expression.tsv', as.is = T, header = T) -airway.I <- read.delim2('data/airway_sample_info.tsv', as.is = T, header = T) +airway.D = read.delim2('data/airway_gene_expression.tsv', as.is = T, header = T) +airway.I = read.delim2('data/airway_sample_info.tsv', as.is = T, header = T) # make Gene ID to row names head(airway.ge, n = 5) -# subset to rows with mean > 1 -airway.D = subset(airway.D, rowMeans(airway.D[, 2:9]) > 1) +# subset to rows with mean > 5 +airway.D = subset(airway.D, rowMeans(airway.D[, 2:9]) > 5) # claculate averages for before and after intervention mean.before = rowMeans(airway.D[airway.I[airway.I$Intervention == "before",]$SampleName]) @@ -541,14 +543,21 @@ hist(log2(mean.after), breaks = H1$breaks, col = '#20502050', add = TRUE) Heatmaps are another regular plot to describe expression data among many other applications. We will use the data and code from this webpage: https://davetang.org/muse/2018/05/15/making-a-heatmap-in-r-with-the-pheatmap-package/ -```{r eval = T, message=FALSE} +```{r, eval = F, echo = TRUE} +if (!requireNamespace("BiocManager", quietly = TRUE)) + install.packages("BiocManager", repos='http://cran.us.r-project.org' , + dependencies = TRUE, version = "1.30.10") +BiocManager::install("DESeq") +``` + +```{r eval = T, message=FALSE, eval = FALSE} library(pheatmap) library(DESeq) # load data and subset -example_file <- system.file ("extra/TagSeqExample.tab", package="DESeq") -data <- read.delim(example_file, header=T, row.names="gene") -data_subset <- as.matrix(data[rowSums(data)>50000,]) +example_file = system.file ("extra/TagSeqExample.tab", package="DESeq") +data = read.delim(example_file, header=T, row.names="gene") +data_subset = as.matrix(data[rowSums(data)>50000,]) # create heatmap using pheatmap pheatmap(data_subset) @@ -567,8 +576,8 @@ pheatmap(as.matrix(airway.D[1:300, -1]), scale = 'row') * Draw a heatmap of only the significantly (p <= 0.01) changed rows ```{r, collapse=TRUE} -airway.D <- read.delim2('data/airway_gene_expression.tsv', as.is = T, header = T) -airway.D = subset(airway.D, rowMeans(airway.D[, 2:9]) > 1) +airway.D = read.delim2('data/airway_gene_expression.tsv', as.is = T, header = T) +airway.D = subset(airway.D, rowMeans(airway.D[, 2:9]) > 5) for(i in 1:nrow(airway.D)){ # calculate p.value @@ -581,25 +590,25 @@ head(airway.D) - use `subset(data, condition)` to subset to only significant genes ```{r, eval = TRUE, echo = FALSE} -sig.airway <- subset(airway.D, p.value <= 0.01) +sig.airway = subset(airway.D, p.value <= 0.01) pheatmap(as.matrix(sig.airway[, 2:9]), scale = 'row') ``` -## Venndiagram -Imagine you have two gene sets. To visualize the overlap of these two sets you can draw a venn diagram. To draw a venn diagram you need to load the `VennDiagram` + + -```{r, message= FALSE, collapse=TRUE} -library(VennDiagram) -genes1 = paste('gene', seq(1, 30)) -genes2 = paste('gene', seq(1, 50, 2)) -venn.diagram(list(group1 = genes1, group2 = genes2), - fill = c('dodgerblue', 'firebrick'), - filename = 'venn1.tiff') + + + + + + + -genes.overlap = calculate.overlap(list(group1 = genes1, group2 = genes2)) -genes.overlap -``` + + + ## Barplot ```{r eval = T} @@ -644,40 +653,40 @@ boxplot(x.and.y ~ groups.x.and.y) boxplot(as.matrix(log2(airway.D[,c(2,4, 6, 8, 3, 5, 7, 9)])), las = 2, cex.axis = 0.5, ylab = 'log2(expression)' ) ``` -## Plot properties -You can modify almost everything about the plot properties. To modify plot properties use `par()` + + -### Margins -Sometimes the axis label does not fit onto the plot or you want to add subtitle and need more space on the bottom. You can use `par(mar = c(bottom, left, top, right))` to modify the plot margins. + + -```{r} -par(mar = c(7, 5, 2, 1)) -boxplot(x.and.y ~ groups.x.and.y, las = 2) -``` + + + + -Sometimes you want multiple plots in one graphic. Use `par(mfrow = (nrow, ncol))` -```{r} -par(mfrow = c(1, 2)) -boxplot(x.and.y ~ groups.x.and.y, las = 2) -boxplot(list(x, y)) -``` + + + + + + -## Add text to a plot + -### Within the plot -```{r eval = T} -M = matrix(c(12, 13, 11, 9, 5, 7 ), byrow = T, ncol = 3) -bp = barplot(M, beside = T, main = 'Barplot, beside = T', - names.arg = c('A', 'B', 'C'), ylim = c(0, 15)) -text(x = colMeans(bp), y = c(12, 13, 11), labels = '**', cex = 1.5, pos = 3) -``` + + + + + + + -### Within the margins -```{r eval = T} -M = matrix(c(12, 13, 11, 9, 5, 7 ), byrow = T, ncol = 3) -bp = barplot(M, beside = T, main = 'Barplot, beside = T', names.arg = c('A', 'B', 'C')) -mtext('Samples', 1, 3) -``` + + + + + + ### Advanced links (plotting) - data to viz: https://www.data-to-viz.com/ @@ -685,12 +694,15 @@ mtext('Samples', 1, 3) # End of the day challenge -Pick a plot from data-to-viz web-page and reproduce the plot. I also encourage you to explore the data. In some cases you will need to install extra libraries, but don't be afraid, R-studio usually helps you with that. If we have time I would like you to share your plot and quickly explain what you visualized. +Pick a plot from the R graph gallery and reproduce the plot. I also encourage you to explore the data. In some cases you will need to install extra libraries, but don't be afraid, R-studio usually helps you with that. If we have time I would like you to share your plot and quickly explain what you visualized. + +# Recommended further reading +- Introduction to the tidyverse: https://r4ds.had.co.nz/introduction.html # And for tomorrow: Tomorrow we will perform a real differential gene expression analysis, following the DESeq2 Tutorial - + To ensure that everything is running smoothly, please make sure that you have the following libraries installed. If not please install them using either `install.packages()` or Bioconductor. @@ -718,7 +730,7 @@ library("ggbeeswarm") # bioconductor libraries if (!requireNamespace("BiocManager", quietly = TRUE)) - install.packages("BiocManager", repos='http://cran.us.r-project.org' , dependencies = TRUE, version = "1.30.10") + install.packages("BiocManager", repos='http://cran.us.r-project.org' , dependencies = TRUE) BiocManager::install("airway") BiocManager::install("GenomicFeatures") diff --git a/R_workshop.2.html b/R_workshop.2.html index 14a8633..16fc492 100644 --- a/R_workshop.2.html +++ b/R_workshop.2.html @@ -610,8 +610,10 @@

Cran

Bioconductor

-
source("https://bioconductor.org/biocLite.R")
-biocLite("edgeR")
+
if (!requireNamespace("BiocManager", quietly = TRUE))
+    install.packages("BiocManager", repos='http://cran.us.r-project.org' , dependencies = TRUE)
+
+BiocManager::install("edgeR")
 
 library(edgeR)

We will install more packages later. In general it is quite straight forward.

@@ -768,7 +770,7 @@

Volcano plot

Hands On

Work on the airway dataset

-
airway.ge <- read.delim("data/airway_gene_expression.tsv", as.is = T, header = T, sep = '\t')
+
airway.ge = read.delim("data/airway_gene_expression.tsv", as.is = T, header = T, sep = '\t')
 # make Gene ID to row names
 head(airway.ge, n = 5)
 ##            GeneID S_01.control.Rep1 S_02.__treat.Rep1 S_03.control.Rep2
@@ -790,10 +792,10 @@ 

Hands On

## 4 229 ## 5 60
    -
  • Remove low abundant rowMeans < 1 genes from the airway data +
  • Remove low abundant rowMeans < 5 genes from the airway data
    • calculate the RM = rowMeans() using columns 2:9 of airway.ge
    • -
    • subset airway.ge using subset(airway.ge, RM > 1)
    • +
    • subset airway.ge using subset(airway.ge, RM > 5)
  • Calculate a p-value for your test data frame
      @@ -825,7 +827,7 @@

      Hands On

      ## [1] "pvalue" ## 1 3 4 5 7 8 ## 0.22082663 0.82755428 0.67474685 0.38412456 0.49498597 0.04771523
-

+

@@ -843,7 +845,7 @@

PCA plot

# load example data
-wine <- read.csv('data/wine.csv')
+wine = read.csv('data/wine.csv')
 head(wine)
##   Cvs Alcohol Malic.acid  Ash Alcalinity.of.ash Magnesium Total.phenols
 ## 1   1   14.23       1.71 2.43              15.6       127          2.80
@@ -867,9 +869,9 @@ 

PCA plot

## 5 2.93 735 ## 6 2.85 1450
# define the first column as a factor
-wineClasses <- factor(wine$Cvs)
+wineClasses = factor(wine$Cvs)
 # compute principal component
-winePCA <- prcomp(scale(wine[, -1]))
+winePCA = prcomp(scale(wine[, -1]))
 # look at the results
 summary(winePCA)
## Importance of components:
@@ -912,15 +914,15 @@ 

Hands On

## Importance of components:
-##                             PC1     PC2     PC3      PC4      PC5      PC6
-## Standard deviation     101.9949 62.6071 48.3187 45.05735 41.18304 35.92998
-## Proportion of Variance   0.4578  0.1725  0.1027  0.08934  0.07464  0.05681
-## Cumulative Proportion    0.4578  0.6303  0.7330  0.82237  0.89700  0.95381
-##                             PC7       PC8
-## Standard deviation     32.39630 3.438e-14
-## Proportion of Variance  0.04619 0.000e+00
-## Cumulative Proportion   1.00000 1.000e+00
-

+## PC1 PC2 PC3 PC4 PC5 PC6 +## Standard deviation 96.8163 55.4581 40.56263 36.99393 33.00294 26.81905 +## Proportion of Variance 0.5267 0.1728 0.09246 0.07691 0.06121 0.04042 +## Cumulative Proportion 0.5267 0.6996 0.79204 0.86895 0.93015 0.97057 +## PC7 PC8 +## Standard deviation 22.88373 2.04e-14 +## Proportion of Variance 0.02943 0.00e+00 +## Cumulative Proportion 1.00000 1.00e+00
+

@@ -991,7 +993,7 @@

Histogram

# sometimes it is useful to separate the data into more bins
 hist(x, breaks = 20)
 # you can also store the information generated by the histogram into a new variable
-x.hist <- hist(x, breaks = 20)
+x.hist = hist(x, breaks = 20)

head(x.hist)
## $breaks
@@ -1031,8 +1033,8 @@ 

Histogram

Hands On

Work on airway data:

-
airway.D <- read.delim2('data/airway_gene_expression.tsv', as.is = T, header = T)
-airway.I <- read.delim2('data/airway_sample_info.tsv', as.is = T, header = T)
+
airway.D = read.delim2('data/airway_gene_expression.tsv', as.is = T, header = T)
+airway.I = read.delim2('data/airway_sample_info.tsv', as.is = T, header = T)
 # make Gene ID to row names
 head(airway.ge, n = 5)
 ##            GeneID S_01.control.Rep1 S_02.__treat.Rep1 S_03.control.Rep2
@@ -1053,8 +1055,8 @@ 

Hands On

## 3 508 ## 4 229 ## 5 60 -# subset to rows with mean > 1 -airway.D = subset(airway.D, rowMeans(airway.D[, 2:9]) > 1) +# subset to rows with mean > 5 +airway.D = subset(airway.D, rowMeans(airway.D[, 2:9]) > 5) # claculate averages for before and after intervention mean.before = rowMeans(airway.D[airway.I[airway.I$Intervention == "before",]$SampleName]) @@ -1069,20 +1071,24 @@

Hands On

  • using the same breaks H1 = hist(...) and H2 = hist(..., breaks = H1$breaks, add = TRUE )
  • -

    +

    Heatmap

    Heatmaps are another regular plot to describe expression data among many other applications.
    We will use the data and code from this webpage: https://davetang.org/muse/2018/05/15/making-a-heatmap-in-r-with-the-pheatmap-package/

    +
    if (!requireNamespace("BiocManager", quietly = TRUE))
    +     install.packages("BiocManager", repos='http://cran.us.r-project.org' , 
    +                      dependencies = TRUE, version = "1.30.10")
    +BiocManager::install("DESeq")
    library(pheatmap)
     library(DESeq)
     
     # load data and subset
    -example_file <- system.file ("extra/TagSeqExample.tab", package="DESeq")
    -data <- read.delim(example_file, header=T, row.names="gene")
    -data_subset <- as.matrix(data[rowSums(data)>50000,])
    +example_file = system.file ("extra/TagSeqExample.tab", package="DESeq")
    +data = read.delim(example_file, header=T, row.names="gene")
    +data_subset = as.matrix(data[rowSums(data)>50000,])
      
     # create heatmap using pheatmap
     pheatmap(data_subset)
    @@ -1095,12 +1101,12 @@

    Hands On

  • pheatmpa(as.matrix(airway.D[<correct row indeces>, <only numerical columns>]))
  • -

    +

    • Draw a heatmap of only the significantly (p <= 0.01) changed rows
    -
    airway.D <- read.delim2('data/airway_gene_expression.tsv', as.is = T, header = T)
    -airway.D = subset(airway.D, rowMeans(airway.D[, 2:9]) > 1)
    +
    airway.D = read.delim2('data/airway_gene_expression.tsv', as.is = T, header = T)
    +airway.D = subset(airway.D, rowMeans(airway.D[, 2:9]) > 5)
     
       for(i in 1:nrow(airway.D)){
         # calculate p.value
    @@ -1132,39 +1138,20 @@ 

    Hands On

    • use subset(data, condition) to subset to only significant genes
    -

    -
    +

    + + + + + + + + + + + + -
    -

    Venndiagram

    -

    Imagine you have two gene sets. To visualize the overlap of these two sets you can draw a venn diagram. To draw a venn diagram you need to load the VennDiagram

    -
    library(VennDiagram)
    -genes1 = paste('gene', seq(1, 30))
    -genes2 = paste('gene', seq(1, 50, 2))
    -venn.diagram(list(group1 = genes1, group2 = genes2), 
    -             fill = c('dodgerblue', 'firebrick'),
    -             filename = 'venn1.tiff')
    -## [1] 1
    -
    -genes.overlap = calculate.overlap(list(group1 = genes1, group2 = genes2))
    -genes.overlap
    -## $a1
    -##  [1] "gene 1"  "gene 2"  "gene 3"  "gene 4"  "gene 5"  "gene 6"  "gene 7" 
    -##  [8] "gene 8"  "gene 9"  "gene 10" "gene 11" "gene 12" "gene 13" "gene 14"
    -## [15] "gene 15" "gene 16" "gene 17" "gene 18" "gene 19" "gene 20" "gene 21"
    -## [22] "gene 22" "gene 23" "gene 24" "gene 25" "gene 26" "gene 27" "gene 28"
    -## [29] "gene 29" "gene 30"
    -## 
    -## $a2
    -##  [1] "gene 1"  "gene 3"  "gene 5"  "gene 7"  "gene 9"  "gene 11" "gene 13"
    -##  [8] "gene 15" "gene 17" "gene 19" "gene 21" "gene 23" "gene 25" "gene 27"
    -## [15] "gene 29" "gene 31" "gene 33" "gene 35" "gene 37" "gene 39" "gene 41"
    -## [22] "gene 43" "gene 45" "gene 47" "gene 49"
    -## 
    -## $a3
    -##  [1] "gene 1"  "gene 3"  "gene 5"  "gene 7"  "gene 9"  "gene 11" "gene 13"
    -##  [8] "gene 15" "gene 17" "gene 19" "gene 21" "gene 23" "gene 25" "gene 27"
    -## [15] "gene 29"

    Barplot

    @@ -1181,7 +1168,7 @@

    Hands On

  • use colMeans(airway.D[, 2:9])
  • -

    +

    @@ -1207,41 +1194,35 @@

    Hands On

  • boxplot()
  • -

    -
    - -
    -

    Plot properties

    -

    You can modify almost everything about the plot properties. To modify plot properties use par()

    -
    -

    Margins

    -

    Sometimes the axis label does not fit onto the plot or you want to add subtitle and need more space on the bottom. You can use par(mar = c(bottom, left, top, right)) to modify the plot margins.

    -
    par(mar = c(7, 5, 2, 1))
    -boxplot(x.and.y ~ groups.x.and.y, las = 2)
    -

    -

    Sometimes you want multiple plots in one graphic. Use par(mfrow = (nrow, ncol))

    -
    par(mfrow = c(1, 2))
    -boxplot(x.and.y ~ groups.x.and.y, las = 2)
    -boxplot(list(x, y))
    -

    -
    -
    -
    -

    Add text to a plot

    -
    -

    Within the plot

    -
    M = matrix(c(12, 13, 11, 9, 5, 7 ), byrow = T, ncol = 3)
    -bp = barplot(M, beside = T, main = 'Barplot, beside = T', 
    -             names.arg = c('A', 'B', 'C'), ylim = c(0, 15))
    -text(x = colMeans(bp), y = c(12, 13, 11), labels = '**', cex = 1.5, pos = 3)
    -

    -
    -
    -

    Within the margins

    -
    M = matrix(c(12, 13, 11, 9, 5, 7 ), byrow = T, ncol = 3)
    -bp = barplot(M, beside = T, main = 'Barplot, beside = T', names.arg = c('A', 'B', 'C'))
    -mtext('Samples', 1, 3)
    -

    +

    + + + + + + + + + + + + + + + + + + + + + + + + + + + +

    End of the day challenge

    -

    Pick a plot from data-to-viz web-page and reproduce the plot. I also encourage you to explore the data. In some cases you will need to install extra libraries, but don’t be afraid, R-studio usually helps you with that. If we have time I would like you to share your plot and quickly explain what you visualized.

    +

    Pick a plot from the R graph gallery and reproduce the plot. I also encourage you to explore the data. In some cases you will need to install extra libraries, but don’t be afraid, R-studio usually helps you with that. If we have time I would like you to share your plot and quickly explain what you visualized.

    +
    +

    And for tomorrow:

    -

    Tomorrow we will perform a real differential gene expression analysis, following the DESeq2 Tutorial http://master.bioconductor.org/packages/release/workflows/vignettes/rnaseqGene/inst/doc/rnaseqGene.html

    +

    Tomorrow we will perform a real differential gene expression analysis, following the DESeq2 Tutorial https://www.bioconductor.org/packages/release/bioc/vignettes/DESeq2/inst/doc/DESeq2.html

    To ensure that everything is running smoothly, please make sure that you have the following libraries installed. If not please install them using either install.packages() or Bioconductor.

    # loading all libraries
     
    @@ -1270,6 +1257,7 @@ 

    And for tomorrow:

    install.packages("RColorBrewer") install.packages("PoiClaClu") install.packages("ggbeeswarm") +install.packages("dbplyr") library("magrittr") library("dplyr") @@ -1282,7 +1270,7 @@

    And for tomorrow:

    # bioconductor libraries if (!requireNamespace("BiocManager", quietly = TRUE)) - install.packages("BiocManager", repos='http://cran.us.r-project.org' , dependencies = TRUE, version = "1.30.10") + install.packages("BiocManager", repos='http://cran.us.r-project.org' , dependencies = TRUE) BiocManager::install("airway") BiocManager::install("GenomicFeatures") @@ -1300,6 +1288,7 @@

    And for tomorrow:

    BiocManager::install("sva") BiocManager::install("RUVSeq") BiocManager::install("fission") +BiocManager::install("tximeta") library("airway") library("GenomicFeatures") @@ -1311,12 +1300,13 @@

    And for tomorrow:

    library("apeglm") library("genefilter") library("AnnotationDbi") -library("org.Hs.eg.,m db") +library("org.Hs.eg.db") library("ReportingTools") library("Gviz") library("sva") library("RUVSeq") -library("fission")
    +library("fission") +library("tximeta")
    diff --git a/R_workshop.2.pdf b/R_workshop.2.pdf index 0abd340..c41700e 100644 Binary files a/R_workshop.2.pdf and b/R_workshop.2.pdf differ diff --git a/R_workshop.Rmd b/R_workshop.Rmd index fa027e1..5eeaeb8 100644 --- a/R_workshop.Rmd +++ b/R_workshop.Rmd @@ -1,8 +1,8 @@ --- title: "R Workshop -- Introduction to R" output: - html_document: default pdf_document: default + html_document: default fontsize: 8pt --- @@ -34,7 +34,7 @@ Now, please share your screen with us for a few moments to make sure we are all *** R can be used as a simple calculator -```{r} +```{r, collapse = TRUE} # adding 18 + 6 @@ -48,21 +48,47 @@ R can be used as a simple calculator 18/6 ``` +*** + +# Programming Syntax in R + +1. Difference between Console and Script +2. What is a variable + + `name = value` + +3. What is a function + + `name(argument = value)` + + `name(argument1 = value1, argument2 = value2)` + +4. You can have nested functions + + `name(arguments = name(arguments = values))` + +*** + + R can also be used as a more advanced calculator -```{r} +```{r, collapse = TRUE} # square a number 4 ^ 2 # square root of a number -sqrt(16) +sqrt(x = 16) + +# sqrt is the function name +# 16 is the argument # log-transform data log10(100) log2(8) + +# nested calculations +sqrt(x = log2(x = 8)) +# or short +sqrt(log2(8)) ``` R can be used to check if a value is bigger/smaller than another -```{r} +```{r, collapse = TRUE} # greater than, less than 6 == 6 # equal to 6 > 6 # greater than @@ -71,7 +97,7 @@ R can be used to check if a value is bigger/smaller than another ``` You can store a result or any value in a variable to use later -```{r} +```{r, collapse = TRUE} # assign the value 6 to variable x x = 6 # check out what x is @@ -81,6 +107,7 @@ print(x) # use x x + 5 ``` + ## Hands On **Try to execute the following calculations** @@ -96,6 +123,11 @@ x + 5 ### Numeric ```{r eval = FALSE} x = 10.5 # or x <- 10 + +# access variables +x +# or +print(x) ``` ### Logical @@ -155,6 +187,12 @@ c = c('apple', 'six') # mixed vector? d = c('six', a, 5) + +# access values in a vector +a[1] +a[1] + 4 +a[1] = a[1] + 4 +print(a) ``` ### Matrix @@ -176,6 +214,14 @@ t(A) # concatenate two matrices row- or column-wise D = cbind(A, B) E = rbind(A, B) + +# access matrix elements +# rows +D[1,] +# columns +D[,2] +# individual cells +D[1,2] ``` ### List @@ -194,6 +240,8 @@ print(xn) # access list elements x[2] # vs. x[[2]] +x[[2]] +x[['Strings']] xn$Strings # vs. xn['Strings'] or xn[['Strings']] ``` diff --git a/R_workshop.html b/R_workshop.html index 7d658be..e93e064 100644 --- a/R_workshop.html +++ b/R_workshop.html @@ -389,51 +389,87 @@

    Introduction to R Studio


    R can be used as a simple calculator

    # adding
    -18 + 6
    -
    ## [1] 24
    -
    # substracting
    -18 - 6 
    -
    ## [1] 12
    -
    # multiplication
    -18 * 6
    -
    ## [1] 108
    -
    # Division
    -18/6
    -
    ## [1] 3
    +18 + 6 +## [1] 24 + +# substracting +18 - 6 +## [1] 12 + +# multiplication +18 * 6 +## [1] 108 + +# Division +18/6 +## [1] 3
    +
    +
    +
    +

    Programming Syntax in R

    +
      +
    1. Difference between Console and Script
    2. +
    3. What is a variable +
        +
      • name = value
      • +
    4. +
    5. What is a function +
        +
      • name(argument = value)
      • +
      • name(argument1 = value1, argument2 = value2)
      • +
    6. +
    7. You can have nested functions +
        +
      • name(arguments = name(arguments = values))
      • +
    8. +
    +

    R can also be used as a more advanced calculator

    # square a number
    -4 ^ 2
    -
    ## [1] 16
    -
    # square root of a number
    -sqrt(16)
    -
    ## [1] 4
    -
    # log-transform data
    -log10(100)
    -
    ## [1] 2
    -
    log2(8)
    -
    ## [1] 3
    +4 ^ 2 +## [1] 16 + +# square root of a number +sqrt(x = 16) +## [1] 4 + +# sqrt is the function name +# 16 is the argument + +# log-transform data +log10(100) +## [1] 2 +log2(8) +## [1] 3 + +# nested calculations +sqrt(x = log2(x = 8)) +## [1] 1.732051 +# or short +sqrt(log2(8)) +## [1] 1.732051

    R can be used to check if a value is bigger/smaller than another

    # greater than, less than
    -6 == 6 # equal to 
    -
    ## [1] TRUE
    -
    6 > 6 # greater than
    -
    ## [1] FALSE
    -
    6 >= 6 # greater or equal then
    -
    ## [1] TRUE
    -
    6 < 6 # less than
    -
    ## [1] FALSE
    +6 == 6 # equal to +## [1] TRUE +6 > 6 # greater than +## [1] FALSE +6 >= 6 # greater or equal then +## [1] TRUE +6 < 6 # less than +## [1] FALSE

    You can store a result or any value in a variable to use later

    # assign the value 6 to variable x
     x = 6
     # check out what x is
    -x 
    -
    ## [1] 6
    -
    # or
    -print(x)
    -
    ## [1] 6
    -
    # use x
    -x + 5
    -
    ## [1] 11
    +x +## [1] 6 +# or +print(x) +## [1] 6 +# use x +x + 5 +## [1] 11

    Hands On

    Try to execute the following calculations

    @@ -450,7 +486,12 @@

    Hands On

    Relevant basic data types

    Numeric

    -
    x = 10.5 # or x <- 10
    +
    x = 10.5 # or x <- 10
    +
    +# access variables
    +x
    +# or 
    +print(x)

    Logical

    @@ -506,7 +547,13 @@

    Vector

    c = c('apple', 'six') # mixed vector? -d = c('six', a, 5) +d = c('six', a, 5) + +# access values in a vector +a[1] +a[1] + 4 +a[1] = a[1] + 4 +print(a)

    Matrix

    @@ -526,7 +573,15 @@

    Matrix

    # concatenate two matrices row- or column-wise D = cbind(A, B) -E = rbind(A, B) +E = rbind(A, B) + +# access matrix elements +# rows +D[1,] +# columns +D[,2] +# individual cells +D[1,2]

    List

    @@ -544,6 +599,8 @@

    List

    # access list elements x[2] # vs. x[[2]] +x[[2]] +x[['Strings']] xn$Strings # vs. xn['Strings'] or xn[['Strings']]
    @@ -692,11 +749,11 @@

    Repeat

    Random numbers

    # random numbers from a normal distribution
     rnorm(n = 5, mean = 5, sd = 1) 
    -## [1] 3.073082 5.903837 5.941621 5.891309 4.580985
    +## [1] 3.167047 4.887193 4.198460 6.396455 5.599182
     
     # random numbers from a uniform distribution
     runif(n = 5, min = 1, max = 5)
    -## [1] 4.910746 3.200908 2.756291 4.979401 3.739086
    +## [1] 3.728042 2.285100 1.705257 1.207352 2.309108

    Other distributions in R include:

    • Normal: rnorm(n, mean, sd)
    • diff --git a/R_workshop.log b/R_workshop.log new file mode 100644 index 0000000..c219dda --- /dev/null +++ b/R_workshop.log @@ -0,0 +1,722 @@ +This is pdfTeX, Version 3.14159265-2.6-1.40.20 (TeX Live 2019/Debian) (preloaded format=pdflatex 2021.8.5) 20 OCT 2021 13:35 +entering extended mode + restricted \write18 enabled. + %&-line parsing enabled. +**R_workshop.tex +(./R_workshop.tex +LaTeX2e <2020-02-02> patch level 2 +L3 programming layer <2020-02-14> (/usr/share/texlive/texmf-dist/tex/latex/base +/article.cls +Document Class: article 2019/12/20 v1.4l Standard LaTeX document class +(/usr/share/texlive/texmf-dist/tex/latex/base/size10.clo +File: size10.clo 2019/12/20 v1.4l Standard LaTeX file (size option) +) +\c@part=\count167 +\c@section=\count168 +\c@subsection=\count169 +\c@subsubsection=\count170 +\c@paragraph=\count171 +\c@subparagraph=\count172 +\c@figure=\count173 +\c@table=\count174 +\abovecaptionskip=\skip47 +\belowcaptionskip=\skip48 +\bibindent=\dimen134 +) (/usr/share/texmf/tex/latex/lm/lmodern.sty +Package: lmodern 2009/10/30 v1.6 Latin Modern Fonts +LaTeX Font Info: Overwriting symbol font `operators' in version `normal' +(Font) OT1/cmr/m/n --> OT1/lmr/m/n on input line 22. +LaTeX Font Info: Overwriting symbol font `letters' in version `normal' +(Font) OML/cmm/m/it --> OML/lmm/m/it on input line 23. +LaTeX Font Info: Overwriting symbol font `symbols' in version `normal' +(Font) OMS/cmsy/m/n --> OMS/lmsy/m/n on input line 24. +LaTeX Font Info: Overwriting symbol font `largesymbols' in version `normal' +(Font) OMX/cmex/m/n --> OMX/lmex/m/n on input line 25. +LaTeX Font Info: Overwriting symbol font `operators' in version `bold' +(Font) OT1/cmr/bx/n --> OT1/lmr/bx/n on input line 26. +LaTeX Font Info: Overwriting symbol font `letters' in version `bold' +(Font) OML/cmm/b/it --> OML/lmm/b/it on input line 27. +LaTeX Font Info: Overwriting symbol font `symbols' in version `bold' +(Font) OMS/cmsy/b/n --> OMS/lmsy/b/n on input line 28. +LaTeX Font Info: Overwriting symbol font `largesymbols' in version `bold' +(Font) OMX/cmex/m/n --> OMX/lmex/m/n on input line 29. +LaTeX Font Info: Overwriting math alphabet `\mathbf' in version `normal' +(Font) OT1/cmr/bx/n --> OT1/lmr/bx/n on input line 31. +LaTeX Font Info: Overwriting math alphabet `\mathsf' in version `normal' +(Font) OT1/cmss/m/n --> OT1/lmss/m/n on input line 32. +LaTeX Font Info: Overwriting math alphabet `\mathit' in version `normal' +(Font) OT1/cmr/m/it --> OT1/lmr/m/it on input line 33. +LaTeX Font Info: Overwriting math alphabet `\mathtt' in version `normal' +(Font) OT1/cmtt/m/n --> OT1/lmtt/m/n on input line 34. +LaTeX Font Info: Overwriting math alphabet `\mathbf' in version `bold' +(Font) OT1/cmr/bx/n --> OT1/lmr/bx/n on input line 35. +LaTeX Font Info: Overwriting math alphabet `\mathsf' in version `bold' +(Font) OT1/cmss/bx/n --> OT1/lmss/bx/n on input line 36. +LaTeX Font Info: Overwriting math alphabet `\mathit' in version `bold' +(Font) OT1/cmr/bx/it --> OT1/lmr/bx/it on input line 37. +LaTeX Font Info: Overwriting math alphabet `\mathtt' in version `bold' +(Font) OT1/cmtt/m/n --> OT1/lmtt/m/n on input line 38. +) (/usr/share/texlive/texmf-dist/tex/latex/amsfonts/amssymb.sty +Package: amssymb 2013/01/14 v3.01 AMS font symbols +(/usr/share/texlive/texmf-dist/tex/latex/amsfonts/amsfonts.sty +Package: amsfonts 2013/01/14 v3.01 Basic AMSFonts support +\@emptytoks=\toks14 +\symAMSa=\mathgroup4 +\symAMSb=\mathgroup5 +LaTeX Font Info: Redeclaring math symbol \hbar on input line 98. +LaTeX Font Info: Overwriting math alphabet `\mathfrak' in version `bold' +(Font) U/euf/m/n --> U/euf/b/n on input line 106. +)) (/usr/share/texlive/texmf-dist/tex/latex/amsmath/amsmath.sty +Package: amsmath 2020/01/20 v2.17e AMS math features +\@mathmargin=\skip49 +For additional information on amsmath, use the `?' option. +(/usr/share/texlive/texmf-dist/tex/latex/amsmath/amstext.sty +Package: amstext 2000/06/29 v2.01 AMS text +(/usr/share/texlive/texmf-dist/tex/latex/amsmath/amsgen.sty +File: amsgen.sty 1999/11/30 v2.0 generic functions +\@emptytoks=\toks15 +\ex@=\dimen135 +)) (/usr/share/texlive/texmf-dist/tex/latex/amsmath/amsbsy.sty +Package: amsbsy 1999/11/29 v1.2d Bold Symbols +\pmbraise@=\dimen136 +) (/usr/share/texlive/texmf-dist/tex/latex/amsmath/amsopn.sty +Package: amsopn 2016/03/08 v2.02 operator names +) +\inf@bad=\count175 +LaTeX Info: Redefining \frac on input line 227. +\uproot@=\count176 +\leftroot@=\count177 +LaTeX Info: Redefining \overline on input line 389. +\classnum@=\count178 +\DOTSCASE@=\count179 +LaTeX Info: Redefining \ldots on input line 486. +LaTeX Info: Redefining \dots on input line 489. +LaTeX Info: Redefining \cdots on input line 610. +\Mathstrutbox@=\box45 +\strutbox@=\box46 +\big@size=\dimen137 +LaTeX Font Info: Redeclaring font encoding OML on input line 733. +LaTeX Font Info: Redeclaring font encoding OMS on input line 734. +\macc@depth=\count180 +\c@MaxMatrixCols=\count181 +\dotsspace@=\muskip16 +\c@parentequation=\count182 +\dspbrk@lvl=\count183 +\tag@help=\toks16 +\row@=\count184 +\column@=\count185 +\maxfields@=\count186 +\andhelp@=\toks17 +\eqnshift@=\dimen138 +\alignsep@=\dimen139 +\tagshift@=\dimen140 +\tagwidth@=\dimen141 +\totwidth@=\dimen142 +\lineht@=\dimen143 +\@envbody=\toks18 +\multlinegap=\skip50 +\multlinetaggap=\skip51 +\mathdisplay@stack=\toks19 +LaTeX Info: Redefining \[ on input line 2859. +LaTeX Info: Redefining \] on input line 2860. +) (/usr/share/texlive/texmf-dist/tex/generic/iftex/ifxetex.sty +Package: ifxetex 2019/10/25 v0.7 ifxetex legacy package. Use iftex instead. +(/usr/share/texlive/texmf-dist/tex/generic/iftex/iftex.sty +Package: iftex 2019/11/07 v1.0c TeX engine tests +)) (/usr/share/texlive/texmf-dist/tex/generic/iftex/ifluatex.sty +Package: ifluatex 2019/10/25 v1.5 ifluatex legacy package. Use iftex instead. +) (/usr/share/texlive/texmf-dist/tex/latex/base/fixltx2e.sty +Package: fixltx2e 2016/12/29 v2.1a fixes to LaTeX (obsolete) +Applying: [2015/01/01] Old fixltx2e package on input line 46. + +Package fixltx2e Warning: fixltx2e is not required with releases after 2015 +(fixltx2e) All fixes are now in the LaTeX kernel. +(fixltx2e) See the latexrelease package for details. + +Already applied: [0000/00/00] Old fixltx2e package on input line 53. +) (/usr/share/texlive/texmf-dist/tex/latex/base/fontenc.sty +Package: fontenc 2020/02/11 v2.0o Standard LaTeX package +LaTeX Font Info: Trying to load font information for T1+lmr on input line 11 +2. +(/usr/share/texmf/tex/latex/lm/t1lmr.fd +File: t1lmr.fd 2009/10/30 v1.6 Font defs for Latin Modern +)) (/usr/share/texlive/texmf-dist/tex/latex/base/inputenc.sty +Package: inputenc 2018/08/11 v1.3c Input encoding file +\inpenc@prehook=\toks20 +\inpenc@posthook=\toks21 +) (/usr/share/texlive/texmf-dist/tex/latex/base/textcomp.sty +Package: textcomp 2020/02/02 v2.0n Standard LaTeX package +) (/usr/share/texlive/texmf-dist/tex/latex/upquote/upquote.sty +Package: upquote 2012/04/19 v1.3 upright-quote and grave-accent glyphs in verba +tim +) (/usr/share/texlive/texmf-dist/tex/latex/microtype/microtype.sty +Package: microtype 2019/11/18 v2.7d Micro-typographical refinements (RS) +(/usr/share/texlive/texmf-dist/tex/latex/graphics/keyval.sty +Package: keyval 2014/10/28 v1.15 key=value parser (DPC) +\KV@toks@=\toks22 +) +\MT@toks=\toks23 +\MT@count=\count187 +LaTeX Info: Redefining \textls on input line 790. +\MT@outer@kern=\dimen144 +LaTeX Info: Redefining \textmicrotypecontext on input line 1354. +\MT@listname@count=\count188 +(/usr/share/texlive/texmf-dist/tex/latex/microtype/microtype-pdftex.def +File: microtype-pdftex.def 2019/11/18 v2.7d Definitions specific to pdftex (RS) + +LaTeX Info: Redefining \lsstyle on input line 914. +LaTeX Info: Redefining \lslig on input line 914. +\MT@outer@space=\skip52 +) +Package microtype Info: Loading configuration file microtype.cfg. +(/usr/share/texlive/texmf-dist/tex/latex/microtype/microtype.cfg +File: microtype.cfg 2019/11/18 v2.7d microtype main configuration file (RS) +)) (/usr/share/texlive/texmf-dist/tex/latex/parskip/parskip.sty +Package: parskip 2020-01-22 v2.0d non-zero parskip adjustments +(/usr/share/texlive/texmf-dist/tex/latex/kvoptions/kvoptions.sty +Package: kvoptions 2019/11/29 v3.13 Key value format for package options (HO) +(/usr/share/texlive/texmf-dist/tex/generic/ltxcmds/ltxcmds.sty +Package: ltxcmds 2019/12/15 v1.24 LaTeX kernel commands for general use (HO) +) (/usr/share/texlive/texmf-dist/tex/generic/kvsetkeys/kvsetkeys.sty +Package: kvsetkeys 2019/12/15 v1.18 Key value parser (HO) +)) (/usr/share/texlive/texmf-dist/tex/latex/etoolbox/etoolbox.sty +Package: etoolbox 2019/09/21 v2.5h e-TeX tools for LaTeX (JAW) +\etb@tempcnta=\count189 +)) (/usr/share/texlive/texmf-dist/tex/latex/hyperref/hyperref.sty +Package: hyperref 2020/01/14 v7.00d Hypertext links for LaTeX +(/usr/share/texlive/texmf-dist/tex/latex/pdftexcmds/pdftexcmds.sty +Package: pdftexcmds 2019/11/24 v0.31 Utility functions of pdfTeX for LuaTeX (HO +) +(/usr/share/texlive/texmf-dist/tex/generic/infwarerr/infwarerr.sty +Package: infwarerr 2019/12/03 v1.5 Providing info/warning/error messages (HO) +) +Package pdftexcmds Info: \pdf@primitive is available. +Package pdftexcmds Info: \pdf@ifprimitive is available. +Package pdftexcmds Info: \pdfdraftmode found. +) (/usr/share/texlive/texmf-dist/tex/generic/kvdefinekeys/kvdefinekeys.sty +Package: kvdefinekeys 2019-12-19 v1.6 Define keys (HO) +) (/usr/share/texlive/texmf-dist/tex/generic/pdfescape/pdfescape.sty +Package: pdfescape 2019/12/09 v1.15 Implements pdfTeX's escape features (HO) +) (/usr/share/texlive/texmf-dist/tex/latex/hycolor/hycolor.sty +Package: hycolor 2020-01-27 v1.10 Color options for hyperref/bookmark (HO) +) (/usr/share/texlive/texmf-dist/tex/latex/letltxmacro/letltxmacro.sty +Package: letltxmacro 2019/12/03 v1.6 Let assignment for LaTeX macros (HO) +) (/usr/share/texlive/texmf-dist/tex/latex/auxhook/auxhook.sty +Package: auxhook 2019-12-17 v1.6 Hooks for auxiliary files (HO) +) +\@linkdim=\dimen145 +\Hy@linkcounter=\count190 +\Hy@pagecounter=\count191 +(/usr/share/texlive/texmf-dist/tex/latex/hyperref/pd1enc.def +File: pd1enc.def 2020/01/14 v7.00d Hyperref: PDFDocEncoding definition (HO) +Now handling font encoding PD1 ... +... no UTF-8 mapping file for font encoding PD1 +) (/usr/share/texlive/texmf-dist/tex/generic/intcalc/intcalc.sty +Package: intcalc 2019/12/15 v1.3 Expandable calculations with integers (HO) +) (/usr/share/texlive/texmf-dist/tex/generic/etexcmds/etexcmds.sty +Package: etexcmds 2019/12/15 v1.7 Avoid name clashes with e-TeX commands (HO) +) +\Hy@SavedSpaceFactor=\count192 +\pdfmajorversion=\count193 +Package hyperref Info: Option `unicode' set `true' on input line 4421. +(/usr/share/texlive/texmf-dist/tex/latex/hyperref/puenc.def +File: puenc.def 2020/01/14 v7.00d Hyperref: PDF Unicode definition (HO) +Now handling font encoding PU ... +... no UTF-8 mapping file for font encoding PU +) +Package hyperref Info: Hyper figures OFF on input line 4547. +Package hyperref Info: Link nesting OFF on input line 4552. +Package hyperref Info: Hyper index ON on input line 4555. +Package hyperref Info: Plain pages OFF on input line 4562. +Package hyperref Info: Backreferencing OFF on input line 4567. +Package hyperref Info: Implicit mode ON; LaTeX internals redefined. +Package hyperref Info: Bookmarks ON on input line 4800. +\c@Hy@tempcnt=\count194 +(/usr/share/texlive/texmf-dist/tex/latex/url/url.sty +\Urlmuskip=\muskip17 +Package: url 2013/09/16 ver 3.4 Verb mode for urls, etc. +) +LaTeX Info: Redefining \url on input line 5159. +\XeTeXLinkMargin=\dimen146 +(/usr/share/texlive/texmf-dist/tex/generic/bitset/bitset.sty +Package: bitset 2019/12/09 v1.3 Handle bit-vector datatype (HO) +(/usr/share/texlive/texmf-dist/tex/generic/bigintcalc/bigintcalc.sty +Package: bigintcalc 2019/12/15 v1.5 Expandable calculations on big integers (HO +) +)) +\Fld@menulength=\count195 +\Field@Width=\dimen147 +\Fld@charsize=\dimen148 +Package hyperref Info: Hyper figures OFF on input line 6430. +Package hyperref Info: Link nesting OFF on input line 6435. +Package hyperref Info: Hyper index ON on input line 6438. +Package hyperref Info: backreferencing OFF on input line 6445. +Package hyperref Info: Link coloring OFF on input line 6450. +Package hyperref Info: Link coloring with OCG OFF on input line 6455. +Package hyperref Info: PDF/A mode OFF on input line 6460. +LaTeX Info: Redefining \ref on input line 6500. +LaTeX Info: Redefining \pageref on input line 6504. +(/usr/share/texlive/texmf-dist/tex/generic/atbegshi/atbegshi.sty +Package: atbegshi 2019/12/05 v1.19 At begin shipout hook (HO) +) +\Hy@abspage=\count196 +\c@Item=\count197 +\c@Hfootnote=\count198 +) +Package hyperref Info: Driver (autodetected): hpdftex. +(/usr/share/texlive/texmf-dist/tex/latex/hyperref/hpdftex.def +File: hpdftex.def 2020/01/14 v7.00d Hyperref driver for pdfTeX +(/usr/share/texlive/texmf-dist/tex/latex/atveryend/atveryend.sty +Package: atveryend 2019-12-11 v1.11 Hooks at the very end of document (HO) +) +\Fld@listcount=\count199 +\c@bookmark@seq@number=\count266 +(/usr/share/texlive/texmf-dist/tex/latex/rerunfilecheck/rerunfilecheck.sty +Package: rerunfilecheck 2019/12/05 v1.9 Rerun checks for auxiliary files (HO) +(/usr/share/texlive/texmf-dist/tex/generic/uniquecounter/uniquecounter.sty +Package: uniquecounter 2019/12/15 v1.4 Provide unlimited unique counter (HO) +) +Package uniquecounter Info: New unique counter `rerunfilecheck' on input line 2 +86. +) +\Hy@SectionHShift=\skip53 +) +Package hyperref Info: Option `breaklinks' set `true' on input line 34. +(/usr/share/texlive/texmf-dist/tex/latex/geometry/geometry.sty +Package: geometry 2020/01/02 v5.9 Page Geometry +(/usr/share/texlive/texmf-dist/tex/generic/iftex/ifvtex.sty +Package: ifvtex 2019/10/25 v1.7 ifvtex legacy package. Use iftex instead. +) +\Gm@cnth=\count267 +\Gm@cntv=\count268 +\c@Gm@tempcnt=\count269 +\Gm@bindingoffset=\dimen149 +\Gm@wd@mp=\dimen150 +\Gm@odd@mp=\dimen151 +\Gm@even@mp=\dimen152 +\Gm@layoutwidth=\dimen153 +\Gm@layoutheight=\dimen154 +\Gm@layouthoffset=\dimen155 +\Gm@layoutvoffset=\dimen156 +\Gm@dimlist=\toks24 +) (/usr/share/texlive/texmf-dist/tex/latex/graphics/color.sty +Package: color 2019/11/23 v1.2a Standard LaTeX Color (DPC) +(/usr/share/texlive/texmf-dist/tex/latex/graphics-cfg/color.cfg +File: color.cfg 2016/01/02 v1.6 sample color configuration +) +Package color Info: Driver file: pdftex.def on input line 147. +(/usr/share/texlive/texmf-dist/tex/latex/graphics-def/pdftex.def +File: pdftex.def 2018/01/08 v1.0l Graphics/color driver for pdftex +)) (/usr/share/texlive/texmf-dist/tex/latex/fancyvrb/fancyvrb.sty +Package: fancyvrb 2020/01/13 v3.5 verbatim text (tvz,hv) +\FV@CodeLineNo=\count270 +\FV@InFile=\read2 +\FV@TabBox=\box47 +\c@FancyVerbLine=\count271 +\FV@StepNumber=\count272 +\FV@OutFile=\write3 +) (/usr/share/texlive/texmf-dist/tex/latex/framed/framed.sty +Package: framed 2011/10/22 v 0.96: framed or shaded text with page breaks +\OuterFrameSep=\skip54 +\fb@frw=\dimen157 +\fb@frh=\dimen158 +\FrameRule=\dimen159 +\FrameSep=\dimen160 +) (/usr/share/texlive/texmf-dist/tex/latex/tools/longtable.sty +Package: longtable 2020/01/07 v4.13 Multi-page Table package (DPC) +\LTleft=\skip55 +\LTright=\skip56 +\LTpre=\skip57 +\LTpost=\skip58 +\LTchunksize=\count273 +\LTcapwidth=\dimen161 +\LT@head=\box48 +\LT@firsthead=\box49 +\LT@foot=\box50 +\LT@lastfoot=\box51 +\LT@cols=\count274 +\LT@rows=\count275 +\c@LT@tables=\count276 +\c@LT@chunks=\count277 +\LT@p@ftn=\toks25 +) (/usr/share/texlive/texmf-dist/tex/latex/booktabs/booktabs.sty +Package: booktabs 2020/01/12 v1.61803398 Publication quality tables +\heavyrulewidth=\dimen162 +\lightrulewidth=\dimen163 +\cmidrulewidth=\dimen164 +\belowrulesep=\dimen165 +\belowbottomsep=\dimen166 +\aboverulesep=\dimen167 +\abovetopsep=\dimen168 +\cmidrulesep=\dimen169 +\cmidrulekern=\dimen170 +\defaultaddspace=\dimen171 +\@cmidla=\count278 +\@cmidlb=\count279 +\@aboverulesep=\dimen172 +\@belowrulesep=\dimen173 +\@thisruleclass=\count280 +\@lastruleclass=\count281 +\@thisrulewidth=\dimen174 +) (/usr/share/texlive/texmf-dist/tex/latex/mdwtools/footnote.sty +Package: footnote 1997/01/28 1.13 Save footnotes around boxes +\fn@notes=\box52 +\fn@width=\dimen175 +) (/usr/share/texlive/texmf-dist/tex/latex/graphics/graphicx.sty +Package: graphicx 2019/11/30 v1.2a Enhanced LaTeX Graphics (DPC,SPQR) +(/usr/share/texlive/texmf-dist/tex/latex/graphics/graphics.sty +Package: graphics 2019/11/30 v1.4a Standard LaTeX Graphics (DPC,SPQR) +(/usr/share/texlive/texmf-dist/tex/latex/graphics/trig.sty +Package: trig 2016/01/03 v1.10 sin cos tan (DPC) +) (/usr/share/texlive/texmf-dist/tex/latex/graphics-cfg/graphics.cfg +File: graphics.cfg 2016/06/04 v1.11 sample graphics configuration +) +Package graphics Info: Driver file: pdftex.def on input line 105. +) +\Gin@req@height=\dimen176 +\Gin@req@width=\dimen177 +) (/usr/share/texlive/texmf-dist/tex/latex/grffile/grffile.sty +Package: grffile 2019/11/11 v2.1 Extended file name support for graphics (legac +y) +Package grffile Info: This package is an empty stub for compatibility on input +line 40. +) (/usr/share/texlive/texmf-dist/tex/latex/l3backend/l3backend-pdfmode.def +File: l3backend-pdfmode.def 2020-02-03 L3 backend support: PDF mode +\l__kernel_color_stack_int=\count282 +\l__pdf_internal_box=\box53 +) + +LaTeX Warning: Unused global option(s): + [8pt]. + +(./R_workshop.aux) +\openout1 = `R_workshop.aux'. + +LaTeX Font Info: Checking defaults for OML/cmm/m/it on input line 113. +LaTeX Font Info: ... okay on input line 113. +LaTeX Font Info: Checking defaults for OMS/cmsy/m/n on input line 113. +LaTeX Font Info: ... okay on input line 113. +LaTeX Font Info: Checking defaults for OT1/cmr/m/n on input line 113. +LaTeX Font Info: ... okay on input line 113. +LaTeX Font Info: Checking defaults for T1/cmr/m/n on input line 113. +LaTeX Font Info: ... okay on input line 113. +LaTeX Font Info: Checking defaults for TS1/cmr/m/n on input line 113. +LaTeX Font Info: ... okay on input line 113. +LaTeX Font Info: Checking defaults for OMX/cmex/m/n on input line 113. +LaTeX Font Info: ... okay on input line 113. +LaTeX Font Info: Checking defaults for U/cmr/m/n on input line 113. +LaTeX Font Info: ... okay on input line 113. +LaTeX Font Info: Checking defaults for PD1/pdf/m/n on input line 113. +LaTeX Font Info: ... okay on input line 113. +LaTeX Font Info: Checking defaults for PU/pdf/m/n on input line 113. +LaTeX Font Info: ... okay on input line 113. +LaTeX Info: Redefining \microtypecontext on input line 113. +Package microtype Info: Generating PDF output. +Package microtype Info: Character protrusion enabled (level 2). +Package microtype Info: Using protrusion set `basicmath'. +Package microtype Info: Automatic font expansion enabled (level 2), +(microtype) stretch: 20, shrink: 20, step: 1, non-selected. +Package microtype Info: Using default expansion set `basictext'. +LaTeX Info: Redefining \showhyphens on input line 113. +Package microtype Info: No adjustment of tracking. +Package microtype Info: No adjustment of interword spacing. +Package microtype Info: No adjustment of character kerning. +(/usr/share/texlive/texmf-dist/tex/latex/microtype/mt-cmr.cfg +File: mt-cmr.cfg 2013/05/19 v2.2 microtype config. file: Computer Modern Roman +(RS) +) +\AtBeginShipoutBox=\box54 +Package hyperref Info: Link coloring OFF on input line 113. +(/usr/share/texlive/texmf-dist/tex/latex/hyperref/nameref.sty +Package: nameref 2019/09/16 v2.46 Cross-referencing by name of section +(/usr/share/texlive/texmf-dist/tex/latex/refcount/refcount.sty +Package: refcount 2019/12/15 v3.6 Data extraction from label references (HO) +) (/usr/share/texlive/texmf-dist/tex/generic/gettitlestring/gettitlestring.sty +Package: gettitlestring 2019/12/15 v1.6 Cleanup title references (HO) +) +\c@section@level=\count283 +) +LaTeX Info: Redefining \ref on input line 113. +LaTeX Info: Redefining \pageref on input line 113. +LaTeX Info: Redefining \nameref on input line 113. +(./R_workshop.out) (./R_workshop.out) +\@outlinefile=\write4 +\openout4 = `R_workshop.out'. + +*geometry* driver: auto-detecting +*geometry* detected driver: pdftex +*geometry* verbose mode - [ preamble ] result: +* driver: pdftex +* paper: +* layout: +* layoutoffset:(h,v)=(0.0pt,0.0pt) +* modes: +* h-part:(L,W,R)=(72.26999pt, 469.75502pt, 72.26999pt) +* v-part:(T,H,B)=(72.26999pt, 650.43001pt, 72.26999pt) +* \paperwidth=614.295pt +* \paperheight=794.96999pt +* \textwidth=469.75502pt +* \textheight=650.43001pt +* \oddsidemargin=0.0pt +* \evensidemargin=0.0pt +* \topmargin=-37.0pt +* \headheight=12.0pt +* \headsep=25.0pt +* \topskip=10.0pt +* \footskip=30.0pt +* \marginparwidth=65.0pt +* \marginparsep=11.0pt +* \columnsep=10.0pt +* \skip\footins=9.0pt plus 4.0pt minus 2.0pt +* \hoffset=0.0pt +* \voffset=0.0pt +* \mag=1000 +* \@twocolumnfalse +* \@twosidefalse +* \@mparswitchfalse +* \@reversemarginfalse +* (1in=72.27pt=25.4mm, 1cm=28.453pt) + +(/usr/share/texlive/texmf-dist/tex/context/base/mkii/supp-pdf.mkii +[Loading MPS to PDF converter (version 2006.09.02).] +\scratchcounter=\count284 +\scratchdimen=\dimen178 +\scratchbox=\box55 +\nofMPsegments=\count285 +\nofMParguments=\count286 +\everyMPshowfont=\toks26 +\MPscratchCnt=\count287 +\MPscratchDim=\dimen179 +\MPnumerator=\count288 +\makeMPintoPDFobject=\count289 +\everyMPtoPDFconversion=\toks27 +) (/usr/share/texlive/texmf-dist/tex/latex/epstopdf-pkg/epstopdf-base.sty +Package: epstopdf-base 2020-01-24 v2.11 Base part for package epstopdf +Package epstopdf-base Info: Redefining graphics rule for `.eps' on input line 4 +85. +(/usr/share/texlive/texmf-dist/tex/latex/latexconfig/epstopdf-sys.cfg +File: epstopdf-sys.cfg 2010/07/13 v1.3 Configuration of (r)epstopdf for TeX Liv +e +)) +LaTeX Font Info: Trying to load font information for OT1+lmr on input line 1 +15. +(/usr/share/texmf/tex/latex/lm/ot1lmr.fd +File: ot1lmr.fd 2009/10/30 v1.6 Font defs for Latin Modern +) +LaTeX Font Info: Trying to load font information for OML+lmm on input line 1 +15. +(/usr/share/texmf/tex/latex/lm/omllmm.fd +File: omllmm.fd 2009/10/30 v1.6 Font defs for Latin Modern +) +LaTeX Font Info: Trying to load font information for OMS+lmsy on input line +115. +(/usr/share/texmf/tex/latex/lm/omslmsy.fd +File: omslmsy.fd 2009/10/30 v1.6 Font defs for Latin Modern +) +LaTeX Font Info: Trying to load font information for OMX+lmex on input line +115. +(/usr/share/texmf/tex/latex/lm/omxlmex.fd +File: omxlmex.fd 2009/10/30 v1.6 Font defs for Latin Modern +) +LaTeX Font Info: External font `lmex10' loaded for size +(Font) <12> on input line 115. +LaTeX Font Info: External font `lmex10' loaded for size +(Font) <8> on input line 115. +LaTeX Font Info: External font `lmex10' loaded for size +(Font) <6> on input line 115. +LaTeX Font Info: Trying to load font information for U+msa on input line 115 +. +(/usr/share/texlive/texmf-dist/tex/latex/amsfonts/umsa.fd +File: umsa.fd 2013/01/14 v3.01 AMS symbols A +) (/usr/share/texlive/texmf-dist/tex/latex/microtype/mt-msa.cfg +File: mt-msa.cfg 2006/02/04 v1.1 microtype config. file: AMS symbols (a) (RS) +) +LaTeX Font Info: Trying to load font information for U+msb on input line 115 +. +(/usr/share/texlive/texmf-dist/tex/latex/amsfonts/umsb.fd +File: umsb.fd 2013/01/14 v3.01 AMS symbols B +) (/usr/share/texlive/texmf-dist/tex/latex/microtype/mt-msb.cfg +File: mt-msb.cfg 2005/06/01 v1.0 microtype config. file: AMS symbols (b) (RS) +) +LaTeX Font Info: Trying to load font information for TS1+lmr on input line 1 +43. +(/usr/share/texmf/tex/latex/lm/ts1lmr.fd +File: ts1lmr.fd 2009/10/30 v1.6 Font defs for Latin Modern +) +LaTeX Font Info: Trying to load font information for T1+lmtt on input line 1 +49. +(/usr/share/texmf/tex/latex/lm/t1lmtt.fd +File: t1lmtt.fd 2009/10/30 v1.6 Font defs for Latin Modern +) +LaTeX Font Info: Font shape `T1/lmtt/bx/n' in size <10> not available +(Font) Font shape `T1/lmtt/b/n' tried instead on input line 151. +[1 + +{/var/lib/texmf/fonts/map/pdftex/updmap/pdftex.map}] [2] + +Package hyperref Warning: Difference (2) between bookmark levels is greater +(hyperref) than one, level fixed on input line 319. + +LaTeX Font Info: Trying to load font information for TS1+lmtt on input line +359. +(/usr/share/texmf/tex/latex/lm/ts1lmtt.fd +File: ts1lmtt.fd 2009/10/30 v1.6 Font defs for Latin Modern +) [3] + +Package hyperref Warning: Difference (2) between bookmark levels is greater +(hyperref) than one, level fixed on input line 399. + +[4] +Overfull \vbox (1.76242pt too high) detected at line 514 + [] + +[5] + +Package hyperref Warning: Difference (2) between bookmark levels is greater +(hyperref) than one, level fixed on input line 581. + + +Overfull \vbox (0.10408pt too high) detected at line 590 + [] + +[6] [7] +LaTeX Font Info: External font `lmex10' loaded for size +(Font) <10> on input line 694. +LaTeX Font Info: External font `lmex10' loaded for size +(Font) <7> on input line 694. +LaTeX Font Info: External font `lmex10' loaded for size +(Font) <5> on input line 694. + +Package hyperref Warning: Difference (2) between bookmark levels is greater +(hyperref) than one, level fixed on input line 743. + + +Overfull \hbox (1.96742pt too wide) in paragraph at lines 773--774 +[]\T1/lmr/m/n/10 (-20) Description| + [] + +[8] + +Package hyperref Warning: Difference (2) between bookmark levels is greater +(hyperref) than one, level fixed on input line 833. + +[9] [10] [11] +Overfull \hbox (13.10422pt too wide) in paragraph at lines 1110--1113 +[]\T1/lmr/m/n/10 (-20) Calculate the \T1/lmr/bx/n/10 cor-re-la-tion \T1/lmr/m/n +/10 (-20) (\T1/lmtt/m/n/10 cor()\T1/lmr/m/n/10 (-20) ) be-tween vari-able \T1/l +mtt/m/n/10 S_01.control.Rep1 \T1/lmr/m/n/10 (-20) and vari-able \T1/lmtt/m/n/10 + S_03.control.Rep2 + [] + + +File: R_workshop_files/figure-latex/unnamed-chunk-40-1.pdf Graphic file (type p +df) + +Package pdftex.def Info: R_workshop_files/figure-latex/unnamed-chunk-40-1.pdf +used on input line 1119. +(pdftex.def) Requested size: 436.63019pt x 250.93687pt. +[12] +Underfull \hbox (badness 5203) in paragraph at lines 1124--1127 +[]\T1/lmr/m/n/10 (+20) Calculate the \T1/lmr/bx/n/10 T Test \T1/lmr/m/n/10 (+20 +) (\T1/lmtt/m/n/10 t.test()\T1/lmr/m/n/10 (+20) ) com-par-ing vari-able \T1/lmt +t/m/n/10 S_01.control.Rep1 \T1/lmr/m/n/10 (+20) and vari-able + [] + + +File: R_workshop_files/figure-latex/unnamed-chunk-41-1.pdf Graphic file (type p +df) + +Package pdftex.def Info: R_workshop_files/figure-latex/unnamed-chunk-41-1.pdf +used on input line 1129. +(pdftex.def) Requested size: 407.52771pt x 222.83534pt. +[13 <./R_workshop_files/figure-latex/unnamed-chunk-40-1.pdf> <./R_workshop_file +s/figure-latex/unnamed-chunk-41-1.pdf>] + +File: R_workshop_files/figure-latex/unnamed-chunk-43-1.pdf Graphic file (type p +df) + +Package pdftex.def Info: R_workshop_files/figure-latex/unnamed-chunk-43-1.pdf +used on input line 1170. +(pdftex.def) Requested size: 440.65189pt x 286.07242pt. +[14 <./R_workshop_files/figure-latex/unnamed-chunk-43-1.pdf>] + +File: R_workshop_files/figure-latex/unnamed-chunk-44-1.pdf Graphic file (type p +df) + +Package pdftex.def Info: R_workshop_files/figure-latex/unnamed-chunk-44-1.pdf +used on input line 1190. +(pdftex.def) Requested size: 440.65189pt x 286.07242pt. +[15 <./R_workshop_files/figure-latex/unnamed-chunk-44-1.pdf>] + +File: R_workshop_files/figure-latex/unnamed-chunk-46-1.pdf Graphic file (type p +df) + +Package pdftex.def Info: R_workshop_files/figure-latex/unnamed-chunk-46-1.pdf +used on input line 1233. +(pdftex.def) Requested size: 443.6564pt x 283.0568pt. +[16 <./R_workshop_files/figure-latex/unnamed-chunk-46-1.pdf>] [17] + +Package hyperref Warning: Difference (2) between bookmark levels is greater +(hyperref) than one, level fixed on input line 1433. + +[18] [19] + +Package hyperref Warning: Difference (2) between bookmark levels is greater +(hyperref) than one, level fixed on input line 1566. + +[20] [21] [22] [23] + +Package hyperref Warning: Difference (2) between bookmark levels is greater +(hyperref) than one, level fixed on input line 1843. + +[24] [25] + +Package hyperref Warning: Difference (2) between bookmark levels is greater +(hyperref) than one, level fixed on input line 1997. + +[26] +Underfull \vbox (badness 10000) detected at line 2127 + [] + + +Underfull \vbox (badness 10000) detected at line 2127 + [] + +[27] [28] +Package atveryend Info: Empty hook `BeforeClearDocument' on input line 2224. +[29] +Package atveryend Info: Empty hook `AfterLastShipout' on input line 2224. +(./R_workshop.aux) +Package atveryend Info: Executing hook `AtVeryEndDocument' on input line 2224. +Package atveryend Info: Executing hook `AtEndAfterFileList' on input line 2224. + +Package rerunfilecheck Info: File `R_workshop.out' has not changed. +(rerunfilecheck) Checksum: C6DBC7943782398E3C104D8020C59D48;7340. + ) +Here is how much of TeX's memory you used: + 13331 strings out of 483065 + 196135 string characters out of 5963551 + 479997 words of memory out of 5000000 + 27892 multiletter control sequences out of 15000+600000 + 584602 words of font info for 90 fonts, out of 8000000 for 9000 + 81 hyphenation exceptions out of 8191 + 34i,5n,42p,818b,463s stack positions out of 5000i,500n,10000p,200000b,80000s +{/usr/share/texmf/fonts/enc/dvips/lm/lm-ec.enc}{/usr/share/texmf/fonts/enc/dv +ips/lm/lm-ts1.enc} +Output written on R_workshop.pdf (29 pages, 2789639 bytes). +PDF statistics: + 608 PDF objects out of 1000 (max. 8388607) + 548 compressed objects within 6 object streams + 185 named destinations out of 1000 (max. 500000) + 10770 words of extra memory for PDF output out of 12000 (max. 10000000) + diff --git a/R_workshop.pdf b/R_workshop.pdf index 4e90d7e..3271b27 100644 Binary files a/R_workshop.pdf and b/R_workshop.pdf differ diff --git a/data/output_results.csv b/data/output_results.csv new file mode 100644 index 0000000..63059b2 --- /dev/null +++ b/data/output_results.csv @@ -0,0 +1,1001 @@ +gene_id,Rep1,Rep2,Rep3,Rep4,Rep5,Rep6,Rep7,Rep8,p.value,mean.g1,mean.g2,log2fc,q.value +1,gene_1,105.392119640751,94.4399149787507,116.868979459851,141.044848477464,93.3452319856818,115.711460724632,113.259064810326,82.6844963335555,0.343388155131913,114.436465639204,101.250063463549,-0.17662403366561,0.919758854682739 +2,gene_2,87.4002917192145,142.944982694153,51.7318608433518,94.6818421376446,70.8988290809317,115.544738693817,102.726029079554,104.11582087209,0.853152540466031,94.1897443485909,98.3213544315981,0.0619348061913814,0.97704151387307 +3,gene_3,117.373196553045,79.4223982724865,121.767218669972,79.9895978057203,108.931474273619,112.089957270666,76.6310101216566,87.1578874587746,0.819663351655675,99.638102825306,96.202582281179,-0.0506219324751154,0.97704151387307 +4,gene_4,134.543910342305,77.289991339564,126.447609235964,91.3637220407366,78.8368370798149,104.228748588906,105.84412559192,115.796500687771,0.710649978684877,107.411308239642,101.176552987103,-0.0862708944401962,0.97704151387307 +5,gene_5,100.483752835354,143.685781884262,105.274933671735,104.194766120656,116.448128496825,86.1644496048584,107.042995281869,110.420306028285,0.517771980680193,113.409808628002,105.018969852959,-0.110895472766649,0.958914368513127 +6,gene_6,107.36050353985,118.166680119551,108.506997499103,84.1718714434523,109.036430613738,103.130201681279,111.164442045292,69.5544581203595,0.620898442334831,104.551513150489,98.2213831151672,-0.0901048986216296,0.976960798897723 +7,gene_7,73.8159140358295,73.8939309838299,84.913690531388,57.1289164214554,82.7494457177713,124.454461462804,100.880552243645,85.0785031559859,0.0699167138170526,72.4381129931257,98.2907406450514,0.440306551014039,0.459978380375346 +8,gene_8,114.772438614228,127.514364283169,79.2635113834416,70.0193391326133,86.4089679075019,120.697646731505,71.5886765752683,96.1853454277497,0.817378452230623,97.892413353363,93.7201591605062,-0.062837651258813,0.97704151387307 +9,gene_9,100.8974597475,97.8836663867022,81.3670399515819,72.1037864578553,125.200804209366,102.89917955427,101.750883145315,129.534495737057,0.0366473311109426,88.0629881359098,114.846340661502,0.383097185526399,0.299981347693748 +10,gene_10,79.032055997576,71.8535199623683,109.189050830131,107.942109805564,125.138275021186,80.9479796862683,105.953340270375,94.6695394607577,0.49912948260203,92.00418414891,101.677283609647,0.144226014825953,0.958914368513127 +11,gene_11,134.557021808915,119.911510954692,90.2067820453168,98.0389327735017,116.538473351499,73.5678639952192,124.6460946025,124.742035628353,0.96133811371838,110.678561895606,109.873616894393,-0.0105307988707695,0.992641973777354 +12,gene_12,76.4280052195504,80.6091739610174,83.559984859044,99.9810882491833,126.943249968787,108.527921755951,83.9934733309626,97.697068849315,0.128855728943101,85.1445630721988,104.290428476254,0.29262044256778,0.663828735367626 +13,gene_13,113.064134221938,62.6261564166001,137.617803056959,85.505233436316,100.306283185242,118.544592352359,78.6882695666372,78.2308267372327,0.773869650058824,99.7033317829533,93.9424929603678,-0.085863836890175,0.97704151387307 +14,gene_14,92.6286701659273,105.7859695004,132.76842100278,62.1975429651622,89.5264185366731,115.205612672037,95.5875071803639,88.8039269297519,0.949840084505706,98.3451509085674,97.2808663297065,-0.0156978427981429,0.992641973777354 +15,gene_15,88.0089071291044,87.7395290011143,89.1361984503023,81.38824727412,81.2824229093209,90.9798434374404,121.452590567186,113.350294856119,0.203879185194746,86.5682204636603,101.766287942517,0.233350311636765,0.760743228338604 +16,gene_16,101.092103309147,108.467140409955,83.3394907144324,99.0589273237472,124.444237955186,92.7540522795975,110.739095036724,125.67751291858,0.155297866899834,97.9894154393204,113.403724547522,0.210770197253581,0.711320181265988 +17,gene_17,134.153548508987,97.0099864079309,92.8282764194458,107.282002472833,97.8021805150032,74.1945700197467,85.1629307293118,55.3418246628377,0.061461012410634,107.818453452299,78.1253764817249,-0.464740978758578,0.429797289584853 +18,gene_18,78.1125404884341,128.8967945158,104.405295479623,80.527143140837,288.221432526895,339.394952351492,207.085946064292,368.393559458866,0.00709246325630538,97.9854434061735,300.773972600386,1.6180403838625,0.0985064341153525 +19,gene_19,94.2143635100721,86.7807337849613,102.956798601058,103.868854011374,86.2940240066099,108.465473686064,119.941370352304,102.344997383155,0.409469983232429,96.9551874768662,104.261466357033,0.104816060316649,0.930988787286778 +20,gene_20,144.148259216076,118.2337615386,89.4492588015742,97.5608329059919,127.788010963802,81.8831874623861,105.308693529112,112.863754952508,0.74095690521458,112.348028115561,106.960911726952,-0.0708911351521531,0.97704151387307 +21,gene_21,110.374980130032,104.55080633105,130.663088330822,115.709771187222,88.3989276462035,110.918162520639,102.243765720099,89.1173410553529,0.0644725354751124,115.324661494782,97.6695492355736,-0.239720314242774,0.435625239696705 +22,gene_22,71.9016412831942,111.462845521271,76.3576690336192,75.2767458462596,103.562950420152,84.2145322658076,155.098181450541,86.7406582927388,0.269151836558739,83.749725421086,107.40408060731,0.358892441123253,0.851746318223856 +23,gene_23,140.297289603182,79.5467324788055,91.02681653202,106.251461480964,72.7487639056247,82.7576130936271,86.2873959802255,124.866995566876,0.497610181561733,104.280575023743,91.6651921365882,-0.186024532463619,0.958914368513127 +24,gene_24,76.2368332594986,118.40233146353,109.777804112303,114.739147488815,128.15759856347,76.1771901324233,120.783077711645,93.9940369491369,0.999453122312829,104.789029081037,104.777975839169,-0.000152184808383053,0.999453122312829 +25,gene_25,103.807616151763,113.039274689267,82.6307963080043,134.080312957204,98.7436534347715,75.8078783241509,112.328421816621,122.879477827683,0.700362922684016,108.38950002656,102.439857850807,-0.0814478497165416,0.976960798897723 +26,gene_26,76.605281798909,105.226570862222,89.8039051941611,115.178238432175,156.339095255921,116.392393486528,102.330607046349,96.6923862122299,0.238841078599561,96.7034990718668,117.938620500257,0.286396226986189,0.818289875612779 +27,gene_27,99.2383688111128,103.019485114067,124.520910798773,47.1657402351579,109.317411105436,81.49788612517,108.476550257255,111.711541539758,0.631302981436104,93.4861262397779,102.750847256905,0.136326106459377,0.976960798897723 +28,gene_28,147.084085219538,107.198177854647,97.3334668323606,110.561839394526,45.0245926382286,29.0328292215282,37.1840980988252,34.2828052579066,0.00342011364195817,115.544392325268,36.3810813041222,-1.66718691575015,0.0645304460746825 +29,gene_29,127.868525187463,134.798793713023,88.1607489633731,117.748033420499,80.4002085808383,90.4468887386051,91.5163361330372,88.7123122090645,0.0608625523007148,117.14402532109,87.7689364153863,-0.41650104455899,0.428609523244471 +30,gene_30,88.7933528244364,98.7762891861846,88.4363064504868,113.326189360897,127.463898392792,121.39359441279,92.9165958418251,101.975836520695,0.226760039257341,97.3330344555013,110.937481292026,0.188745437867859,0.815523488873472 +31,gene_31,86.5708123285845,91.295524550665,93.7261524121371,94.0386624519156,111.416500247859,114.845817917208,120.945721734972,93.9453739016977,0.0420107739787672,91.4077879358255,110.288353450434,0.270891455947339,0.327770356152906 +32,gene_32,109.848771094619,81.5969916378554,135.657391295438,107.995151560539,104.538792884305,89.3933446134048,90.2224299237921,98.4776803894376,0.327789897830426,108.774576397113,95.6580619527348,-0.185382931068589,0.919758854682739 +33,gene_33,76.4121896764789,124.452808108133,123.137472197806,144.074233187097,85.3173640748983,87.3527669164719,94.8096109233607,108.688137558256,0.21123489451049,117.019175792379,94.0419698682467,-0.315368297782169,0.773754192346117 +34,gene_34,78.8256509617679,115.463907618079,97.8403589243422,99.852802377478,103.560536492298,109.366221720941,138.425481505231,98.4421534602041,0.263287873104744,97.9956799704168,112.448598294669,0.198475621453265,0.84773030824189 +35,gene_35,122.758052260002,85.4848358808614,94.4564317485036,122.991950350732,102.324668340384,84.1541736371897,129.477159956858,81.3140813701807,0.646438829051427,106.422817560025,99.3175208261531,-0.0996873503267337,0.976960798897723 +36,gene_36,96.7946943019806,103.563171264609,90.1951738314595,72.8165393168708,91.7363261410478,72.8416967138349,121.234433936522,110.091147510973,0.544088392882585,90.8423946787301,98.9759010755945,0.123711559446148,0.975593151676992 +37,gene_37,112.609862532999,137.161275352127,78.959604801572,111.281833101866,113.099548328169,99.4339361686418,89.9029977984328,71.7521869957743,0.311428354302355,110.003143947141,93.5471673227545,-0.23377888394492,0.9106092231063 +38,gene_38,132.339194047891,118.087307395875,138.917587171792,98.0626644403252,104.955421582332,79.895451528622,119.639020561236,109.391331236168,0.188024835121886,121.851688263971,103.47030622709,-0.235909435455537,0.757207212115658 +39,gene_39,96.1300034296247,82.9195108553278,92.9911203764285,126.08350640524,78.6965376695995,65.738556519471,77.1608141170026,100.322634903458,0.159463339386759,99.5310352666553,80.4796358023828,-0.306522673241219,0.711320181265988 +40,gene_40,67.8441631491857,117.653939498877,111.715416860626,139.4859875466,87.7691189799018,108.013023955443,96.1984086612088,83.3688697077241,0.394168466604217,109.174876763822,93.8373553260694,-0.218406643889883,0.919758854682739 +41,gene_41,82.2967174459608,74.6904722011224,124.216181065391,129.587171070173,93.0671295288932,107.849428313201,70.5241710564154,131.742677803866,0.923891487327407,102.697635445662,100.795851675594,-0.0269666998829504,0.989992953448256 +42,gene_42,91.3533140208147,102.118483977231,84.0879857138515,105.874837111693,93.8760574139254,99.9231334881306,67.3379292336439,94.7929028711439,0.471492660002055,95.8586552058974,88.9825057517109,-0.107386975186441,0.958914368513127 +43,gene_43,91.5675228121192,110.560462143719,97.7322668234525,112.717236284228,133.256179278852,95.5312386812686,76.0452944217919,90.5282798096599,0.760845438484538,103.14437201588,98.8402480478932,-0.0614945676073489,0.97704151387307 +44,gene_44,96.5901187360957,119.894211355775,123.824369859509,122.511554178765,92.4857862603565,88.6811868694778,87.9452161392634,99.710874052624,0.0277055502456128,115.705063532536,92.2057658304304,-0.327523128140996,0.246025519246968 +45,gene_45,104.916218744527,93.70436423323,71.0519065750894,117.084787412858,119.893095016918,72.4953754983183,109.327615495652,81.4085044191603,0.953408441013457,96.689319241426,95.781147607512,-0.0136148101861486,0.992641973777354 +46,gene_46,85.0850443029929,99.0321188650571,82.6880937600049,98.7728578824434,69.9659649582532,86.295251871538,75.7168073394513,101.285543008429,0.366167094807243,91.3945287026246,83.315891794418,-0.133516097909849,0.919758854682739 +47,gene_47,94.5211173347919,91.4275170789214,60.802642305092,99.0152869114201,85.1931549148655,103.385372878376,115.05003062089,73.6943284173783,0.556485004458298,86.4416409075564,94.3307217078775,0.126001246647553,0.976960798897723 +48,gene_48,136.491578813092,104.152714950561,111.668258044297,104.055135315424,94.7174946878789,114.730166023241,124.807273993782,94.5394078673816,0.545524118819884,114.091921780843,107.198585643071,-0.0899107746827092,0.975593151676992 +49,gene_49,100.284674797032,132.933700991547,101.038084647471,94.7558819331115,92.2347544779463,77.7342705903197,98.95584586911,64.3629637842983,0.0855354526997479,107.25308559229,83.3219586804186,-0.364250494734531,0.531276103725142 +50,gene_50,103.76085486905,112.61785243725,96.6803761710357,95.5055262505136,108.030366174939,99.427051315022,113.387269997034,101.098835474482,0.536523288473695,102.141152431962,105.485880740369,0.0464856656660403,0.973726476358793 +51,gene_51,98.9173261945255,130.38623483533,99.5797904078748,72.1908881198037,107.087034111452,101.211555538885,133.374875169113,112.086029365863,0.385049855433856,100.268559889383,113.439873546328,0.178058522664888,0.919758854682739 +52,gene_52,109.232233405117,91.7095462704373,128.374175066081,94.8092924586324,102.866598766483,105.692038316648,122.881671045465,104.799244836069,0.7652890033734,106.031311800067,109.059888241166,0.0406302163651829,0.97704151387307 +53,gene_53,88.0645940921656,97.8163758663226,120.648585717354,111.178528870972,68.6543540516425,116.748976428636,104.476765406519,100.256036858667,0.603839976288483,104.427021136704,97.5340331863662,-0.0985174456514704,0.976960798897723 +54,gene_54,125.265164719362,103.575193153048,133.018883677094,78.5767881998442,240.087132841745,159.041182151134,299.950448696353,294.920108553451,0.0182645575312974,110.109007437337,248.499718060671,1.17431172195142,0.182518921751139 +55,gene_55,77.0934192533504,121.243662699397,100.572563555374,95.6243442903912,91.503861043187,128.456562554969,86.534992198576,73.8122265264009,0.818971927651202,98.6334974496283,95.0769105807832,-0.0529826659408196,0.97704151387307 +56,gene_56,121.692471118698,110.866985056143,100.155985272404,93.39025216331,125.880907521825,115.988379057305,122.476578560155,108.668503094208,0.16819984202479,106.526423402639,118.253592058373,0.150672678489817,0.726177314590369 +57,gene_57,69.4200937262311,93.9723419046896,113.400766426222,112.095276452413,91.5032742277112,109.080872475988,115.357107813926,65.7311466804189,0.909010247760204,97.2221196273889,95.418100299511,-0.0270216243021557,0.989971080047645 +58,gene_58,68.5251623431024,122.677216934136,91.9963965223353,127.805968367179,81.4288418085875,143.975851184676,101.096894654598,72.5125327031295,0.891805108629407,102.751186041688,99.7535300877476,-0.0427152452325739,0.988697459677835 +59,gene_59,97.7181473911014,122.886705871181,94.7257484587656,114.112593954884,111.789653421943,71.3048128054227,105.14784204764,133.636637331107,0.902177990044034,107.360798918983,105.469736401528,-0.0256382225576949,0.989971080047645 +60,gene_60,102.224183597027,111.151935707996,87.7344048110853,79.9248048573815,271.32545804027,214.607274309888,472.530727046558,187.542926645765,0.0582410263363523,95.2588322433725,286.50159651062,1.58861841007584,0.416007330973945 +61,gene_61,104.282752408226,139.044493678211,104.551940162646,101.131578423207,95.4693588949937,115.25899416059,144.133068263393,122.916889043822,0.612906609919951,112.252691168073,119.4445775907,0.0895913286141744,0.976960798897723 +62,gene_62,111.075516500834,106.514230698559,88.917529981938,95.1182219206849,111.281578024601,95.5685948240421,109.709399544375,98.9757637332286,0.608287536163037,100.406374775504,103.883834031562,0.0491202969888887,0.976960798897723 +63,gene_63,78.809609627698,80.5856297990079,86.6536400322852,94.1846021104878,97.3826475050683,114.705826604986,69.6911100897977,110.748142603307,0.296172079149904,85.0583703923697,98.1319317007898,0.206269444416942,0.900219085562018 +64,gene_64,67.7990134749711,83.5668922007971,78.4876853179653,90.5795722190269,269.596546282217,426.368748440803,323.035516644628,248.017220946583,0.00894952441869519,80.1082908031901,316.754508078558,1.98334168495909,0.11328511922399 +65,gene_65,93.2369787473079,103.892634297805,87.1915540060432,89.6625762420931,108.024435004334,84.0606948848011,80.9007934276524,86.4938719904534,0.635205097618254,93.4959358233124,89.8699488268101,-0.0570648731932817,0.976960798897723 +66,gene_66,104.098755068525,103.719086416461,120.933067307123,100.154510130322,117.454957553332,82.9559505847729,123.877096306906,107.128950230967,0.953193804765844,107.226354730608,107.854238668995,0.00842333195339487,0.992641973777354 +67,gene_67,95.5130992145762,108.262866841187,83.0454324662819,63.2211193232824,98.3297443852068,144.217813504924,94.2254912301211,92.4756976167519,0.255405976572241,87.510629461332,107.312186684251,0.29428375267647,0.840151238724476 +68,gene_68,81.8078059196233,63.4850620788634,116.320754033492,102.685211341722,106.385086553569,90.5463516359569,85.9878780777054,142.664389930933,0.410906184939765,91.0747083434252,106.395926549541,0.224320542180855,0.930988787286778 +69,gene_69,83.8378023150393,115.057466933628,104.301145343744,110.624551063219,91.0554295158816,116.888693993047,106.170338281054,113.659322340634,0.71164941298192,103.455241413908,106.943446032654,0.0478413313202204,0.97704151387307 +70,gene_70,111.061670282844,94.6913625357115,56.3993334267945,55.0216517001285,75.8543943040759,88.3684282513911,129.697929235233,93.9327269821875,0.369575362293283,79.2935044863696,96.9633696932219,0.290237147533109,0.919758854682739 +71,gene_71,92.2164413479363,93.6082623578167,119.303499485487,117.294780759012,49.6872181600855,71.6209151970742,151.94011811578,110.759373205398,0.70790484162854,105.605745987563,96.0019061695845,-0.137553376862832,0.97704151387307 +72,gene_72,91.0550872281119,96.9448512971502,129.500004611909,103.337334440582,98.1360501152633,108.125950289425,141.793547015711,109.231022352716,0.501173620821732,105.209319394438,114.321642443279,0.11983604512435,0.958914368513127 +73,gene_73,99.5772230966199,72.9808717778821,113.943243057179,100.899351919521,37.1648549481944,36.0871121261046,32.0136321765883,34.9263638219161,0.00508070292992934,96.8501724628006,35.0479907682009,-1.46642287810202,0.079385983280146 +74,gene_74,88.0116508975055,89.3636461464893,67.0874672985099,108.131612262686,98.6340273939452,106.58953783769,105.100827730177,114.785548036541,0.116347122593483,88.1485941512977,106.277485249588,0.26982653028227,0.635776626193898 +75,gene_75,93.7826762089184,76.615918600386,84.3420615748825,92.3501519180527,87.1242012589426,116.879796965765,101.713846438905,101.336163727543,0.0919900937882843,86.7727020755599,101.763502097789,0.229907065558332,0.560915206026124 +76,gene_76,86.3673506222891,88.9080979443294,98.7596047050413,80.9748012638324,101.95256488643,58.6851701726321,71.5041388819178,131.231334919059,0.907337343202847,88.752463633873,90.8433022150097,0.033592982842834,0.989971080047645 +77,gene_77,95.9588855297438,91.5189619646244,70.6704269327681,117.159306527848,102.980691388038,84.5544229490298,69.556873050294,108.813949136375,0.863289586646668,93.8268952387462,91.4764841309341,-0.036600609555952,0.97704151387307 +78,gene_78,122.336006584812,96.8207105910944,89.8305400555757,85.2341269385485,152.788677817603,95.332414003976,88.3368405931046,116.809340322724,0.418604775081684,98.5553460425076,113.316818184352,0.201355961909874,0.932304621562769 +79,gene_79,116.519984253415,81.2739397033296,93.967292290902,93.4247106168618,131.460373116434,95.2671990464815,129.537748293987,52.2907551298526,0.784810137212246,96.2964817161271,102.139018896689,0.0849791124200147,0.97704151387307 +80,gene_80,125.018379596258,89.9743283777605,115.943373602934,132.708355866502,102.833188362354,116.747498208949,64.8098192968905,95.7335172177536,0.198207724885993,115.911109360864,95.0310057714868,-0.286548642789744,0.760743228338604 +81,gene_81,152.161961899614,93.217961563464,57.5612827909983,87.6022422861266,155.669667642661,107.275293907383,115.330157282672,84.4679027800844,0.495155476802597,97.6358621350507,115.6857554032,0.244728174457645,0.958914368513127 +82,gene_82,98.9792007760899,84.2626715495364,104.183749488671,108.539217872263,109.030954913002,116.218427890858,91.6928419265051,95.1628153652754,0.624826320371563,98.9912099216399,103.02626002391,0.0576397784216751,0.976960798897723 +83,gene_83,144.543883886755,69.3907526170094,92.9451795180322,90.9822134583052,92.2023880591509,92.4782507642696,62.6001012616949,96.3106640172108,0.484132809786909,99.4655073700253,85.8978510255815,-0.211574276094,0.958914368513127 +84,gene_84,99.7225575236898,107.620823348453,135.935222632912,52.0055370291536,84.284671548321,95.6259454470619,45.3896249395185,112.323757751631,0.546332164939115,98.821035133552,84.405999921633,-0.227472612643545,0.975593151676992 +85,gene_85,69.0520060647805,155.916266901688,93.5715522080632,67.6139353540351,101.386767876117,114.925626049645,88.9281944868134,70.2165127686048,0.911816525255621,96.5384401321417,93.8642752952949,-0.0405273427053658,0.989971080047645 +86,gene_86,72.4022178168603,114.298582242457,98.2136291628857,77.8099291233958,101.80683239866,78.4234279084003,109.050656058102,96.0329002771182,0.647124881636776,90.6810895863997,96.32845416057,0.0871602881850151,0.976960798897723 +87,gene_87,129.597414816765,116.205514304722,94.4976347556021,84.8365103983055,97.9005276799036,104.720482266119,95.0209779188139,64.6986998679412,0.289505270486602,106.284268568849,90.5851719331944,-0.230581258259681,0.89539901995168 +88,gene_88,94.9015611132225,104.575309586693,83.1931125037854,118.243360352117,140.674943777851,88.1021964158109,89.3021834404888,89.4833805691962,0.915767913429411,100.228335888954,101.890676050837,0.0237316021116404,0.989971080047645 +89,gene_89,93.4743923970816,102.910558370516,107.069841750325,89.5883041089083,117.758558684372,89.3732882676368,97.6724962019953,112.911665239346,0.461865655928202,98.2607741567078,104.429002098338,0.0878349232154628,0.958914368513127 +90,gene_90,85.4672266861546,92.4535121471399,99.2110468777804,98.5966664640301,83.7597130789516,80.5764542267398,120.80735805149,132.568110961055,0.487296389113396,93.9321130437762,104.427909079559,0.152816964920177,0.958914368513127 +91,gene_91,60.9530270009603,84.1487284224435,138.30522941398,115.341644735383,73.9077846384497,85.1748319905785,116.652118760198,85.640993423099,0.651122619513583,99.6871573931917,90.3439322030813,-0.141979947311254,0.976960798897723 +92,gene_92,108.458800835378,137.631159832308,106.647824860636,121.007831459659,110.031193883454,80.1248682243051,92.1448512881581,83.3883613639916,0.0331519964368575,118.436404246995,91.4223186899772,-0.373494281045806,0.28094912234625 +93,gene_93,123.633695715063,95.3758264652252,115.444774844548,98.9828169883881,130.044382658321,105.441763757589,92.74488904432,80.1671406188406,0.639781740291665,108.359278503306,102.099544019768,-0.0858462695779693,0.976960798897723 +94,gene_94,118.359187545523,92.2100148258307,76.8226386083189,88.3053350644717,114.578303750735,127.682010694702,78.9560008885106,81.3974621498534,0.670385999835464,93.9242940110361,100.65344437095,0.0998262703772944,0.976960798897723 +95,gene_95,101.909350937705,100.991490211694,131.533125602272,89.414903159818,107.533836862039,107.660743160351,108.756208456599,86.5009988555542,0.762260865423269,105.962217477872,102.612946833636,-0.0463371710184927,0.97704151387307 +96,gene_96,66.311364265125,67.7981334324127,79.6532402602371,101.67896347446,79.4147957926647,115.916571587886,133.462231046596,73.3035258978923,0.251820883428967,78.8604253580588,100.52428108126,0.350170621263355,0.839001036276196 +97,gene_97,119.806587012123,108.01745782928,53.2740985344853,100.414527244102,80.5295615663763,62.3143429378924,60.8596396370494,146.397240184929,0.763785967901306,95.3781676549976,87.5251960815617,-0.12396067814591,0.97704151387307 +98,gene_98,85.8433643614275,120.051063357366,144.123117800886,109.968284256126,92.0594552991937,77.4000037194656,75.8397122594265,88.8925109057962,0.0746808842433306,114.996457443951,83.5479205459705,-0.460913592408243,0.488110354531572 +99,gene_99,88.1194166137181,90.2139769975882,122.110452206478,116.292830772349,24.8255564608525,39.2870218636536,38.2202710041858,33.6904808303316,0.00200657913401107,104.184169147533,34.0058325397559,-1.61528195803218,0.0542318684867857 +100,gene_100,78.6820593321856,99.7938459028228,115.433535190189,106.165178667793,87.0193545074031,109.647479235019,74.2216089182152,106.049016611925,0.630150730846154,100.018654773247,94.2343648181406,-0.0859439321840982,0.976960798897723 +101,gene_101,81.1846593344818,141.486291687597,67.4379281254283,97.0862089201574,198.819209990908,210.631235387563,267.929609661442,294.124591717537,0.00268643808497104,96.7987720169162,242.876161689362,1.32716024552204,0.0571582571270433 +102,gene_102,101.878208553996,78.3500910384335,80.3204719005454,88.6379373422549,117.051168861036,60.0048198259325,116.613595817879,68.1778680631207,0.855496790046308,87.2966772088074,90.4618631419918,0.0513829685494622,0.97704151387307 +103,gene_103,101.32506767419,114.148697017167,92.3445824470446,90.0148830207324,84.2465720241939,116.072021366571,80.4603613921157,108.528693479084,0.845304400308263,99.4583075397835,97.3269120654912,-0.0312530985685461,0.97704151387307 +104,gene_104,80.1868775389447,124.647861417998,91.7169653490708,73.8025809892575,95.1921518362036,83.1540709564011,97.2142268626804,105.537443948901,0.836830393299553,92.5885713238179,95.2744734010465,0.0412556037062828,0.97704151387307 +105,gene_105,98.5577002741617,112.008669515933,114.582615475303,96.3137889775324,136.528166774491,98.4303451925208,107.317558886287,62.333438375981,0.806541707520336,105.365693560732,101.15237730732,-0.0588749837001487,0.97704151387307 +106,gene_106,95.5348632615874,116.414588998833,91.4126754423963,106.977988852866,105.654565256401,97.4419472414309,64.7282139985635,133.249525154963,0.886360965345235,102.585029138921,100.26856291284,-0.0329508546624764,0.988530250143975 +107,gene_107,97.1444688586812,98.0677183549185,119.567476984842,99.7505158312262,77.2730614511365,87.4049092196652,105.419007322252,104.251803382046,0.292587287599159,103.632545007417,93.5871953437749,-0.147094083491375,0.896912120687058 +108,gene_108,110.708129748898,113.845573879156,96.713042111703,121.352549465407,122.282805729111,75.696586866272,93.2347529900801,131.568834945772,0.73959311309158,110.654823801291,105.695745132809,-0.0661490432070695,0.97704151387307 +109,gene_109,92.5088600373924,90.8863854857455,45.7855647742991,94.9871954178612,76.4786415870428,90.1160521602067,85.6012857910759,119.157026135444,0.462094126888614,81.0420014288246,92.8382514184423,0.196049546542649,0.958914368513127 +110,gene_110,81.6367545760237,86.5320249646588,120.954294963523,86.0123191901943,95.6710526862685,115.949701454515,120.019203437223,53.8250487774379,0.889677225129577,93.7838484235999,96.366251588861,0.0391885075660121,0.988530250143975 +111,gene_111,87.175553070111,83.0562712032883,119.434733199982,103.984883343533,66.2579830400832,92.9496026474614,90.9372215719679,89.8638877455223,0.249828198137923,98.4128602042287,85.0021737512587,-0.211347117974465,0.838090482684514 +112,gene_112,82.941740525734,121.37713137475,70.1370604186597,97.7842181838543,296.514406983166,353.787454573231,280.494049866562,241.485016292766,0.00112866899812958,93.0600376257495,293.070231928931,1.65501276085356,0.038919620625158 +113,gene_113,67.6987297484282,95.0419446217304,109.228495467685,99.7546064633123,119.057515522719,64.3452552884987,94.683925096448,75.8693216712082,0.776628842385543,92.9309440752889,88.4890043947184,-0.0706608664329549,0.97704151387307 +114,gene_114,122.129809596999,75.9801619348944,118.20869353623,128.498362899203,86.7788651370014,84.5177735350601,114.653765606313,123.358707259286,0.587036549797634,111.204256991831,102.327277884415,-0.120021234042745,0.976960798897723 +115,gene_115,91.3420793804165,90.4210903079238,129.713272170335,77.6972549056122,145.973385902564,136.00787944613,94.4083063015515,73.7496261095622,0.488506548935306,97.2934241910718,112.534799439952,0.209956993502189,0.958914368513127 +116,gene_116,112.062080024452,90.4826502905479,127.44547778046,119.898629812965,101.708391406671,107.244907746451,70.7684212878599,90.5160929892685,0.129446603396687,112.472209477106,92.5594533575625,-0.281116323736506,0.663828735367626 +117,gene_117,100.839273771723,125.292848751604,110.811463357235,122.676547234494,117.037072134767,121.645003367621,104.654154701953,99.2737672227731,0.600449216839204,114.905033278764,110.652499356779,-0.0544059566183516,0.976960798897723 +118,gene_118,111.722596058675,110.903285658862,80.4219170995081,88.4440348012195,83.8325762549447,88.4973847256956,113.647357592701,141.882819778039,0.584313467639048,97.8729584045661,106.965034587845,0.128157062620407,0.976960798897723 +119,gene_119,79.2979669612394,83.4681891917966,56.3554693533431,94.0376255325016,79.9341022385674,49.1373272643347,71.9186823084367,113.387299820372,0.985096015684514,78.2898127597202,78.5943529079277,0.00560106383664464,0.997693106634484 +120,gene_120,116.563840478036,111.659077819358,113.680324776244,127.869386849085,88.9415043806809,63.3120520052994,114.297558534863,81.8671273210547,0.0577654030683276,117.443157480681,87.1045605604744,-0.431142499388459,0.415578439340486 +121,gene_121,92.8593317826544,98.248358424282,129.619904571483,102.399046707246,83.5659134411088,85.943531161213,92.9850489785392,91.7695231025727,0.123476300711183,105.781660371416,88.5660041708584,-0.256264590088726,0.649875266900961 +122,gene_122,103.749315667186,85.3666160263218,83.7761102739792,66.8908773132462,103.501185272625,95.7543540178328,99.1192897813612,99.8901792012189,0.146255773003509,84.9457298201832,99.5662520682594,0.229115398713306,0.697243081366878 +123,gene_123,95.7697144767555,94.3091781243303,108.719002609708,123.451966873574,69.718837187117,97.9574040580747,70.6561515223407,94.071895905501,0.0685673118680074,105.562465521092,83.1010721682584,-0.345157955963438,0.454088158066274 +124,gene_124,91.6340581216971,105.945613701241,97.6476650224558,96.8558886876473,36.8933311853385,31.4008188426655,39.059045533758,34.1680576419769,1.39309956966627e-05,98.0208063832603,35.3803133009347,-1.47014119186308,0.00348274892416567 +125,gene_125,85.0212172660314,110.523884066424,89.0424095214839,63.1392936959375,92.1857547155262,32.8731928165012,105.366236379175,86.3262661264764,0.695590157810789,86.9317011374691,79.1878625094196,-0.134603057810975,0.976960798897723 +126,gene_126,96.6791809752773,104.048900199185,94.2517530262359,115.395601806697,87.2340795884133,85.0729701412463,123.883585481213,109.560926841448,0.916701942724655,102.593859001849,101.43789051308,-0.0163477287689255,0.989971080047645 +127,gene_127,52.0510861031867,74.4230661109122,141.338755627888,90.2439689743162,210.035629153193,272.06679291656,326.769382927144,232.952625308958,0.00219847680432878,89.5142192040759,260.456107576464,1.5408514923125,0.0553552260973115 +128,gene_128,117.66517920729,95.2902622126217,100.197570712532,103.806625464808,79.0078920403111,98.4636399958453,88.3786544044283,83.0352749451045,0.037921354356239,104.239909399313,87.2213653464223,-0.257154255714251,0.303915386400201 +129,gene_129,94.9179088458003,95.1841388062014,125.866094484261,85.5999711543176,130.479198767696,101.207962255166,87.678425102255,135.411230967213,0.395598014333179,100.392028322645,113.694204273082,0.17951399669077,0.919758854682739 +130,gene_130,67.0126861679933,110.301542644912,117.694837036603,101.613258772785,115.483197962815,74.2067010788117,112.542915435273,107.890107776058,0.826636119019695,99.1555811555734,102.53073056324,0.0482904952276495,0.97704151387307 +131,gene_131,103.326779604869,89.5697602132009,101.791228422545,88.5708430837653,131.818974238079,115.731478453502,109.487462692143,136.745391325425,0.0149633960216641,95.8146528310952,123.445826677287,0.365559856498427,0.159185064060256 +132,gene_132,118.481792045817,63.6429736138124,128.44910572794,95.5730899269744,78.4322909406899,107.554906189297,93.6828932832166,93.9924605317851,0.629445258037328,101.536740328636,93.4156377362472,-0.120265868780804,0.976960798897723 +133,gene_133,80.7987109132667,112.29210527792,105.208754878598,81.4003533500553,120.961347333425,105.866268998256,70.7270711837529,94.2733250071192,0.828288842178633,94.9249811049599,97.9570031306382,0.0453608304928769,0.97704151387307 +134,gene_134,109.602123254998,135.1891865099,122.786887662973,91.5936406815168,126.356535097431,101.019733279122,91.6093334515116,75.4870412318674,0.297417603771627,114.792959527347,98.6181607649831,-0.219108909621923,0.901265465974626 +135,gene_135,122.550976878426,88.3028526811074,77.165529907984,120.344929686692,120.555735491851,109.057000165986,100.830096508329,106.263120257838,0.592707713923105,102.091072288553,109.176488106001,0.0968054853781953,0.976960798897723 +136,gene_136,113.362506954197,118.999114161698,114.699390669699,99.796068819403,95.9802230748731,75.2030200933148,121.202020090892,104.999118508477,0.300872381443714,111.714270151249,99.3460954418892,-0.169278312430657,0.904560025949688 +137,gene_137,127.139538985669,96.6965030602014,73.4649996527741,94.1955155031881,116.223960547851,80.7388755003469,77.9748602541073,131.172912784353,0.838995451584939,97.8741393004582,101.527652271665,0.052873095602908,0.97704151387307 +138,gene_138,120.45840387705,81.3024417433327,127.46370538277,90.9176634464478,121.337094048771,121.566582636974,106.536229645241,86.5903579822376,0.785631641068381,105.0355536124,109.007566078306,0.0535505239690931,0.97704151387307 +139,gene_139,99.5659099028362,93.1065400287134,108.237075046473,96.7233486595754,42.4992173310926,26.942585525462,36.6381744293246,25.2421766040963,2.07168633116742e-05,99.4082184093995,32.8305384724939,-1.59832671656133,0.00414337266233483 +140,gene_140,70.1273069869036,97.7741161248919,70.5752745486022,138.793495389496,141.134457433402,106.062883041372,104.426145131812,82.2263601017129,0.512767103863847,94.3175482624734,108.462461427075,0.201597694310957,0.958914368513127 +141,gene_141,80.10948120808,80.8865480066657,93.9585691715724,99.5521931972046,115.122571687841,93.8653775720927,115.687935819915,100.753787201853,0.0507098456460065,88.6266978958807,106.357418070425,0.263107393263874,0.38300569893794 +142,gene_142,111.757787054657,115.901311576796,114.054936023584,92.4416041083422,122.334233041286,116.346401218521,122.469877528905,99.4773765557009,0.421496964062071,108.538909690845,115.156972086103,0.0853894390659371,0.934660703327918 +143,gene_143,115.781856967521,107.237642868379,66.9434455402035,95.1889297907478,77.6408661287215,108.534577958611,128.501510928957,125.748613844978,0.41615198791719,96.2879687917129,110.106392215317,0.193470777547526,0.930988787286778 +144,gene_144,126.470949176504,85.0385825264582,65.9506872908836,89.0519669946138,96.9309282747997,118.582698293683,93.7909824242833,138.2794138093,0.263624384032148,91.6280464971148,111.896005700517,0.288297371387763,0.84773030824189 +145,gene_145,114.344423214625,97.0020083977683,94.7024219745944,88.8773586439025,125.405984754974,90.7848151857689,95.5526147694507,104.270131852691,0.597943051564082,98.7315530577227,104.003386640721,0.0750473810914204,0.976960798897723 +146,gene_146,72.3857222054796,85.0645752448579,140.598903125709,97.2681739755586,101.782363691171,118.28857483496,90.1969521595268,99.4499961270283,0.832548747472948,98.8293436379013,102.429471703172,0.0516195127952431,0.97704151387307 +147,gene_147,102.057529951112,98.4216535575913,111.051393386796,86.1087821293806,100.722378021363,109.509393273523,72.6143920808323,78.2236332860022,0.413876270310867,99.4098397562199,90.2674491654303,-0.139182819900605,0.930988787286778 +148,gene_148,64.0191288169165,71.8743956499631,71.8766448802369,82.8722614912368,104.894473147017,96.9948340479691,93.5126654507027,88.0225842850448,0.00454743941925938,72.6606077095883,95.8561392326834,0.399697402122524,0.0733457970848288 +149,gene_149,119.46031437831,82.3416365036217,120.770843759277,89.1998733677144,117.368469451576,81.88702689428,85.2100845102117,140.508202733723,0.854536069486307,102.943167002231,106.243445897448,0.0455257726617636,0.97704151387307 +150,gene_150,104.329715029713,117.863698290639,87.8842717195368,89.8230827868046,101.306564818866,71.0974477396541,109.330909821857,99.2978771675138,0.680462684096209,99.9751919566733,95.2581998869729,-0.0697268600084114,0.976960798897723 +151,gene_151,110.502298406268,114.20441685141,98.1428228347954,111.963657969356,64.7041977208201,107.402365510306,91.1205330351794,109.630932303667,0.235939638851548,108.703299015457,93.2145071424929,-0.221769318396312,0.818289875612779 +152,gene_152,89.1334933009706,88.3516383597733,112.413744065346,84.919239073195,99.3163322431294,116.11267055314,101.146907962425,86.5539403592933,0.448969363729907,93.7045286998213,100.782462779497,0.105053936878311,0.958914368513127 +153,gene_153,65.6596181914196,88.1446820682255,108.751090069883,109.416499440843,109.606589277203,92.016332187132,68.7494752127628,101.875590473504,0.996129945737536,92.9929724425927,93.0619967876506,0.00107044800035373,0.999453122312829 +154,gene_154,120.602332494777,119.930816932934,111.494464299049,103.819504245916,114.109120940768,128.619449316636,90.6293526992087,110.43177678376,0.746862282431336,113.961779493169,110.947424935093,-0.0386738710855085,0.97704151387307 +155,gene_155,77.0576232700333,121.685133886067,79.7677543061878,108.257821665639,87.1877034714384,126.424160015696,104.069217339544,96.5723360071783,0.63633204055098,96.6920832819817,103.563354208464,0.099043918901692,0.976960798897723 +156,gene_156,94.6774095832591,111.692001863768,124.509444426719,133.887504541258,105.72025661833,71.9835430793697,73.1996187998241,85.8617521585697,0.0326454096430175,116.191590103751,84.1912926640235,-0.464762712958877,0.28094912234625 +157,gene_157,76.6551677430633,96.707389400087,116.254093597913,106.216635218896,100.737450913208,110.346841307339,106.357901997412,97.0766158648848,0.630721143539877,98.9583214899899,103.629702520711,0.0665446350421587,0.976960798897723 +158,gene_158,95.7583506666997,48.0988673502692,74.9355845310977,102.79565774443,80.388105230825,81.0626360324545,89.5064492264611,66.1120236896479,0.936023386562291,80.3971150731241,79.2673035448471,-0.0204178327181934,0.99139661091521 +159,gene_159,65.5637093303963,109.287339365873,88.0414076119705,114.21904160135,110.919946693834,117.734426932555,135.512698932519,112.512445572797,0.109676807615314,94.2778744773973,119.169879532926,0.33802849923273,0.623163679632469 +160,gene_160,71.2345070026589,103.711089805363,141.553364237708,72.1503203405687,105.048781663614,99.5435264380336,124.844171759214,70.9124227643625,0.889187708399832,97.1623203465747,100.087225656306,0.0427890030188021,0.988530250143975 +161,gene_161,116.691195762314,91.5723319315343,80.8608979402654,78.9371911668614,94.9044183859686,50.1281540166605,71.7903703354027,69.6131200430309,0.157289973187541,92.0154042002437,71.6090156952657,-0.361734164767661,0.711320181265988 +162,gene_162,109.455173035627,103.558434203248,118.118113364096,113.778757107886,111.900664604164,34.5103831198698,89.6697197153861,89.1459636606075,0.166187041832739,111.227619427714,81.3066827750068,-0.452069234042643,0.726177314590369 +163,gene_163,108.626152118746,89.643555990741,91.788341300948,117.0394564031,94.8001137840945,99.9423423929583,64.0777297571135,110.817949984053,0.469498615453071,101.774376453384,92.4095339795549,-0.139260773813811,0.958914368513127 +164,gene_164,109.42921818811,78.4084562775695,127.376812074666,95.3520526242829,128.001039404208,53.0746032677201,107.052826720226,90.1929715863381,0.68776381711782,102.641634791157,94.5803602446232,-0.11800351181623,0.976960798897723 +165,gene_165,134.737813682765,91.5855488150733,105.965960252296,90.8845181979659,39.2051806811544,34.4976947258168,39.9660180239429,32.5360857962189,0.0057308024162407,105.793460237025,36.5512448067833,-1.5332580028584,0.085534364421503 +166,gene_166,118.096532012133,111.084270888736,111.029703642045,101.236696273219,84.0104266146036,97.1105203797447,84.4451752088753,97.3872114831784,0.0086908241717297,110.361800704033,90.7383334216005,-0.282456834278041,0.111420822714483 +167,gene_167,105.806634851169,126.655247312762,87.9337048629439,126.829003259753,108.071129718872,91.5300153723299,129.560779216169,70.7799133875548,0.47916974533627,111.806147571657,99.9854594237317,-0.161209307221225,0.958914368513127 +168,gene_168,82.5220657713221,89.1287131852447,50.4409326105603,122.530598457649,118.045054986744,106.306955770377,118.835744810514,89.0901080420847,0.246597217374522,86.1555775061939,108.06946590243,0.326942858362988,0.830293661193678 +169,gene_169,85.6502701544983,99.7749947084446,100.408600021179,81.481922270554,115.524901054175,87.7732048378019,45.0723681924358,72.7025824100822,0.500582436073319,91.828946788669,80.2682641236238,-0.194119300705843,0.958914368513127 +170,gene_170,96.4466120807863,71.0659792929556,80.6232107496798,114.2968671375,135.469216949964,139.06788655526,74.8283086903465,111.16666032745,0.220373368115189,90.6081673152304,115.133018130755,0.345588628343301,0.798454232301409 +171,gene_171,120.68034239475,110.24481557304,98.5589832832087,79.0277316019114,108.300542052917,94.2946207211709,103.781121045031,98.7459760096639,0.933068042083835,102.127968213228,101.280564957196,-0.0120206515314802,0.99139661091521 +172,gene_172,61.8412027230863,112.424123831688,104.989225290585,117.132793809993,92.0412627158836,126.35445085903,118.422257665249,86.7183873929396,0.686625932518509,99.096836413838,105.884089658276,0.0955749171653971,0.976960798897723 +173,gene_173,115.946539269348,81.3032537404935,104.737158679709,90.2696621968626,104.911008310893,99.7081206654253,102.299122088236,98.7428361548899,0.69459946107679,98.0641534716032,101.415271804861,0.0484771467266001,0.976960798897723 +174,gene_174,98.1029812541329,89.0345130089796,115.792148889516,86.5778356392601,112.328329540088,95.6237631870707,91.7555322546169,115.362998945957,0.498674881984367,97.3768696979722,103.767655981933,0.0917058015113136,0.958914368513127 +175,gene_175,104.112302375315,88.1070674487924,122.599874661462,139.049313555673,109.266132432104,114.125739888075,123.361444637845,127.139392714796,0.694251364900353,113.467139510311,118.473177418205,0.0622859184802162,0.976960798897723 +176,gene_176,117.677857584334,127.517909155621,87.5416305876023,83.1232816640197,102.912248272218,84.6458054685344,108.039934764467,132.518917032115,0.842528363072847,103.965169747894,107.029226384334,0.0419045261683018,0.97704151387307 +177,gene_177,65.9373561164165,129.46742708465,75.9716484107825,108.80195352256,117.099247275998,113.980788809764,113.361296945953,81.4266545046705,0.530595531635982,95.0445962836022,106.466996884096,0.16372977612833,0.972014394251591 +178,gene_178,102.71559883176,123.330900845701,127.272442499492,85.7565474944467,85.1612931380484,142.148740423087,123.07391761904,117.63734928143,0.653102536739061,109.76887241785,117.005325115401,0.0921051891114221,0.976960798897723 +179,gene_179,123.580042222074,106.326790283243,104.442210851339,81.1983195037748,94.096281248198,93.8151464099788,116.697584778718,104.001718547871,0.872144117256017,103.886840715108,102.152682746191,-0.0242858276831543,0.982144276189208 +180,gene_180,107.685817482839,108.923233169766,86.9159335788677,80.8640320322774,104.869523466833,92.7926885857455,84.6613725444166,109.598980541505,0.843857807366794,96.0972540659375,97.980641284625,0.02800152685789,0.97704151387307 +181,gene_181,100.714761295496,93.1608707699126,118.80749342559,91.7253170253189,81.5861320223811,86.6402276155102,90.6874058075913,100.283666443247,0.184984802104634,101.102110629079,89.7993579721823,-0.171036080112276,0.755040008590345 +182,gene_182,118.686711209778,108.690979785134,80.3032327113291,94.5810006485531,103.163256869633,147.739893422687,114.567137262172,125.605916943039,0.130842962450612,100.565481088699,122.769051124383,0.287811729482168,0.667566134952104 +183,gene_183,97.6127370386981,112.665715621582,127.354778293824,90.1340158028232,106.812789445906,58.60014990799,99.7188346084086,94.0638820661919,0.255159777688628,106.941811689232,89.7989140071242,-0.252056119794899,0.840151238724476 +184,gene_184,77.4463253666816,56.2257440420205,101.87173260993,89.3537804449056,103.648749842334,143.097979840225,94.8832446622317,117.820977706164,0.0574751774421796,81.2243956158844,114.862738012739,0.499925848409617,0.415578439340486 +185,gene_185,108.350560519553,99.5443781569975,94.0063252666142,83.0107071779635,30.3351978183611,30.3007704331425,33.0436659053997,37.2045132802392,0.000619510277697411,96.2279927802821,32.7210368592856,-1.55623817098749,0.0258129282373921 +186,gene_186,101.029376912397,98.7968401788811,112.374974916148,108.997874737921,105.308312931391,91.407229876137,122.108466599643,87.3303275429796,0.680978147444436,105.299766686337,101.538584237538,-0.0524741900928532,0.976960798897723 +187,gene_187,98.2437937025373,94.1694683208219,64.8087710790454,111.438836554141,82.5021216483882,124.819474549867,71.979582785015,137.323997558414,0.549392961394952,92.1652174141364,104.156294135421,0.176455729416367,0.976220965232151 +188,gene_188,102.092042750707,86.3616369648586,80.0266284849233,96.7641444426539,66.2733155480368,53.9280925109214,102.422531542106,93.3284935281633,0.374774183783297,91.3111131607857,78.9881082823068,-0.209154985494799,0.919758854682739 +189,gene_189,79.8073834040545,108.826016348239,86.6601375111318,75.2532208415023,65.0111962352221,122.138821301625,122.50382142977,100.401026447352,0.382499318343061,87.6366895262318,102.513716353492,0.226210062798245,0.919758854682739 +190,gene_190,94.3266718486437,76.489945290225,81.7775064304928,102.459730607684,104.625331368916,96.6386968095707,90.8761288465564,105.519158224606,0.182344547247793,88.7634635442614,99.4148288124123,0.163495099136966,0.755040008590345 +191,gene_191,122.599202202549,117.720249414158,86.7622164740247,118.787625479474,107.560810926458,114.937536757518,88.9916280483682,94.0234150017054,0.365856989688921,111.467323392551,101.378347683512,-0.136871291124179,0.919758854682739 +192,gene_192,99.1823051612592,132.824955712894,95.9613537452118,120.560804488576,83.5944079359077,115.161500506346,60.4844875009344,84.4491437078043,0.11835398628334,112.132354776985,85.922384912748,-0.384096671527285,0.639751277207245 +193,gene_193,126.736635773763,87.1044666985254,108.700435804097,60.5319901126028,82.0818157164869,118.859894347851,108.751243775167,105.718070095107,0.64155003625973,95.768382097247,103.852755983653,0.116918167741286,0.976960798897723 +194,gene_194,108.033701572302,101.85859873649,98.6059533721187,89.482320607704,36.0102029877519,35.9181603427691,37.2235101889646,43.006104596449,0.0001107264341607,99.4951435721536,38.0394945289837,-1.38712803270628,0.0123029371289667 +195,gene_195,86.0489588257614,113.418188325749,75.2222590403204,72.9983047007472,115.815474595827,123.019809081546,91.0148562379398,72.7804922123198,0.391174433095139,86.9219277231445,100.657658031908,0.211664861077936,0.919758854682739 +196,gene_196,54.7500455365125,86.5428903737483,123.455468835469,111.007744803156,93.760189398953,77.0060894508173,144.619805656149,57.9561914560567,0.980773026132835,93.9390373872214,93.3355689904941,-0.00929783160211803,0.997693106634484 +197,gene_197,115.751352309683,113.574123439201,98.8208860977493,78.0749048507785,104.816544847251,135.292748236113,85.0765245854841,94.6891929354345,0.814869761031059,101.555316674353,104.968752651071,0.0476941565980427,0.97704151387307 +198,gene_198,90.970513150998,98.1995628183362,123.188860019574,81.3199877009195,78.0434248781934,99.4880546815435,123.132260303702,76.595119424693,0.78163831207458,98.4197309224569,94.3147148220331,-0.0614646968772174,0.97704151387307 +199,gene_199,88.7790014179197,87.2329383382096,92.3104296635963,106.015637538062,97.8542941905883,128.787126871324,107.189258105353,98.5275125666423,0.145953502183483,93.584501739447,108.089547933477,0.207885489659115,0.697243081366878 +200,gene_200,112.462217464466,88.8961398872511,81.3386280768975,108.345915643711,91.9384537942939,116.529672024198,121.931756445243,100.31519057923,0.370652055134826,97.7607252680813,107.678768210741,0.139406918085332,0.919758854682739 +201,gene_201,128.442275809101,98.7978547690006,125.653734405337,120.656163990063,97.3885945731332,77.269001769952,123.298693839578,83.3651657149265,0.116296672932223,118.387507243375,95.3303639743974,-0.312509139856689,0.635776626193898 +202,gene_202,84.8310922122087,116.278258334134,83.8103204286928,101.669044477209,146.852407769409,116.212144697869,109.467504724776,149.946923257888,0.0422823759437248,96.6471788630611,130.619745112486,0.434573472321023,0.327770356152906 +203,gene_203,98.8931417160233,153.041549152301,101.667383877373,77.0774510414612,93.8318465777322,109.533203988966,81.1436316432497,124.202671101259,0.780264354218908,107.66988144679,102.177838327802,-0.0755324209180671,0.97704151387307 +204,gene_204,90.390826448113,98.7769494011785,85.8679893992895,102.383223761956,59.0385167622351,126.024163691037,111.59589096739,101.548132336465,0.74763069273088,94.3547472526342,99.551675939282,0.0773504980344338,0.97704151387307 +205,gene_205,81.5896695102481,121.323754646775,116.199192317039,104.266036585796,114.884046520448,78.0499078907698,97.0060470199558,83.1095044659321,0.338248428821967,105.844663264964,93.2623764742765,-0.182581432420919,0.919758854682739 +206,gene_206,87.0474252977705,78.9925479512792,70.2567871799235,74.6322726225725,100.839293387308,95.0486422618427,108.037457648778,106.493375418972,0.0019368008675726,77.7322582628864,102.604692179225,0.400511372970462,0.0538000240992388 +207,gene_207,110.358660360946,107.403978482885,105.46304312928,88.7453895730114,103.833307552259,88.2955922661742,144.96653467565,123.794714236038,0.408201265913878,102.992767886531,115.22253718253,0.161879895740895,0.930988787286778 +208,gene_208,129.567217222473,100.830723675888,114.548486390305,95.8552481411869,128.245598690822,116.251908187163,132.822970563251,71.4404662012138,0.905900055006226,110.200418857463,112.190235910613,0.0258174140183843,0.989971080047645 +209,gene_209,50.866318736113,70.7631529010777,141.452092060569,132.436889703602,99.8810182833605,141.906411643458,84.7090281151816,95.4985975735573,0.807592759862063,98.8796133503403,105.498763903889,0.0934810884384716,0.97704151387307 +210,gene_210,71.0109602437269,99.0040528062748,83.5848363909692,129.071909549445,84.0399658545445,129.712705120318,85.0358534547437,105.100049523645,0.758921920807461,95.667939747604,100.972143488313,0.0778498979686953,0.97704151387307 +211,gene_211,92.0039059527614,82.7865605819515,80.9129624205048,87.4144136596594,86.1628001500879,79.9419237480924,82.0938628201653,93.3949873440754,0.92477030631419,85.7794606537193,85.3983935156053,-0.00642331429183901,0.989992953448256 +212,gene_212,110.334462555183,115.790964051421,127.334362774381,131.231552385641,74.7506294650706,119.824266150868,121.664220804747,87.9750473728508,0.187178493449664,121.172835441657,101.053540948384,-0.261946436202821,0.757207212115658 +213,gene_213,94.1492663788822,125.229014946529,113.82237154555,90.55974735226,92.0017038584675,88.6721692940165,106.028759743617,100.57543990934,0.36993775380155,105.940100055805,96.8195182013604,-0.129878956200699,0.919758854682739 +214,gene_214,126.880729230326,78.8304596833866,99.4941682981482,87.4805278518064,121.868899697581,59.2328581535737,110.456908497358,86.3452841911999,0.83925040563035,98.1714712659167,94.4759876349282,-0.0553561414924444,0.97704151387307 +215,gene_215,105.062586774602,107.559678253224,95.3723007088679,129.792995030954,88.0708216576224,127.752559194573,107.266692154644,110.127161615142,0.920004196522794,109.446890191912,108.304308655496,-0.0151403239458762,0.989971080047645 +216,gene_216,80.9245920007938,84.5249921171057,118.432153829801,94.2863847542656,106.368065973112,81.9615951657538,113.466169309158,125.620799053527,0.36262415996622,94.5420306754916,106.854157375388,0.176615282136047,0.919758854682739 +217,gene_217,79.9221117328587,88.7100148485969,121.671521557794,84.956511271271,83.8459459090621,65.267736551552,68.0569126352634,91.3201444743479,0.198768352388283,93.8150398526301,77.1226848925564,-0.282663947946402,0.760743228338604 +218,gene_218,111.01994740892,105.322481386837,72.8819482642176,119.89357611324,115.691544076463,75.4900049851159,103.238638797125,110.189620382153,0.936650716711541,102.279488293304,101.152452060214,-0.0159855548453667,0.99139661091521 +219,gene_219,106.647374985299,107.351635027169,95.0432625143086,124.00842514457,106.566751269781,84.4794471958843,73.1001492047347,84.2902965555798,0.062291999029216,108.262674417837,87.1091610564949,-0.313639575958259,0.432583326591778 +220,gene_220,102.914056738307,95.8926849971482,156.759842664333,96.4515688344042,93.4502116222714,89.1521645971003,111.068994030238,97.4555360226705,0.384818993237793,113.004538308548,97.78172656807,-0.208743928144821,0.919758854682739 +221,gene_221,91.5659761027175,79.7782493498692,122.937869438373,112.263990816882,124.577700583498,105.143016017506,104.036833431073,123.981395398162,0.310811541595134,101.63652142696,114.43473635756,0.171106140593454,0.9106092231063 +222,gene_222,100.083706192141,47.5371379439445,81.1105507218375,123.011336871402,77.1419103288604,99.8532014571405,112.966100912212,93.7433166203882,0.672196626335477,87.9356829323312,95.9261323296502,0.125475182379591,0.976960798897723 +223,gene_223,85.9321656592053,99.1360944769852,76.8290284437827,69.7307060085486,77.061950355297,85.7884271588844,110.314491743833,84.0085581508806,0.53262592856275,82.9069986471305,89.2933568522237,0.107058954436009,0.972014394251591 +224,gene_224,128.975803003886,86.985554795594,107.395698978579,86.1684080863453,102.615084345187,99.4654165983341,86.5464076627007,76.3172181793789,0.389475537378623,102.381366216101,91.2360316964002,-0.166277560218036,0.919758854682739 +225,gene_225,73.5387918219484,98.6922541376479,105.103850182382,90.9688043204177,108.976201195915,147.905951521791,64.9624896459766,82.1427659422063,0.669124473413133,92.0759251155991,100.996852076472,0.133414434474058,0.976960798897723 +226,gene_226,90.7872389148026,110.481948373081,103.244746793234,118.070613536731,116.556540947304,99.4979842670768,103.177231579326,94.2112610815635,0.771593175241126,105.646136904462,103.360754468818,-0.0315515081655437,0.97704151387307 +227,gene_227,90.1465403905551,64.5488001029643,99.6950495344355,78.2093540340636,94.2552379244819,125.446218272893,126.654209472576,89.6294090849714,0.0868047389890629,83.1499360155046,108.99626868873,0.390491689051222,0.535831722154709 +228,gene_228,140.557558429761,70.1032827469041,109.162112231209,99.7284954624546,268.341287006005,267.365480022467,329.960539988143,362.836629400943,0.00077424139005181,104.887862217582,307.125984104389,1.54998283861424,0.0286756070389559 +229,gene_229,78.1900677949977,96.6097447012537,78.8063932991807,92.4989857666584,89.02200519669,94.3891764918275,85.4542590347975,96.7935954234095,0.407132021202429,86.5262978905226,91.4147590366811,0.0792884322442459,0.930988787286778 +230,gene_230,114.513404319347,123.865324718567,124.785291692258,119.199771579286,27.2573070662201,38.2148607216885,27.7186448827988,25.4424420899858,4.88531911289199e-07,120.590948077364,29.6583136901733,-2.02361314162529,0.000315461514246758 +231,gene_231,101.032653707652,86.4603984307877,94.9602655906435,64.6630163912898,83.2181238536914,121.977074372341,100.322056805229,87.5474271614814,0.367687686480835,86.7790835300933,98.2661705481858,0.179347484853606,0.919758854682739 +232,gene_232,90.8937273168449,87.4378964349203,72.5778952759873,140.645164840971,358.935007498701,218.957705255935,305.712586114578,315.326408190979,0.00251215726992137,97.8886709671809,299.732926765048,1.61446377196618,0.0553552260973115 +233,gene_233,109.730006196825,99.8033452988637,120.513739462031,107.261570327076,87.0056302686334,86.6517852581034,87.1915726314515,95.3422239935557,0.010908342114878,109.327165321199,89.047803037936,-0.295999999436328,0.131084238902199 +234,gene_234,102.125906956094,93.6763530366414,96.9829522921814,122.196134392216,102.294674396469,96.1948021601699,86.4119038154946,135.334922962164,0.919709856934247,103.745336669283,105.059075833574,0.0181543097151132,0.989971080047645 +235,gene_235,100.715653812386,81.5408538481364,113.915609886455,68.5909765528498,110.088534419536,93.5024716829781,99.4827522060723,108.613798743856,0.339361046996532,91.1907735249567,102.921889263111,0.174590076658997,0.919758854682739 +236,gene_236,88.1661332486854,101.345451282565,91.88678435498,115.92649849561,94.7687731198699,110.600438458537,109.709199718758,82.5871825258349,0.99284262312418,99.3312168454602,99.4163984557499,0.00123665478026814,0.999453122312829 +237,gene_237,117.973557877443,55.8614238369149,97.3550269871894,75.7491471042509,105.714372265538,86.7747954395451,110.74331148581,105.935082768329,0.342991149181771,86.7347889514495,102.291890489806,0.238009102019809,0.919758854682739 +238,gene_238,100.788006127395,111.768224663922,111.008091179491,100.631771485966,82.282066508581,99.8929618924123,91.0772340662928,126.011275693293,0.567630586431086,106.049023364194,99.8158845401448,-0.0873900076125968,0.976960798897723 +239,gene_239,97.8482414092493,118.722098043101,61.8586711419476,103.060822228408,101.385654897524,89.4049855385388,98.7683618884295,119.087402032478,0.639301350832539,95.3724582056763,102.161601089243,0.0992084324658804,0.976960798897723 +240,gene_240,122.899446513536,120.6760607746,74.7953296847454,71.6398368475627,71.7929087422018,104.66223234787,102.235284852634,103.466749433853,0.908101017404067,97.502668455111,95.5392938441396,-0.0293474895982829,0.989971080047645 +241,gene_241,39.3759025034755,93.2093528322306,102.820019019475,113.074005822246,127.171718283474,91.8937175505816,106.077676640868,54.8976026590756,0.736578604044292,87.1198200443567,95.0101787835,0.125081108840891,0.97704151387307 +242,gene_242,103.685574482882,99.6912674749419,83.3473989203361,116.277452715709,110.183952222279,96.7545880420154,86.0744853857359,125.802319812911,0.731100637288033,100.750423398467,104.703836365735,0.0555284022024324,0.97704151387307 +243,gene_243,95.6747691467502,98.5228843634064,117.271904551376,107.975811675502,80.2104756655274,75.087030474975,121.984620631201,109.888057004804,0.549612403425701,104.861342434259,96.7925459441268,-0.115515066435668,0.976220965232151 +244,gene_244,123.298238095075,108.041148735998,92.2123129959697,74.0607338061429,115.517725696304,82.009545237725,99.3495558697566,93.9287229140611,0.898048027756092,99.4031084082963,97.7013874294616,-0.0249119169889581,0.989971080047645 +245,gene_245,90.9817018336645,101.832722099569,126.019938997879,126.867646791748,82.3985920464733,80.1057258302865,88.0504330691534,97.4770083285151,0.0652172647738213,111.425502430715,87.0079398186071,-0.356860502537824,0.437699763582693 +246,gene_246,94.921884957943,80.5613119409146,29.2354680341013,91.0767912858011,114.274061318033,78.3706865860854,75.3549280915039,67.5853548158199,0.610979836394185,73.94886405469,83.8962577028605,0.182078472961827,0.976960798897723 +247,gene_247,92.6190210206697,87.2391485140135,96.217041848395,107.996050736598,77.0521542297824,119.104276998629,93.1217667226301,105.878844513806,0.794292742947043,96.0178155299189,98.7892606162119,0.0410521008241482,0.97704151387307 +248,gene_248,107.577383987025,114.15581352414,97.4928640083471,74.2186784405658,71.7274122968693,98.6963746025056,103.100534788537,71.2333719687363,0.357868711474843,98.3611849900194,86.1894234141621,-0.190578273314948,0.919758854682739 +249,gene_249,70.4209731037007,132.937483420168,96.8028622039204,86.6738794051014,98.8552515150117,69.9285268442742,93.08645868643,125.078444939891,0.998754994542286,96.7087995332226,96.7371704964016,0.000423173955712542,0.999453122312829 +250,gene_250,86.5740490204732,91.9956005212099,121.451588317792,121.243431576419,83.8959949482574,123.717415345865,97.5182037523334,95.7379808196562,0.698683288611677,105.316167358973,100.217398716528,-0.0715939290474249,0.976960798897723 +251,gene_251,88.7249998034324,113.688950061797,137.101844915796,99.6880164384999,95.8356931912537,99.727285891262,103.716365222814,97.7343840019552,0.388620206138472,109.800952804881,99.2534320768212,-0.145701678405086,0.919758854682739 +252,gene_252,66.2859603318806,81.6725207525604,109.266603366863,105.014957736745,61.8982909804566,145.478019701127,97.1350228454842,118.390238563671,0.490839965439974,90.5600105470121,105.725393022685,0.223375892134095,0.958914368513127 +253,gene_253,110.245451843448,122.407368624884,90.5733308125466,114.608560765936,104.399271286778,74.3684254458563,123.822541225422,78.2586919591927,0.340159923750341,109.458678011704,95.2122324793122,-0.201167495470834,0.919758854682739 +254,gene_254,95.6473470384128,83.018154019298,144.775282834171,92.9396990403518,77.2381392743494,81.3556714871431,128.474883862903,108.237833662331,0.783684771676871,104.095120733058,98.8266320716816,-0.0749306658201285,0.97704151387307 +255,gene_255,132.677697180531,92.6571793108934,118.446959819021,64.6779053580692,102.422982693882,115.033054753267,102.942093053054,91.8941950126446,0.954596219338312,102.114935417129,103.073081378212,0.0134737154284778,0.992641973777354 +256,gene_256,91.4104368529152,103.632626133034,103.048352539822,118.987408302352,340.636702488724,340.973783751153,217.699213970002,423.796112364113,0.0120791696244646,104.269705957031,330.776453143498,1.66553647286229,0.13884103016626 +257,gene_257,134.469409536313,131.861187018847,114.158500167029,100.473721932589,113.729250089746,76.3601408979002,78.4279442157731,87.9656697033568,0.0379894233000251,120.240704663695,89.1207512266941,-0.432092070452836,0.303915386400201 +258,gene_258,141.363327122033,90.9358583858906,122.70004205518,119.172101395021,86.0478071509443,107.707859650557,104.386457082622,77.1333188611437,0.10560019030738,118.542832239531,93.8188606863167,-0.33745854576121,0.610405724320116 +259,gene_259,50.7014820634126,55.7196566090802,119.703266621287,94.1796534928682,100.637500937026,109.702630203724,91.7863506364728,82.0105381350207,0.414729870208059,80.0760146966621,96.0342549780608,0.26217892586639,0.930988787286778 +260,gene_260,96.7599364718789,106.590761636163,96.1706631414074,147.525764883485,87.2883339352482,94.7833791480016,133.860417848079,127.448110910506,0.958291574744354,111.761781533234,110.845060460459,-0.0118824417984872,0.992641973777354 +261,gene_261,95.2165139498538,72.341100734721,113.087920694835,120.171147967937,71.3462550739188,62.6204369798193,113.07205737094,112.565612473091,0.569708948946678,100.204170836837,89.9010904744423,-0.156532039199265,0.976960798897723 +262,gene_262,124.190137610641,101.663085009613,74.8859422724876,66.1522938288373,96.8710238007378,101.868582215908,101.3603116935,109.01191520539,0.485850011094943,91.7228646803946,102.277958228884,0.1571419466528,0.958914368513127 +263,gene_263,103.65746892872,132.187084195258,119.096256155491,122.730493646482,237.296602877285,233.165204658763,407.153619983635,284.63062133911,0.0230745367732805,119.417825731488,290.561512214698,1.28282540962756,0.213653118271116 +264,gene_264,119.316352732406,101.271379698854,89.1155420688264,96.7295960994351,155.448889055772,95.0117735277137,76.1592896352399,101.235648290078,0.783632110137218,101.60821764988,106.963900127201,0.0741068891764602,0.97704151387307 +265,gene_265,122.335450807238,56.9038677494332,80.8908459737276,105.498837040031,39.8045742635844,28.7954252544815,33.6981990840601,38.5385415002906,0.0274395761658931,91.4072503926073,35.2091850256041,-1.37635676986928,0.246025519246968 +266,gene_266,67.4922890240187,97.1644478489008,80.5087316523578,97.2931051840896,108.025316245737,129.83070528029,108.346534802807,130.471535959316,0.0132735972263558,85.6146434273417,119.168523072037,0.477073735928236,0.144559694388795 +267,gene_267,84.5212607993384,78.5219583891565,91.624065028111,126.48107310078,74.4661511945239,122.736231031569,76.3315950820751,126.446124775679,0.80114755045126,95.2870893293464,99.9950255209619,0.0695755732894779,0.97704151387307 +268,gene_268,95.4490723744007,82.122735328207,101.841540049541,110.269377507282,85.629208083349,71.3770884435246,113.344784311856,86.3273133313692,0.469154119341337,97.4206813148576,89.1695985425247,-0.127676150810186,0.958914368513127 +269,gene_269,104.335022144034,75.2516159256337,133.172448060907,114.461468372677,134.483796891685,110.653069144944,97.3831934812816,86.2491305288095,0.981422387415434,106.805138625813,107.19229751168,0.00522018229901351,0.997693106634484 +270,gene_270,101.282999598403,105.195171678527,92.8443054147393,141.033191093183,87.6009971784332,111.087262924661,92.2561157813934,142.444832825245,0.918824981143937,110.088916946213,108.347302177433,-0.0230060037194824,0.989971080047645 +271,gene_271,68.9158783852588,121.897242698377,90.1961819800682,119.396769456039,96.390895411676,58.6318572616511,91.0383994968622,90.2586860965171,0.340128129348868,100.101518129936,84.0799595666766,-0.251629973479821,0.919758854682739 +272,gene_272,129.239907130228,114.287288328966,96.4948885420403,67.8659647576089,84.097377070198,99.8613313236755,85.1038951115596,136.767427201853,0.978180087122093,101.972012189711,101.457507676822,-0.00729761041989065,0.997693106634484 +273,gene_273,99.9273052875627,91.6563824219333,113.805698070291,139.489562820664,123.96619571072,89.9900757712622,77.7450073142585,46.6197430452905,0.220321761300757,111.219737150113,84.5802554603828,-0.395020009779789,0.798454232301409 +274,gene_274,78.9936549049036,79.3446444354733,107.233989253479,83.089914987238,95.5109916488503,102.25757222154,107.110873867327,68.7754221498618,0.588246714979305,87.1655508952736,93.4137149718948,0.0998763081186969,0.976960798897723 +275,gene_275,128.369042280763,95.2673741829416,104.168446989681,82.4027223760374,115.339340636767,91.7263039571024,118.509573533074,72.8058119392818,0.844945313927765,102.551896457356,99.5952575165563,-0.0422052199137316,0.97704151387307 +276,gene_276,87.2911204621954,92.7052660686029,99.0904499484187,129.721989108808,108.315097425997,129.787560450631,79.53258799722,119.751021592113,0.638236451948178,102.202206397006,109.346566866491,0.0974815827737292,0.976960798897723 +277,gene_277,133.891725643838,94.2986546779436,99.9416799061957,98.1256597959083,132.053480850958,106.271020714818,116.169295373779,91.8025670979626,0.702323993772633,106.564430005971,111.574091009379,0.0662760897850824,0.97704151387307 +278,gene_278,115.260045106605,123.442708952227,122.965107256213,95.2611302223722,94.2773805748005,106.926814697541,123.714397046368,107.499500205392,0.518772673365602,114.232247884354,108.104523131025,-0.0795430953338861,0.958914368513127 +279,gene_279,95.4688365195168,75.9473493913795,118.378560184394,81.2870384727907,251.01468223268,268.559505573991,296.833064072482,344.995795769968,0.000733959534186,92.7704461420201,290.35076191228,1.64605963517941,0.0282292128533077 +280,gene_280,69.2740098838956,110.00873792702,98.9740968784416,108.16581361249,58.4299559755374,100.123186931253,113.951704119891,89.3955312665064,0.699601754189097,96.6056645754619,90.4750945732971,-0.0945870748503835,0.976960798897723 +281,gene_281,114.963225070259,94.5105512204194,95.4716843960086,93.5123496893984,39.3287322102196,34.0790039816235,47.6924376404825,35.7496719974434,0.000187059622737303,99.6144525940214,39.2124614574422,-1.34504286531894,0.0129272899548559 +282,gene_282,75.7417000774846,81.0205899324743,118.972868589599,101.60826103131,103.694812127254,69.5038009311701,97.5425715968186,73.6464389610437,0.552584498462024,94.3358549077169,86.0969059040715,-0.131844818729667,0.976960798897723 +283,gene_283,121.956738312398,78.6336346361301,78.4111463545063,86.7034773680198,135.772807963961,72.1909220156781,118.263814394185,82.0476759480488,0.582770077971904,91.4262491677636,102.068805080468,0.158861669388079,0.976960798897723 +284,gene_284,109.835401710283,99.2089713769733,113.051488239476,108.302163031535,104.46516134457,122.762957116841,76.565008169652,81.0158641195741,0.37341280625171,107.599506089567,96.2022476876593,-0.161528948650914,0.919758854682739 +285,gene_285,123.454742489419,105.226888458699,95.7904224962022,151.250760545696,118.284987698594,121.428716885477,114.009150849805,90.9953964695179,0.605459646214075,118.930703497504,111.179562975848,-0.0972295972598105,0.976960798897723 +286,gene_286,78.1442813898083,104.27399739925,132.480866780995,84.3961852209227,144.937246247131,76.8039763960592,105.601981667802,129.29655755364,0.485215577422491,99.8238326977439,114.159940466158,0.193600285830385,0.958914368513127 +287,gene_287,86.3006512293565,130.806363188511,99.5154406663047,82.3957811731533,104.572190308719,129.781540896918,107.94242926232,92.4979146172087,0.533430198474842,99.7545590643313,108.698518771291,0.123877597792135,0.972014394251591 +288,gene_288,90.8465233489305,75.7789630329413,99.9921511532698,103.809967952294,61.1108636484867,55.128456996709,96.3398548685559,98.8671413083906,0.313930403530766,92.6069013718589,77.8615792055356,-0.250208105849189,0.911686915669735 +289,gene_289,88.2223123049515,98.144870027207,135.969293923881,93.0114824398829,16.0169167101688,43.531169825391,40.4207670096531,33.3148541144652,0.00290609044264125,103.836989673981,33.3209269149195,-1.63982002507471,0.058121808852825 +290,gene_290,114.297895408094,77.2670871581363,124.084775619283,104.190304131133,60.7762483455581,97.2621597710115,91.7726838692493,92.381796758315,0.190347293616452,104.960015579162,85.5482221860335,-0.295030060327136,0.757207212115658 +291,gene_291,96.8384931494654,109.363987373857,112.192158529607,101.866602883725,99.545798961653,116.366607712333,104.013803655361,57.0107583890227,0.470311370080355,105.065310484163,94.2342421795926,-0.156963115242651,0.958914368513127 +292,gene_292,79.8192912277155,90.6306710972087,98.676656201989,80.2515977837473,89.1372358019425,112.62012232293,91.5742235139785,83.8741386789111,0.408487323799725,87.3445540776651,94.3014300794406,0.1105618954242,0.930988787286778 +293,gene_293,91.2148742121269,114.626793197215,132.926436728369,110.455252331093,112.500248621608,69.8904097835019,131.817871669344,110.503008693257,0.709682588900894,112.305839117201,106.177884691928,-0.0809496346763545,0.97704151387307 +294,gene_294,81.9394085227097,62.0375222273797,114.818229929755,108.343962299925,92.1851355829689,95.1114433292133,93.9941953074529,86.9844689401403,0.983017052023059,91.7847807449424,92.0688107899439,0.00445755842956224,0.997693106634484 +295,gene_295,98.6551916416091,100.580084459179,80.34370443403,106.99140206677,123.47018318429,103.080347531162,100.994284944355,110.957103987957,0.141457840329131,96.6425956503972,109.625479911941,0.181852049877684,0.690038245507954 +296,gene_296,88.3320777163168,92.1984982277639,108.972182001658,90.826428877133,93.2900137185068,78.1783048377441,80.9447540195317,107.331946572114,0.553766244554161,95.0822967057178,89.936254786974,-0.0802739447440827,0.976960798897723 +297,gene_297,99.6669459375292,129.935098110147,73.1409443103205,95.1198559595721,105.014448967368,117.186226760689,53.8442900138409,73.2572756190476,0.539765071358816,99.4657110793922,87.3255603402366,-0.187795274598613,0.975593151676992 +298,gene_298,110.173087108655,149.164095024015,122.085161327314,116.756753191588,37.2544496446619,31.1250720519664,42.0309555400146,47.1309313527323,0.000828148345083176,124.544774162893,39.3853521473438,-1.66093340794378,0.0295767266101134 +299,gene_299,91.7527060809091,99.9009791186019,73.9876457375939,120.662429179951,98.5626136279216,124.01735151204,116.114376154029,83.8653062497697,0.518598389502882,96.5759400292641,105.63991188594,0.129419283048621,0.958914368513127 +300,gene_300,84.621144308056,110.419102083715,103.917282486518,65.0086215599169,110.473070079492,89.1336574310961,125.140510003102,105.33159491021,0.243806148830965,90.9915376095515,107.519708105975,0.240796843402102,0.826461521460897 +301,gene_301,108.323435936124,78.4387003385762,125.673008514598,41.8756423334935,109.660401272193,78.2312360793407,79.7285187042331,84.140124252779,0.97585926905958,88.5776967806979,87.9400700771365,-0.0104228021987906,0.997693106634484 +302,gene_302,99.1991372263768,96.4886746284118,112.91785953188,106.136861412231,87.3122024464433,99.7110871554205,86.7527744905786,126.83001110326,0.74399591258077,103.685633199725,100.151518798926,-0.0500317067160724,0.97704151387307 +303,gene_303,74.3376586400189,80.4981206339629,75.9400962023378,83.4315170109452,122.073334589098,91.8199513880514,84.5451963476547,114.027993380668,0.066730933207728,78.5518481218162,103.116618926368,0.392559741386194,0.44487288805152 +304,gene_304,114.418228169126,125.218569187881,95.2356988654194,69.7845710926022,107.303260494883,91.3156127194101,122.213994999442,75.2944009179545,0.89731790775468,101.164266828757,99.0318172829223,-0.0307357734744823,0.989971080047645 +305,gene_305,83.1702801515575,128.602883195356,103.765185863755,121.498292846545,69.1708445884385,118.765005757694,97.9461106942652,77.0091849055776,0.26516290137819,109.259160514303,90.7227864864938,-0.26821738590162,0.84773030824189 +306,gene_306,88.5932328632091,100.449561251161,104.708305742844,102.147728888691,104.209424351189,132.213530740475,100.68361028417,78.8635884013849,0.687707392910981,98.9747071864762,103.992538444305,0.0713482182404109,0.976960798897723 +307,gene_307,90.5478203846314,106.896625179304,94.6854886962055,53.8768794682408,89.887968466535,108.594526246967,116.338941158524,97.7845297845781,0.257001352505334,86.5017034320954,103.151491414151,0.253964232189032,0.84262738526339 +308,gene_308,78.7700002183142,95.6058501259716,52.2790472885929,94.5775151756352,110.106734602259,108.891884187692,89.532439717031,103.658411607522,0.10699064375598,80.3081032021285,103.047367528626,0.359690179747207,0.611375107177026 +309,gene_309,101.999646440755,104.359960032418,121.699800057287,122.423033506249,118.930584757533,50.0968617279015,86.8267028747278,105.066869865853,0.234975687694473,112.620610009177,90.2302548065038,-0.319787705390238,0.818289875612779 +310,gene_310,84.3054980746995,96.4831473642067,99.3266073783098,101.173580625795,395.174450398633,276.536205953192,329.685604174355,251.839581782382,0.00590070546472192,95.3222083607528,313.308960577141,1.7167017506894,0.0867750803635576 +311,gene_311,64.2096127954768,68.700939049722,69.9823469640525,95.0488458172997,85.256169002321,122.584509420785,131.861874622864,63.6704449193677,0.203095069687662,74.4854361566377,100.843249491335,0.43708423850284,0.760743228338604 +312,gene_312,71.9175431242405,103.272360581004,126.965889249932,111.104613294841,85.3681877020961,110.547731676967,116.136749668587,112.863993452048,0.838238219092979,103.315101562504,106.229165624925,0.0401287697164129,0.97704151387307 +313,gene_313,116.00221655107,77.8254307274282,81.2381990183161,120.83124968848,106.388210545774,130.87715845382,71.821886851451,136.531403090362,0.529475227526797,98.9742739963236,111.404664735352,0.170684157619827,0.972014394251591 +314,gene_314,106.336712704456,101.905553054693,133.455108772813,111.673466712192,74.6963113566467,73.9493294181408,152.637980897472,98.2835434011904,0.534607916838375,113.342710311038,99.8917912683625,-0.182253573712102,0.972014394251591 +315,gene_315,76.7763871890079,121.636876579181,108.244604205678,85.6628564121514,97.0791519601003,71.6177977895703,92.7191259421124,104.235523243686,0.613661287992435,98.0801810965044,91.4128997338673,-0.101563877242079,0.976960798897723 +316,gene_316,108.428948083106,53.6097084679451,100.949440072222,149.930909625408,99.0023782481926,108.544296348538,113.077024136528,87.1849478362317,0.953818243233262,103.22975156217,101.952161642373,-0.0179664614076082,0.992641973777354 +317,gene_317,88.3661855234779,103.393235353464,104.168484436803,100.782738730987,89.3959096833446,97.281859061302,82.9438535787089,115.880539121852,0.742690100745932,99.1776610111829,96.3755403613018,-0.0413481574854279,0.97704151387307 +318,gene_318,115.303796629188,98.5633017246426,114.70975263868,67.9232115952988,96.6962452655599,69.1480793532264,93.4098764352104,88.1001435745255,0.380325520357426,99.1250156469524,86.8385861571306,-0.190912951316939,0.919758854682739 +319,gene_319,89.7526784526893,129.036992435931,116.656787224782,112.661280132241,34.7050464066906,23.085429281418,23.6775031408688,36.9173682691424,0.000671529524788234,112.026934561411,29.5963367745299,-1.9203551147805,0.0268611809915294 +320,gene_320,94.6332407659669,115.746394013262,78.7765716734642,91.5171759966661,80.9904982609416,126.407663662339,139.86684024339,88.3381321351751,0.440195752682269,95.1683456123397,108.900783575461,0.19446063783679,0.950746766052417 +321,gene_321,88.2782587091338,67.7031822639292,92.8426307429841,124.849297352451,114.586311036997,148.015523031632,145.550636306334,92.5058338854879,0.125035175540242,93.4183422671244,125.164576065113,0.422048560664401,0.652415963636263 +322,gene_322,123.794870875756,96.3234482579193,82.296011170055,75.9858313106036,113.586977465565,104.989995796088,126.287593291783,124.206443373601,0.121015849218218,94.6000404035835,117.267752481759,0.30989363561853,0.647143578707048 +323,gene_323,86.7015885844851,93.292084280129,112.377907146413,144.600157593866,88.2403772466806,110.182743845458,63.6869978783952,104.383426461648,0.332185252338488,109.242934401223,91.6233863580456,-0.253752182024858,0.919758854682739 +324,gene_324,100.333579215844,120.009182314817,67.5231777705592,101.55242091396,78.0791048554114,75.624754899867,47.6177550682572,104.728375720115,0.240115957008283,97.3545900537948,76.5124976359128,-0.347553581976971,0.818289875612779 +325,gene_325,97.8559677647992,151.36689285704,118.851241090328,70.5489677538187,86.3046332730772,115.156757129501,54.0434820247819,67.3269055417855,0.231608670840066,109.655767366496,80.7079444922864,-0.442199095439268,0.815523488873472 +326,gene_326,87.2163717110673,86.9007258402991,120.036044786021,105.812071184688,138.416676899903,108.87387720308,88.5629117493722,81.8921315967587,0.77893393329002,99.9913033805189,104.436399362278,0.0627500951991038,0.97704151387307 +327,gene_327,130.727993159752,117.713960343493,126.720221229249,118.01124652011,36.1630324590738,33.2569854508058,32.4350266461018,42.5635868863094,1.7109881683585e-06,123.293355313151,36.1046578605727,-1.77183817396106,0.000570329389452835 +328,gene_328,126.295650474842,87.0921805010083,152.764470326533,83.0234734356896,93.6859342361047,122.46638868051,103.418542049251,88.589783709542,0.603057134864464,112.293943684518,102.040162168852,-0.138143024519547,0.976960798897723 +329,gene_329,106.877418462348,88.0980599522532,104.716419124911,102.302651808803,78.1142266839584,90.3050714786688,71.1926372810781,94.3387875310135,0.0492145735914061,100.498637337079,83.4876807436797,-0.267540702472302,0.375683767873329 +330,gene_330,116.338356643403,76.6191565999303,111.624773612307,93.7293362106262,82.7356582479048,71.8736800778339,98.937150241816,100.525028196041,0.370815336304854,99.5779057665666,88.517879190899,-0.1698567883795,0.919758854682739 +331,gene_331,121.906573627696,113.044151421659,110.462133768546,102.843892301056,119.274476873739,87.0144446491165,85.8280223428215,83.397298142548,0.120245228829581,112.064187779739,93.8785605020563,-0.255457686033464,0.646479724890223 +332,gene_332,122.375061778165,109.944224628447,117.910581573601,97.2739257948734,330.039398652821,372.300979198347,276.526236189522,255.600937409203,0.00398498147825896,111.875948443772,308.616887862473,1.46391709688577,0.0698916679642577 +333,gene_333,69.3360639340438,110.922403140473,97.0301100728468,117.17901246968,73.5275098558805,127.09531200679,79.4171052539926,94.240984341111,0.763656861104816,98.6168974042607,93.5702278644435,-0.0757852980621458,0.97704151387307 +334,gene_334,109.547305789382,119.390955411226,111.175056335655,108.804706415269,36.4115582504548,31.8628169073885,38.8218833400434,31.5787473778895,6.30923028493515e-07,112.229505987883,34.668751468944,-1.69474423468645,0.000315461514246758 +335,gene_335,120.929829258313,67.9268935813371,94.6736757571281,85.2241059596256,110.597955438753,111.328826841536,103.011271261587,103.978378743862,0.268514762839472,92.188626139101,107.229108071435,0.218035915501064,0.851746318223856 +336,gene_336,120.624401445164,88.4836604412081,104.215966564751,115.766312842452,88.9720572187639,111.903409571373,125.811031442367,119.627445860931,0.70327173496666,107.272585323394,111.578486023358,0.0567774543337189,0.97704151387307 +337,gene_337,127.133571839847,94.1739765613011,111.43502989461,90.908133484301,58.7515739285554,123.917202222932,101.582555643765,86.5838718992262,0.44801413357736,105.912677945015,92.7088009236195,-0.192097086247785,0.958914368513127 +338,gene_338,121.557259400496,66.4973969087104,113.20065144552,113.304884715473,88.277769672682,113.542038917418,102.094675576544,77.7015919742215,0.601350698146613,103.64004811755,95.4040190352164,-0.119459642155873,0.976960798897723 +339,gene_339,87.1261826827209,78.2202803724913,115.283537536813,122.223022752669,83.7091164661946,79.6786414395825,82.4457726007949,77.4990963932619,0.158711544908411,100.713255836174,80.8331567249585,-0.317234488244981,0.711320181265988 +340,gene_340,121.162345474071,134.446564895325,133.312112844299,117.91793321159,121.44068822649,104.997784254862,124.878097223522,139.813668706358,0.656127608857094,126.709739106321,122.782559602808,-0.0454217659116778,0.976960798897723 +341,gene_341,126.35230202815,65.4891681075155,141.964723774597,140.778705700738,109.195242771214,94.1170863272704,110.56105252704,139.261603419735,0.804037634415088,118.64622490275,113.283746261315,-0.0667253166117755,0.97704151387307 +342,gene_342,99.7256389325166,94.1501378916778,100.882747481652,71.6768524781735,67.3897212732847,126.035764568268,104.252516222222,100.975780007589,0.588575185794073,91.6088441960051,99.663445517841,0.121577563852883,0.976960798897723 +343,gene_343,89.3239444689287,110.065480087174,89.0914681645001,98.6776968839877,93.4763908516144,73.6876722313945,121.152366499517,73.0342990687431,0.628319185298281,96.7896474011477,90.3376821628172,-0.0995248470830729,0.976960798897723 +344,gene_344,87.6891607498036,85.9784677526458,126.069919784366,97.9390593091288,92.3574312669366,94.1479942575757,117.880400257431,69.6798420106609,0.677784653631021,99.4191518989861,93.5164169481511,-0.0883041418111203,0.976960798897723 +345,gene_345,114.031676150252,63.1044526268625,98.6199395241458,88.6428410346555,120.357951123467,113.367833670738,120.53675613286,89.3138359303975,0.184630886715115,91.0997273339789,110.894094214366,0.283663894163148,0.755040008590345 +346,gene_346,86.1861848270064,108.467435506505,104.824891217757,71.6482033711905,97.9154754081129,99.1115728240111,97.787197703595,78.6737131467646,0.954754372852806,92.7816787306149,93.3719897706209,0.00914987785652862,0.992641973777354 +347,gene_347,79.5172329813199,125.687231076088,129.944421318351,122.015678139074,109.917931636096,110.502921511273,105.171454153907,105.628361760383,0.619477285004679,114.291140878709,107.805167265415,-0.0842872490432409,0.976960798897723 +348,gene_348,100.747313946649,83.5060433438334,133.140595508435,97.2014622027968,25.642856511665,34.9007438763909,27.361722517784,22.8144712555601,0.00405371674192694,103.648853750428,27.67994854035,-1.90479099583143,0.0698916679642577 +349,gene_349,102.450299459842,90.059083540349,88.5397284388137,97.9468239826515,134.984847703453,121.743546190763,141.426442114132,79.588951245074,0.173101392721444,94.7489838554141,119.435946813355,0.33405473585833,0.733480477633239 +350,gene_350,84.9689778212921,83.0141443179229,79.1826990544023,119.769799345959,70.7505381543213,113.74532988066,81.6029482669106,118.07541838502,0.784447453779232,91.7339051348941,96.043558671728,0.0662338033517027,0.97704151387307 +351,gene_351,97.9597960482424,111.793023702027,76.1767914931696,104.715745274667,117.821805503881,100.301512422764,89.8188640250932,113.846349445788,0.467709262841029,97.6613391295265,105.447132849382,0.110660402780049,0.958914368513127 +352,gene_352,91.0841287279343,78.1598310287205,143.547562808291,94.8286932983623,93.5797348083341,87.4864168312945,85.790502889317,92.6549528182543,0.464635823282133,101.905053965827,89.8779018368,-0.181187252629237,0.958914368513127 +353,gene_353,107.626638681763,109.747298885253,88.4814559009256,88.1703083087161,39.4529316910789,19.8939760082774,35.8680674385861,33.5603627803485,0.000164783421233685,98.5064254441644,32.1938344795727,-1.61343341201481,0.0129272899548559 +354,gene_354,104.559362959398,107.599563129497,71.9980584509745,97.6882445338732,73.9027539688738,109.580252516619,118.359808482563,66.0720677959815,0.828295069979753,95.4613072684356,91.9787206910094,-0.0536159613397139,0.97704151387307 +355,gene_355,114.594651305137,79.3487699504538,83.1252791746419,111.525360768065,110.70934706259,65.1650793432031,70.4800434266394,71.4472059227015,0.253640415340474,97.1485152995743,79.4504189387834,-0.290137120707431,0.839868924968457 +356,gene_356,141.210156546859,65.5023271757738,91.8592654822363,114.434572760184,110.258542397999,149.358698265821,126.386197777121,82.3326047630552,0.542640410493366,103.251580491263,117.084010800999,0.181380206894625,0.975593151676992 +357,gene_357,71.7020315155233,75.1338294443291,88.9944884477325,96.7214687525879,70.0182853979248,76.7133309784572,87.6609311059892,96.0280168953877,0.950476556087873,83.1379545400432,82.6051410944397,-0.00927568006019849,0.992641973777354 +358,gene_358,86.3300924799028,59.742657747882,117.93436789631,126.163544760165,95.5851932941247,100.183467631349,118.690168442996,124.86985802897,0.503089741653829,97.542665721065,109.83217184936,0.171195402871811,0.958914368513127 +359,gene_359,111.27866685193,74.2252335167923,96.083706533658,97.2000310940491,107.615870860224,96.1301939750819,99.2659294882035,105.732847516669,0.411539947804494,94.6969094991074,102.186210460045,0.109811276423027,0.930988787286778 +360,gene_360,95.9641313933427,92.6777869504784,104.240907879319,103.576640508983,316.692654436048,320.212308042302,168.110963400562,347.786940837613,0.0184344110968651,99.1148666830309,288.200716679131,1.53990054806931,0.182518921751139 +361,gene_361,66.8239551598885,103.684161759816,63.3579714261177,97.2994763137772,119.836698369014,115.812114342387,71.9688420408444,89.2671945092503,0.325499909494899,82.7913911648998,99.2212123153738,0.26116782378358,0.919758854682739 +362,gene_362,95.6185936857581,145.161050035759,102.325190775235,77.7272435447858,96.8719887057788,132.746949284089,113.043418357678,108.613646630569,0.658840212956261,105.208019510384,112.819000744529,0.100765385287031,0.976960798897723 +363,gene_363,118.754823837953,101.500398354896,100.592158702284,80.1921520251071,74.5565266967145,108.588956811635,117.227973677408,103.28054839165,0.958890116019374,100.25988323006,100.913501394352,0.0093747490912209,0.992641973777354 +364,gene_364,111.756746062314,73.9106454924687,102.189486180844,136.444803150544,117.964129036494,95.4830842130585,119.59279160543,108.115921692415,0.779167931046061,106.075420221543,110.288981636849,0.0561982725058096,0.97704151387307 +365,gene_365,98.2016723913911,117.481691506827,108.773945105085,118.672573268106,117.033342366376,103.976970906178,67.3696621687785,74.5251477573847,0.191369064386169,110.782470567852,90.7262807996792,-0.288137193864984,0.757207212115658 +366,gene_366,39.2051908508424,119.294074930998,96.8548333750178,94.7111293359618,104.366886003351,125.400346347103,92.1175344595183,103.844152149744,0.362275783316704,87.5163071232051,106.432229739929,0.282311325062312,0.919758854682739 +367,gene_367,88.8352057492591,135.982380616396,62.0380764313368,106.903192973931,95.0383383911817,81.1084008085126,106.006435140258,125.494426251007,0.855890895059908,98.4397139427308,101.91190014774,0.0500101527876692,0.97704151387307 +368,gene_368,73.4161625396488,65.2934409388951,101.567320375537,103.314815906416,82.5743529009758,71.9933742732782,76.2862469956361,123.298008724175,0.868597489745299,85.8979349401241,88.5379957235162,0.0436732666783986,0.979600593105935 +369,gene_369,118.725222513453,111.772778441041,84.3586296573649,89.8786373557669,149.444363701834,122.808945778918,93.8047822893921,104.426259870152,0.31316797136623,101.183816991906,117.621087910074,0.217168170995615,0.911686915669735 +370,gene_370,98.7929777749563,106.880504631157,79.7854935011036,124.848022508697,102.497692989686,149.62220686093,111.882145198674,82.912717132883,0.608997066063438,102.576749603978,111.728690545543,0.123295937814363,0.976960798897723 +371,gene_371,142.069137363583,111.689178642932,84.6669764112901,122.628375151299,77.7056848083329,106.409864536862,87.8616837812634,54.7971381326757,0.0826691683809063,115.263416892276,81.6935928147835,-0.4966398549051,0.523721344412532 +372,gene_372,85.9898821891695,97.08762681692,92.5561220300011,116.234822104574,109.135123412582,99.8767415809739,92.2647119561324,105.87820900958,0.632406186475777,97.9671132851662,101.788696489817,0.0552079254597317,0.976960798897723 +373,gene_373,80.7019540291453,103.40568082342,85.2114276394767,79.1397242301378,61.7411148094277,96.9527743089756,109.4070766866,119.114974671638,0.517820967910888,87.1146966805449,96.8039851191604,0.152150310841047,0.958914368513127 +374,gene_374,104.728647312667,102.030121215058,104.421588354552,132.146391882419,38.8826092531715,43.8132024183907,24.2932632340345,30.3952323946749,0.00027139081761004,110.831687191174,34.3460768250679,-1.69015319026959,0.0137461303191761 +375,gene_375,121.157915041457,100.939657299437,75.4773270748622,115.036712039086,60.4343988907681,103.451768046591,78.8865550655702,79.1721676452745,0.143818145929479,103.152902863711,80.4862224120509,-0.3579706714873,0.694773651833233 +376,gene_376,85.2835282733453,98.899983165596,118.047125550802,99.4703970371386,99.3752845374562,78.7389625246804,107.976966494966,103.811670314924,0.76300939728125,100.42525850672,97.4757209680066,-0.0430073495554405,0.97704151387307 +377,gene_377,117.247363663461,118.007483269078,92.2621591135814,106.920656614936,109.282108408713,101.450292667236,84.9529008101682,79.5714068996881,0.159304041175042,108.609415665264,93.8141771964513,-0.211271315609337,0.711320181265988 +378,gene_378,90.3624303350331,88.7068039267457,99.3571211364259,83.7210023103964,77.407022675234,107.948673262331,122.066407132137,97.6623387512044,0.345566508341448,90.5368394271503,101.271110455227,0.161645826959917,0.919758854682739 +379,gene_379,123.580422067458,110.651181424712,95.7747763768702,86.7772717630241,60.150250353325,108.337069311298,141.542049111868,99.4472683027705,0.926147297064363,104.195912908016,102.369159269815,-0.0255175484779546,0.989992953448256 +380,gene_380,95.7901482995068,113.130689690583,114.968080567318,86.1766247263055,102.675167502278,92.5447237312454,108.555822596973,98.7329472964867,0.817922014806935,102.516385820928,100.627165281746,-0.0268346956549684,0.97704151387307 +381,gene_381,99.1845638735845,101.07574429938,123.509929892269,52.4200737147686,91.2665295187224,130.068445173735,71.4358009849227,110.55623635145,0.740622155323065,94.0475779450005,100.831753007208,0.100487335744059,0.97704151387307 +382,gene_382,69.2538243899341,101.354771308222,82.6434764606187,131.799639776754,95.5307289890383,109.339384077117,95.4662351292305,105.061128369352,0.737714160025122,96.2629279838822,101.349369141184,0.0742848977853872,0.97704151387307 +383,gene_383,74.3299992774131,96.2822951267646,83.143796043411,118.9569381917,327.943309810383,315.564251293113,244.192313428488,316.597187177162,0.000375905699104778,93.1782571598222,301.074265427287,1.69205414666053,0.0170866226865808 +384,gene_384,101.272985904764,112.9286199493,97.2729037903022,92.1458684470441,109.209680598875,141.740697000381,142.40951679423,68.6960699157444,0.469650104179221,100.905094522853,115.513991077308,0.195068586283041,0.958914368513127 +385,gene_385,82.2198114236766,101.243649230729,122.649107511208,134.436271306159,108.455905262287,106.159106700231,93.114318440514,98.1445955977152,0.517898317316649,110.137209867943,101.468481500187,-0.118270303985476,0.958914368513127 +386,gene_386,99.6508659778874,130.858119932366,111.525202411864,85.887974642296,106.215476496387,106.334733752839,114.24632809772,85.4848057612653,0.743991286383879,106.980540741103,103.070336027053,-0.0537192208354728,0.97704151387307 +387,gene_387,138.059903288777,76.793568564246,115.559879799926,98.5045925073608,108.850678230784,115.636556324282,99.1082250104491,115.549750656736,0.860701465385434,107.229486040077,109.786302555563,0.0339963946421161,0.97704151387307 +388,gene_388,55.8647475318733,59.1917164274222,78.8967511447173,120.779705127679,120.592213267182,116.510933433272,111.841576420152,94.2682504385932,0.117378579735772,78.683230057923,110.8032433898,0.493872023400482,0.637927063781369 +389,gene_389,106.035111263473,102.835022334507,118.88031806728,106.945940532296,128.329943767868,32.5960647797935,82.1914668490735,105.887450875059,0.375151675411098,108.674098049389,87.2512315679483,-0.31676072138913,0.919758854682739 +390,gene_390,103.773587673902,100.548774410519,111.134579069937,98.0825898610429,122.148388966706,102.032546693468,82.2710780539271,84.0642051520866,0.589848301575065,103.38488275385,97.6290547165468,-0.0826427784747672,0.976960798897723 +391,gene_391,68.7422040141095,86.8933044985233,107.46106093235,88.0167646278925,140.052750243567,113.591142797098,69.6699071620496,86.7092555950172,0.438944761993928,87.7783335182188,102.505763949433,0.223768249623545,0.950746766052417 +392,gene_392,126.77286480229,86.5933688636758,114.906879053165,92.71559254155,116.083828058607,131.909525840169,134.439891149926,102.833566100516,0.230108537617377,105.24717631517,121.316702787304,0.204996665609479,0.815523488873472 +393,gene_393,86.2981743663498,98.0948230381009,82.9408801018143,95.7563363521898,335.206473664876,267.693693030076,311.015459984548,315.647449225086,0.000339712038385531,90.7725534646137,307.390768976146,1.75974579456351,0.0161767637326443 +394,gene_394,96.0775575927948,105.616849588442,76.600547697351,77.6768199489412,135.231448222213,108.400995684616,114.238792121404,115.358964822362,0.0200067020881918,88.9929437068823,118.307550212649,0.410779293530748,0.194831874398845 +395,gene_395,70.255349714113,83.7997284913968,83.1456929624455,73.1504914570514,98.4599272550294,100.224867906313,96.7542727439196,79.5992030783688,0.036897705766331,77.5878156562517,93.7595677459077,0.273135808364003,0.299981347693748 +396,gene_396,62.1175518476769,108.977726596526,94.0294983452002,86.4449738260482,27.0749087540612,39.2462699028925,38.1236685125664,29.9871392932448,0.00836497694512416,87.8924376538628,33.6079966156912,-1.38693449424253,0.108636064222392 +397,gene_397,127.826575410615,93.7123187462731,69.4871105067511,91.08139371027,116.409195079648,97.5467646898264,94.1592300884987,89.9480847938531,0.779631149441213,95.5268495934773,99.5158186629565,0.059019582947356,0.97704151387307 +398,gene_398,132.167220254748,97.7488231849429,79.40330136043,108.132836893724,120.111239006912,102.452228922621,108.637550020822,87.708915655793,0.978580482976398,104.363045423461,104.727483401537,0.00502914597861881,0.997693106634484 +399,gene_399,121.244070661602,74.0559058311417,98.0258918778494,121.442585285952,107.235200044497,68.218010733064,90.9223425501114,138.836756832598,0.902614035335017,103.692113414136,101.303077540067,-0.0336281670217028,0.989971080047645 +400,gene_400,102.939189413767,100.452596454132,115.11222182771,88.6519767216381,106.732562123565,111.096213938857,102.974932689484,115.493498888437,0.290109282464344,101.788996104312,109.074301910086,0.0997296329567599,0.89539901995168 +401,gene_401,91.4490889963375,92.0591448704919,100.528833783223,100.960837211956,73.2774109713889,109.157710936721,120.687019972692,95.3331005810084,0.767853193229135,96.249476215502,99.6138106154526,0.0495670840235851,0.97704151387307 +402,gene_402,87.1244195660076,118.143513617489,90.2805259485294,68.0714881986625,89.7279027286306,138.840569813342,123.378885325408,104.853538857148,0.168473136984966,90.9049868326722,114.200224181132,0.329134138248654,0.726177314590369 +403,gene_403,105.439021097443,85.1861446808321,84.907299229222,100.889247336309,119.858397853587,128.586711396379,89.5770252525123,79.1694324719127,0.474307518066689,94.1054280859515,104.297891743598,0.148360149390416,0.958914368513127 +404,gene_404,84.0784398183167,87.8576243347358,153.891282370439,71.998847155321,90.2193382624321,107.465334956401,73.1545917043097,78.8684339338143,0.57912975819396,99.4565484197032,87.4269247142394,-0.185988711759958,0.976960798897723 +405,gene_405,86.9214131167705,61.9258770209242,98.5880985955384,91.2349177153459,93.0011042257179,112.989681540216,98.5033121960439,88.9744588327435,0.207967764741969,84.6675766121447,98.3671391986803,0.216366849028787,0.77025098052581 +406,gene_406,91.9763643471974,92.8146560809763,95.1683441998438,95.0852583596982,98.0409017889412,116.974984795934,96.0152180574479,125.398850561957,0.121997395805941,93.7611557469289,109.10748880107,0.218687868828551,0.648922318116705 +407,gene_407,110.527248780959,96.4908182451144,104.084703954369,118.077135972103,96.358582547872,92.2745984496977,96.4398955391481,109.080208655871,0.188770911130541,107.294976738136,98.5383212981473,-0.122825735403581,0.757207212115658 +408,gene_408,123.131155072136,109.664262997651,101.253771503368,130.566872187753,115.664333082392,49.5200225517951,127.913339769546,82.6947630677723,0.306022580210131,116.154015440227,93.9481146178762,-0.306102914362784,0.9053922491424 +409,gene_409,63.7030870779243,81.6204189340512,116.750004675391,124.815042161669,147.984859388644,103.876099675521,94.8206925089469,85.4472691895006,0.592524521905246,96.7221382122589,108.032230190653,0.159543744956434,0.976960798897723 +410,gene_410,120.210537514427,90.7784579629746,78.1805371323436,114.21726971882,106.782374863917,112.973006305866,86.0291992319882,74.8150581719942,0.683226261573382,100.846700582141,95.1499096434414,-0.0838896922394116,0.976960798897723 +411,gene_411,86.0740405381603,111.082543481683,121.725699482994,142.57153048233,116.51506993876,131.983922591803,144.783029698551,91.5187269524305,0.734291696842561,115.363453496292,121.200187295386,0.0712056697098332,0.97704151387307 +412,gene_412,95.483415070265,135.201539462531,122.585907732424,98.4336772388549,100.150488929509,103.610719969321,86.0042395768598,120.737259246104,0.42461766635317,112.926134876019,102.625676930448,-0.137987674316881,0.937345841839228 +413,gene_413,139.135564924754,104.509608634874,142.871991795378,72.4791485739768,117.89343188999,98.3407360823664,133.647106432212,79.262646285914,0.727169017288633,114.749078482246,107.285980172621,-0.0970210066869279,0.97704151387307 +414,gene_414,109.519797823308,107.071211260829,88.4912650833108,95.0447160462147,83.7392894245185,118.465152896789,49.1229559397669,81.1916200137181,0.327582075298683,100.031747553415,83.1297545686982,-0.267021090425303,0.919758854682739 +415,gene_415,83.5192065859921,101.475607107378,78.6156762525795,88.1587223074681,96.27024417676,88.7930746860013,100.291058334131,112.887297673258,0.149979511203185,87.9423030633545,99.5604187175376,0.179014982979951,0.704158035623226 +416,gene_416,97.7528993600738,50.6041995443056,115.51000568144,118.253932397416,352.176980350438,378.275999535707,165.861761823415,328.282031453253,0.0169454002261859,95.5302592458089,306.149193290703,1.68020519671581,0.17148539342323 +417,gene_417,92.880062180676,54.9652140921408,101.99425746565,113.186412686909,102.605477252884,98.4131383344946,109.566628472918,118.64997079079,0.288461124894762,90.7564866063441,107.308803712772,0.241695775835809,0.89539901995168 +418,gene_418,102.868462925634,100.331669331336,69.8193796301632,93.4523474324638,70.590519707153,120.887125875761,99.8480783068062,114.076683572535,0.500374409118884,91.6179648298994,101.350601865564,0.145652235412941,0.958914368513127 +419,gene_419,70.7514220663435,100.812226817531,78.0498864768949,138.419603541623,103.943901011107,89.5919124525607,112.542960615642,95.7320729057077,0.84119685613484,97.0082847255981,100.452711746254,0.0503366434392172,0.97704151387307 +420,gene_420,123.250440262617,91.0690653837291,84.8768164762456,88.0633814292155,93.0424142365472,124.261976362003,117.543759738069,109.616386185926,0.25058905432267,96.8149258879519,111.116134130636,0.198766923116063,0.838090482684514 +421,gene_421,92.9937842952504,66.840626473851,94.0018828976426,86.0138749358783,96.2639215275046,91.8537302488989,85.5224383923048,86.0849494645023,0.505454606527964,84.9625421506556,89.9312599083026,0.081995747105997,0.958914368513127 +422,gene_422,127.686990565238,68.6760771082577,127.894987137414,96.7913649485197,90.2086883444515,82.7495821964009,95.3662376038414,32.0537299495357,0.189014897006355,105.262354939857,75.0945595235574,-0.487209280648778,0.757207212115658 +423,gene_423,132.096736952978,83.2321384976875,57.4097114532216,66.7389908017477,113.009023697695,96.3511568715625,110.307956167053,56.1583503868146,0.683581552002778,84.8693944264087,93.9566217807813,0.146750458700931,0.976960798897723 +424,gene_424,80.1460711261893,100.925636915945,121.076376391577,114.952809190912,112.410985391955,87.6096281033466,78.5597959725729,112.947115122447,0.630134077151119,104.275223406156,97.8818811475803,-0.0912826698564858,0.976960798897723 +425,gene_425,83.1163521212367,93.6387343600589,142.480947117006,142.856741283926,90.9921071182529,99.1671483319751,103.496062114244,80.5033623030464,0.263271439450434,115.523193720557,93.5396699668795,-0.304532288553591,0.84773030824189 +426,gene_426,113.636596671942,117.870310894598,102.665215971896,94.3872872010118,87.4774155412913,100.582435662176,114.408759844806,124.616789254157,0.971093402711392,107.139852684862,106.771350075607,-0.00497063646945114,0.997693106634484 +427,gene_427,123.59150411229,93.5213911378928,119.546359693672,88.273150457108,112.401728699747,82.4235460500458,97.4607027553053,120.731030009308,0.81691892724179,106.233101350241,103.254251878602,-0.0410321767470114,0.97704151387307 +428,gene_428,105.753144218313,117.817572386748,128.2832681147,111.03191257641,253.9196596162,284.966347094314,249.015126100031,276.132199889019,3.46528479104421e-05,115.721474324043,266.008333174891,1.20081483253552,0.00495040684434887 +429,gene_429,99.5879587310974,88.3979255688607,91.0805800406327,94.5894136463797,65.4718553378623,88.8827247399918,83.7465438257861,72.4096886800191,0.0513110923445116,93.4139694967426,77.6277031459148,-0.267066710802306,0.38300569893794 +430,gene_430,98.5684076727245,97.016896304512,90.5376382868025,64.4409332898411,150.01393515588,105.498476472076,125.468464340954,130.298110648463,0.0164612514083871,87.64096888847,127.819746654343,0.544433394183889,0.17148539342323 +431,gene_431,107.728334169654,108.391647493509,120.621280815617,112.610697265765,83.6412315406007,106.614110007518,94.6412356993592,78.2268020090235,0.0330969065052334,112.337989936136,90.7808448141254,-0.307386074823558,0.28094912234625 +432,gene_432,111.350883880563,49.5814349659508,88.7865915040207,93.3781092843494,80.7824367085881,110.072700387822,125.754385123058,69.0257490259791,0.584766743328272,85.774254908721,96.4088178113618,0.168620416637757,0.976960798897723 +433,gene_433,97.1776353789457,81.0506716120868,102.305055473155,108.23371368889,92.6880634738117,81.8542527403345,99.5678977340423,87.2718793411631,0.369012231383623,97.1917690382693,90.3455233223379,-0.105381023854718,0.919758854682739 +434,gene_434,69.8524964568359,73.5726048232267,99.7218572784814,89.0327531719249,108.666510227306,116.261810097555,81.8926651108776,127.647473331684,0.0809300197336295,83.0449279326172,108.617114691856,0.387287483409601,0.518782177779676 +435,gene_435,129.05377430638,99.1609317408605,49.5191743020968,110.757475849606,92.9609561601308,100.387729895691,113.093845248961,100.151025902527,0.811257341128563,97.122839049736,101.648389301828,0.0657048552190946,0.97704151387307 +436,gene_436,93.7270922126033,81.1610095595681,119.653084879333,114.091546451711,28.5814287326746,25.5576399135296,20.5666971277813,42.5767160472618,0.00118829661488413,102.158183275804,29.3206204553118,-1.8008172364379,0.0396098871628043 +437,gene_437,76.5941527019894,121.086897781123,108.025464932016,87.7994317082104,40.2874389485843,35.2581243091534,20.6055461146302,37.0059955576127,0.00363041457695719,98.3764867808348,33.2892762324951,-1.56325603039656,0.0660075377628581 +438,gene_438,128.652617216684,112.80803433991,130.361402610643,67.5555728086201,72.5850698003007,95.3638348660234,92.7667027865064,82.9079607526837,0.202917806562736,109.844406743964,85.9058920513785,-0.35463241948077,0.760743228338604 +439,gene_439,108.240653870219,93.474716427427,57.6825500218269,104.541458840079,93.2060653371629,135.892270185231,126.768030785774,72.2803541004462,0.426623803931312,90.984844789888,107.036680102154,0.234407111636285,0.93793636037618 +440,gene_440,107.665106622576,116.983678016494,115.436320386893,98.4879286915808,102.02962285123,87.8648349370617,104.706345684499,77.7674844607022,0.0786507863369795,109.643258429386,93.092071983373,-0.236086894961443,0.507424427980513 +441,gene_441,65.4664862175422,74.4773454389745,126.096401830129,103.901760813702,68.4876219827748,124.426549826032,80.5505752283386,108.671357630825,0.877062743513521,92.4854985750869,95.5340261669925,0.0467874930656551,0.985463756756766 +442,gene_442,112.825730673322,110.71062221461,106.75712121544,101.508856651522,104.17589569033,82.8176265734059,88.1939377563547,111.457202684471,0.192836571118689,107.950582688723,96.6611656761405,-0.159362732641179,0.759199098892476 +443,gene_443,114.759902482702,105.77048535427,107.80794742861,129.588378512508,125.032021892594,94.6370796742883,97.9371754765755,85.6866738761711,0.2310334533338,114.481678444522,100.823237729907,-0.183288539671707,0.815523488873472 +444,gene_444,118.670955203795,109.703515150991,89.9247756738463,116.022072457731,90.8023548705009,62.9525246291978,87.2363091177133,89.157005089713,0.0304020832368162,108.580329621591,82.5370484267813,-0.395649015872794,0.264365941189706 +445,gene_445,137.919866772,85.3881080934536,79.8756437746119,75.7834134195329,83.6299436293843,98.0214062937037,85.6112719469501,86.7103778258492,0.700480892809668,94.7417580148996,88.4932499239718,-0.0984330289192215,0.976960798897723 +446,gene_446,110.733496449445,64.410171776012,103.034979231692,104.950743897473,69.7139210833448,122.539128712448,107.804722337723,73.2886350325345,0.888875278515061,95.7823478386557,93.3366017915125,-0.0373168572052317,0.988530250143975 +447,gene_447,103.385273364214,92.3739804949644,93.8029677786691,85.9627669136833,107.758756925476,109.40030419501,114.321601300457,103.749877280262,0.0167429617517164,93.8812471378827,108.807634925301,0.212870880479809,0.17148539342323 +448,gene_448,101.828161010825,138.157603284218,107.525593336061,89.76808506814,103.112970500027,103.429701308689,99.5062771269158,79.3631063444288,0.324514616599353,109.319860674811,96.3530138200152,-0.18215382799016,0.919758854682739 +449,gene_449,111.570660221027,110.14262463907,64.48686180414,99.487958097485,23.837471086605,34.1857222758745,41.6815761649526,40.2001579915198,0.00724135447031525,96.4220261904304,34.976231879738,-1.46298787581742,0.0991966365796609 +450,gene_450,86.7695726045435,86.6224047025219,130.979585782716,104.336443129262,76.8601431051699,98.7314225812654,85.0946056932994,68.8468220806845,0.167643524315876,102.177001554761,82.3832483651048,-0.310647586928257,0.726177314590369 +451,gene_451,105.495286559546,91.3069534282633,88.7412959047427,88.5333657874706,76.6105389661354,85.4440437468163,80.9085089209883,108.772151345891,0.529423264859645,93.5192254200056,87.9338107449579,-0.0888449892097679,0.972014394251591 +452,gene_452,79.3999984640064,133.697926038835,89.9592256001128,118.008995782028,75.1000909771387,93.5535749898953,112.424295196035,111.470063201064,0.659365561173973,105.266536471246,98.1370060910333,-0.101177721872985,0.976960798897723 +453,gene_453,118.184478864058,88.7913384890024,68.340203767787,117.292144259556,83.8451467608808,68.6599021620835,109.709298848313,94.997271775488,0.575295689492691,98.1520413451009,89.3029048866914,-0.136311168096084,0.976960798897723 +454,gene_454,75.4169551567534,91.6985851149851,110.331599484719,107.342950448363,67.4540778616949,83.5349391232164,110.302462633742,110.460663488068,0.815128096971011,96.1975225512052,92.9380357766802,-0.0497305854849224,0.97704151387307 +455,gene_455,115.469583747885,153.524013971197,113.518734626481,78.5335703461081,86.413381715846,116.054293746523,124.726324214495,90.352530078957,0.5720404964556,115.261475672918,104.386632438955,-0.142973420682446,0.976960798897723 +456,gene_456,109.3250908798,123.626193863714,153.751983986912,140.051430286183,92.5433510068723,100.877449185801,123.48586738417,116.926707629566,0.105442452467641,131.688674754152,108.458343801602,-0.279990233783155,0.610405724320116 +457,gene_457,97.5952122112914,112.255098642988,70.1779637580667,67.6818647352605,59.2899042611765,141.74843461911,93.7765447924546,99.4435507159639,0.58681578312369,86.9275348369018,98.5646085971764,0.181256481822881,0.976960798897723 +458,gene_458,53.5118876508015,111.341212768929,110.226558278383,87.4468016609403,97.3202828827528,120.24153747783,112.684925658362,98.9007096716182,0.318825617226909,90.6316150897636,107.286863922641,0.243387145522812,0.913540450506902 +459,gene_459,78.0081596576903,133.746676039318,104.528385101952,94.6978341209215,117.399528975229,118.742146919533,142.350794307947,116.276248927601,0.18015520360098,102.74526372997,123.692179782577,0.267682400154016,0.755040008590345 +460,gene_460,94.0267744057052,108.592342879503,144.881978617843,41.6494614734108,86.9555710102432,124.547435244798,85.0904382332885,105.560672678556,0.895727378724336,97.2876393441155,100.538529291721,0.0474200666346684,0.989754009640151 +461,gene_461,99.3372861109707,82.1089625587487,117.360580646499,133.191126654695,102.930037938848,69.3499413497284,92.4992616430726,106.410974020798,0.317783104084747,107.999488992728,92.7975537381117,-0.218865806505402,0.913540450506902 +462,gene_462,85.978030591817,93.7369868169874,101.628305083548,64.1988551431657,283.325709659839,327.064580391474,362.435442299018,358.434405662378,0.00020877405896502,86.3855444088796,332.815034503177,1.94585878701573,0.0129272899548559 +463,gene_463,95.1494439679881,121.639612763424,115.726639332283,81.1530275836844,56.8074269019035,105.612574514823,105.203638041853,90.1709279725462,0.382649916537297,103.417180911845,89.4486418577813,-0.209344401082806,0.919758854682739 +464,gene_464,96.2418194024248,107.425898158917,84.1897524570499,110.102943870557,125.527655698035,110.06997639886,98.1403288206678,91.7825976077701,0.496602308545151,99.4901034722373,106.380139631333,0.0966039062631186,0.958914368513127 +465,gene_465,73.8608359644711,103.165084666175,125.864983928441,112.696159075786,100.574633372723,43.5194842212433,118.860528752133,80.3975203331522,0.39593546876811,103.896765908718,85.8380416698129,-0.275461679247312,0.919758854682739 +466,gene_466,128.802213259265,96.1556045306396,82.5100049548759,94.5369965325467,80.7384244904855,116.917272561221,41.2171294079492,87.4996967929455,0.352114036088779,100.501204819332,81.5931308131503,-0.30069319231123,0.919758854682739 +467,gene_467,97.8552700346495,132.880419609271,86.6752211574749,51.5611958005239,109.772012784128,99.9609674197534,78.1484820194846,97.9526500782005,0.826738630280414,92.2430266504799,96.4585280753915,0.064468944185397,0.97704151387307 +468,gene_468,98.0074364905334,112.122021350044,79.4220365508601,66.4641131458429,97.5930313792186,96.7276067431745,86.6182732531101,101.90048747197,0.563756712250383,89.00390188432,95.7098497118682,0.104798818823864,0.976960798897723 +469,gene_469,92.1354870509244,103.220807866592,143.859010289888,58.9649683123354,114.424677903287,82.2983194970311,124.571193038865,95.7243361069682,0.823030781462921,99.5450683799349,104.254631636538,0.0666897291084896,0.97704151387307 +470,gene_470,114.631971686883,94.0402946233718,72.9018712073508,101.224545848982,91.2361486293811,74.7196222039183,119.160445075321,102.262807583038,0.93153221536396,95.6996708416468,96.8447558729146,0.0171599666718479,0.99139661091521 +471,gene_471,120.588953733304,109.004669367042,75.902557315864,126.173507732765,101.511953230062,104.265164499463,108.768844390597,64.9240516602028,0.421531977200891,107.917422037244,94.8675034450813,-0.185941903806932,0.934660703327918 +472,gene_472,109.344341647415,73.922672428135,113.727241238226,97.1239744238409,87.9968249019975,59.4203462268933,114.655248059691,77.3775936793031,0.387394760134728,98.5295574344044,84.8625032169712,-0.215429342126378,0.919758854682739 +473,gene_473,108.587999371924,92.6626195090175,105.278707390243,62.2699477655262,103.052999364378,113.007643328627,99.736593466322,100.026987297852,0.352926303524475,92.1998185091777,103.956055864295,0.173137987619645,0.919758854682739 +474,gene_474,89.6900503306097,113.044851443293,77.4425494762503,109.179489196343,98.8182954771757,105.244370407723,112.665299118056,120.230814613962,0.272243248914018,97.3392351116242,109.239694904229,0.166403846790114,0.853427112583127 +475,gene_475,73.920225230447,56.1447560449839,92.5066531580842,93.86409041967,258.263893724224,326.824998953257,260.855308294716,308.983628494643,0.00021976392923255,79.1089312132963,288.73195736671,1.86781831056391,0.0129272899548559 +476,gene_476,121.562333125561,136.526885093699,89.8559299322343,97.2772194726733,125.168027877923,135.21962565916,98.8492587186714,118.383060393817,0.565619807841016,111.305591906042,119.404993162393,0.101337092715358,0.976960798897723 +477,gene_477,73.8227016941334,92.3761213945131,106.789788222536,101.705735470858,97.1647360471206,139.826789489057,91.5075466674985,92.82294905878,0.431827786639965,93.67358669551,105.330505315614,0.169209112191665,0.940801278082713 +478,gene_478,93.7140924468899,112.967261084083,76.3182638245686,134.274499854246,82.3109365502602,97.7181930743903,86.2874277016914,88.2977334684331,0.301956680306469,104.318529302447,88.6535726986937,-0.234744758141181,0.904560025949688 +479,gene_479,101.880317355812,69.8822614811589,82.253373194588,126.032611307125,76.7841000725881,107.0714401051,86.5167697319295,100.700363064534,0.87966000284913,95.012140834671,92.768168243538,-0.0344820206053323,0.986437635508572 +480,gene_480,111.280218357206,82.5452158886747,106.133730556144,82.7242006094559,102.947763113073,117.466732166791,90.3389719069326,87.0511057101565,0.725646152565883,95.6708413528701,99.4511432242383,0.0559086696360348,0.97704151387307 +481,gene_481,109.264803595745,92.5295647007809,100.501472786813,133.798973959069,108.393861535976,76.2976647131375,114.799230148379,86.9636193861477,0.366042599145307,109.023703760602,96.6135939459099,-0.174343735752295,0.919758854682739 +482,gene_482,63.5235664413857,86.2583987021196,75.8853066729174,74.9947500807106,128.989985966987,84.260299239966,101.678109642408,108.287352767156,0.0365634512119471,75.1655054742833,105.803936904129,0.493250664815768,0.299981347693748 +483,gene_483,97.8029006468026,127.539710890134,113.569309890122,123.665657970909,81.086454432245,132.193591497896,102.866845136132,98.2353099920207,0.379937563645623,115.644394849492,103.595550264573,-0.158733305568815,0.919758854682739 +484,gene_484,138.891904199486,95.7656626352665,75.9387421030079,124.204750212049,91.414706868021,106.353653651511,80.9971141989629,111.41543275817,0.514506512464488,108.700264787452,97.5452268691663,-0.156212269676299,0.958914368513127 +485,gene_485,89.855498649882,115.526785618384,106.211916768852,76.6154702718677,80.6624544681196,74.1156411408766,127.849027523104,113.471883719286,0.903632823401931,97.0524178272463,99.0247517128466,0.0290250241713266,0.989971080047645 +486,gene_486,66.6231259567329,74.817042388543,128.036201269049,107.224731375165,88.0749979747605,112.338761589853,101.054314841169,143.90661455274,0.393097229122498,94.1752752473727,111.343672239631,0.241599320931177,0.919758854682739 +487,gene_487,112.798631578421,76.123871015154,90.4518500460046,110.687728742415,103.920032638574,119.019808468477,70.9049460056869,123.380080409328,0.662849583967386,97.5155203454984,104.306216880517,0.0971213899583376,0.976960798897723 +488,gene_488,151.069138209324,135.003061327392,108.462453726397,76.9304720809543,434.295996834396,245.958941943085,200.412897075723,292.589474299263,0.0348369868000283,117.866281336017,293.314327538117,1.31529648667516,0.292747788235532 +489,gene_489,89.6012564724005,87.2821856112179,90.2589698646545,92.0937183197393,80.0099979726258,116.058147907187,90.3839301283916,90.4973131652989,0.606177819371851,89.809032567003,94.2373472933757,0.0694383773224621,0.976960798897723 +490,gene_490,72.5745402209587,86.3439494004904,85.5827489906901,105.746201214616,71.1828016717228,86.2263965567392,85.0392944981482,85.9164322287637,0.514357226643749,87.5618599566889,82.0912312388435,-0.0930744745512705,0.958914368513127 +491,gene_491,86.4799147473517,87.0434750637261,70.5078757719529,118.850543106665,100.01407877894,107.302016373357,113.890760855353,71.2117957279153,0.612444315431959,90.7204521724239,98.1046629338913,0.112893878617652,0.976960798897723 +492,gene_492,107.467074528628,127.058126616226,113.710500326218,79.7164281049808,27.9887511203694,44.8034491195205,37.8378546019723,25.998421917559,0.0023329442639082,106.988032394013,34.1571191898553,-1.64719121844345,0.0553552260973115 +493,gene_493,86.6161924447829,110.453198743732,89.2465341611141,56.8706187334536,104.549614698207,117.340100902666,82.8633622692524,118.637617088237,0.199906578487778,85.7966360207706,105.847673739591,0.302996575286029,0.760743228338604 +494,gene_494,84.5560585576317,100.378735957598,95.3084787538431,69.7723864221373,113.982151160272,81.1267978193748,105.689210237561,140.996617925299,0.168347448532207,87.5039149228025,110.448694285626,0.335956893746118,0.726177314590369 +495,gene_495,130.686111409397,107.931940403972,107.193102098514,117.412730745484,82.767644314811,90.9280031404376,93.2724925312178,94.5458768190164,0.0118028861694464,115.805971164342,90.3785042013707,-0.357658058031053,0.137242862435423 +496,gene_496,67.3212130165539,89.6248276344046,88.0734800429828,107.546276251333,92.3061148113467,142.787302519051,119.674116667228,102.166947857596,0.111488619717799,88.1414492363187,114.233620463806,0.374094794454361,0.626340560212353 +497,gene_497,123.786483346128,114.412315837911,113.599383236707,137.115889449027,71.3625660658224,111.108734025192,64.7818203161413,83.2583869095832,0.0217644968442801,122.228517967443,82.6278768291847,-0.564880426956256,0.205357438279128 +498,gene_498,113.568260098845,88.8331927438985,89.5612142321624,127.481169082015,90.9781922602557,103.882435910441,100.02315935392,134.74015210541,0.855882221207145,104.86095903923,107.405984907506,0.0345967401822422,0.97704151387307 +499,gene_499,74.6453650488725,109.860741862409,74.5413538955847,90.3264317071113,80.33313421947,89.9911466222813,121.768912592556,84.8591661667693,0.603606981218547,87.3434731284944,94.2380899002691,0.109610398036571,0.976960798897723 +500,gene_500,92.4430127124666,97.5507702089285,97.5448334533833,116.863186245755,107.130292614746,128.664555328619,85.2843998198067,80.4245523906134,0.955699261404232,101.100450655133,100.375950038446,-0.0103757854371615,0.992641973777354 +501,gene_501,108.93241009398,104.154675659377,91.5970075213452,94.3018582878596,111.97144926948,112.251056297941,109.073246846853,67.1447586956266,0.97685205483126,99.7464878906405,100.110127777475,0.00524998423083719,0.997693106634484 +502,gene_502,131.277948347156,103.698810205895,55.3251590516046,55.8707611576577,40.9019374235712,37.8255887916314,33.5485796078166,22.9465763271618,0.0641022783771066,86.5431696905783,33.8056705375453,-1.35615469783842,0.435625239696705 +503,gene_503,110.570321618272,127.067098215807,69.9455681611666,114.218249796408,89.2174336044143,108.721942889827,116.375053684013,135.757619608965,0.668546086556374,105.450309447913,112.518012446805,0.0935926449951927,0.976960798897723 +504,gene_504,122.269656080942,112.544039406137,57.6126848749026,128.129959055394,62.0139987373467,121.560932080194,131.757575341137,106.276902007527,0.990969717251378,105.139084854344,105.402352041551,0.00360797825804257,0.999453122312829 +505,gene_505,88.3419365028514,88.6863841079642,109.382881520851,122.042891089726,93.1845796294424,73.0579351181847,64.5210720244929,98.7512553558798,0.139387027151124,102.113523305348,82.378710532,-0.309830491691473,0.686635601729675 +506,gene_506,92.7005796564949,117.445688188982,78.7001011172376,121.636540522296,114.730811027904,106.112719404434,86.9735587031455,132.516951217536,0.611378117489103,102.620727371253,110.083510088255,0.101276220769452,0.976960798897723 +507,gene_507,91.066847236425,122.019114397525,104.900308335195,106.148878641838,88.100873180099,88.9058104342089,119.374246513275,116.345844486199,0.797552283649784,106.033787152746,103.181693653446,-0.0393370132323311,0.97704151387307 +508,gene_508,94.5129040623721,107.444190454527,100.210139516177,107.193099614563,104.166604833957,68.9556653913322,103.636196281371,97.7142614508143,0.385456494157853,102.34008341191,93.6181819893687,-0.128510660188239,0.919758854682739 +509,gene_509,99.9114533906054,102.380223357579,114.50891230294,90.5380047925614,96.1047323503473,117.618895312875,133.283050134878,63.9715104229738,0.957080196910569,101.834648460922,102.744547055268,0.0128333171162276,0.992641973777354 +510,gene_510,96.8256823154746,89.2667966717895,95.860800128871,133.03500911393,79.5072004142794,87.1227847215542,105.137619527691,116.495736083906,0.626079733462623,103.747072057516,97.0658351868575,-0.0960351248607351,0.976960798897723 +511,gene_511,83.9032863678838,85.4419646253083,67.2018624832684,88.3868354828402,81.6663429978154,88.4334382490107,66.1542454947948,124.183227244355,0.538359532558431,81.2334872398252,90.109313496494,0.149601648881104,0.975289008258027 +512,gene_512,123.595908226198,114.547097419869,82.8176065535227,100.887098241521,115.985665047777,72.0230552227982,73.9436302833578,131.07913015976,0.695728625053115,105.461927610278,98.2578701784234,-0.102077398420992,0.976960798897723 +513,gene_513,89.9973246458717,98.4617163278227,78.7815970642135,119.79762879361,138.61851953798,106.769091994948,91.2060740875604,77.0005803171509,0.691416873720316,96.7595667078796,103.39856648441,0.0957399702821618,0.976960798897723 +514,gene_514,114.407661393961,80.9250555575318,91.8765865033014,89.2448534103735,99.0921382403385,77.3538853692424,103.997842380948,109.046794749492,0.755406044251224,94.1135392162918,97.3726651850054,0.0491145458065255,0.97704151387307 +515,gene_515,94.4197481691256,125.253047560832,120.993185094744,80.98771730579,106.520529753585,112.139617835803,129.951127885557,90.2125741811947,0.760518471432987,105.413424532623,109.705962414035,0.0575833292572768,0.97704151387307 +516,gene_516,127.572906958859,126.49130984738,66.1309076748088,73.1042136530439,115.409062975747,106.807677885227,102.505191611874,108.160194962441,0.596431011072292,98.3248345335229,108.220531858822,0.138346478259679,0.976960798897723 +517,gene_517,74.6673356977945,112.588991949751,91.1062259840484,88.6627963206306,106.036003241818,79.0379102640687,83.6662094730501,89.5938953561894,0.83246497780287,91.7563374880561,89.5835045837815,-0.0345746996537126,0.97704151387307 +518,gene_518,103.758984655929,79.4611716032019,77.8186525619836,105.08166426382,113.554820178306,89.7926088682678,39.5155581623905,86.2108313248386,0.616602612857683,91.5301182712337,82.2684546334507,-0.153907201277058,0.976960798897723 +519,gene_519,73.2895138402089,137.207484764306,89.8760016998085,93.3276056527326,136.758584742046,92.7792770288373,83.0552132320016,76.6311097007211,0.955507333645593,98.4251514892639,97.3060461759014,-0.0164975772761235,0.992641973777354 +520,gene_520,91.314524200726,118.137965878375,125.050951961547,134.325425505351,102.605934622053,52.4228828742271,116.826574106036,99.8726418738324,0.205521929239901,117.2072168865,92.9320083690371,-0.334813913000335,0.764022041784019 +521,gene_521,98.3562800455791,94.7617802450405,90.3548587560225,108.733966378621,107.390486249931,75.1580568359609,94.8011022042805,95.9065208744142,0.568604573708059,98.0517213563159,93.3140415411468,-0.0714487693490061,0.976960798897723 +522,gene_522,96.9000209428847,109.085742072544,126.320516362639,111.65324680529,109.107077639374,99.0814840106639,110.486682548817,106.729049574755,0.517785426566553,110.98988154584,106.351073443402,-0.0615935634129104,0.958914368513127 +523,gene_523,84.2030441941901,116.22596145213,108.357606121482,90.26967085872,33.6352199051208,29.4574407941065,37.8332910248912,25.6853177209274,0.00140181896201748,99.7640706566305,31.6528173612615,-1.65618641531073,0.0412299694711023 +524,gene_524,78.6191214527292,119.371547226266,132.102249260966,86.8352007580175,90.3496298968096,113.048955338249,115.246429681374,67.2055530933483,0.664783587091789,104.232029674495,96.4626420024452,-0.111756444932765,0.976960798897723 +525,gene_525,90.4299709209691,114.221237566592,127.812946011369,128.645212986997,39.3346530002688,35.503087364396,30.4097079895216,35.6994505223662,0.00224550068757106,115.277341871482,35.2367247191381,-1.70995723856986,0.0553552260973115 +526,gene_526,121.603701459928,95.5289824850652,86.7246011023278,109.520429867213,97.2108053695458,103.764400190041,86.8049831090951,97.0351203440833,0.44340779113673,103.344428728633,96.2038272531913,-0.103294420912477,0.953565142229526 +527,gene_527,98.0624737863959,99.606213921495,83.6827985316045,103.455024294975,135.106597368278,70.1873742941971,127.899354882343,124.27410459585,0.315062461768126,96.2016276336177,114.366857785167,0.249535827818622,0.911686915669735 +528,gene_528,91.824575914654,104.181172200533,73.7202270676784,133.488743599798,97.3091965312434,52.9670927303209,101.322236664063,93.0977504006284,0.418471358950538,100.803679695666,86.1740690815638,-0.226222589649557,0.932304621562769 +529,gene_529,89.0208574460488,132.900967742765,68.9507101005379,115.599745470704,88.4511173650045,101.461479863779,94.9262250726539,131.142383541511,0.894005649410792,101.618070190014,103.995301460737,0.0333613768856603,0.988944302445566 +530,gene_530,95.0533650894813,90.5351106071434,116.364765244947,99.4135328932067,56.2334948224653,107.197546705952,93.1969283023399,106.99852410021,0.514111153749938,100.341693458695,90.9066234827419,-0.14246387313122,0.958914368513127 +531,gene_531,84.8944016716248,120.756310061477,113.541326174493,113.844973373085,73.6171909737223,139.372276003988,126.068178755989,133.558744885271,0.589555437992784,108.25925282017,118.154097654743,0.126179327647239,0.976960798897723 +532,gene_532,102.516075158487,120.285507647993,84.9548798051576,100.790121938746,91.5273071197842,111.719483454862,88.492850862346,108.020498148923,0.821023907269418,102.136646137596,99.9400348964789,-0.0313659642061906,0.97704151387307 +533,gene_533,79.4596099379694,104.221728357637,125.637167380956,125.268521516697,98.1676029664094,113.811811575603,129.520137363813,94.4833466540578,0.98038622683318,108.646756798315,108.995724639971,0.00462643692262612,0.997693106634484 +534,gene_534,92.6307368772682,113.502052429298,98.815361266503,139.197546906952,105.034397167728,87.6143803690061,89.3389894522601,87.3420165380048,0.170438753351542,111.036424370005,92.3324458817498,-0.266123406472187,0.729535871197449 +535,gene_535,118.834306734926,102.467997450931,90.6800723817352,89.9574597665956,69.677997228334,100.408864809475,97.6406589676512,81.6172437194331,0.231378438316312,100.484959083547,87.3361911812235,-0.202328050037793,0.815523488873472 +536,gene_536,85.3772015268163,66.4669568116628,75.0236052238234,89.7361513448746,129.656995577904,78.822259222169,67.050648527221,117.236495244738,0.301290656603535,79.1509787267943,98.1915996430079,0.310992416442378,0.904560025949688 +537,gene_537,89.2911293650743,131.934515041408,81.4798800514085,99.7381508395649,99.3234919530157,41.8493614500133,103.443300968951,87.9636384691846,0.370841284152605,100.610918824364,83.1449482102912,-0.275086367642639,0.919758854682739 +538,gene_538,128.864652511726,64.9363216145585,108.44002660136,121.92542135351,45.2816434106836,34.6836734999739,35.1858723124235,29.4688949480973,0.0140645519091759,106.041605520289,36.1550210427946,-1.55236249752671,0.151231740958881 +539,gene_539,118.053746940924,95.9724351173326,85.9242432822044,143.979797222991,124.006483991586,110.379797250334,93.32122563129,105.769238092458,0.863704698263794,110.982555640863,108.369186241417,-0.0343783317758705,0.97704151387307 +540,gene_540,113.682670794617,100.642393416593,108.085561710856,84.0609929150614,92.0237603032503,104.59721360247,78.993353652807,96.2919695732406,0.34253236551142,101.617904709282,92.976574282942,-0.128215446258997,0.919758854682739 +541,gene_541,87.9144765973811,59.6579428888144,126.255844663801,125.555309252054,87.0334647499033,129.330525306614,126.329246976833,76.0583658000895,0.826020335436175,99.8458933505126,104.68790070836,0.0683197164660853,0.97704151387307 +542,gene_542,95.3846685045788,134.990333487721,106.315959189942,108.877748005247,100.696089562412,108.7127394931,127.710792271128,118.049411147008,0.823120698679814,111.392177296872,113.792258118412,0.0307544863573978,0.97704151387307 +543,gene_543,91.4254454164107,89.9218242133282,73.7677869708865,97.0543505473013,87.1235892740112,101.787465194956,117.067204705071,105.623031856431,0.112931850955796,88.0423517869817,102.900322757617,0.224977919281242,0.630802153518396 +544,gene_544,123.16625335118,107.387808849476,80.6677755896823,100.986890517914,110.003130731582,86.2174673567045,71.0532621246134,94.2652197129096,0.330961588027884,103.052182077063,90.3847699814523,-0.18922345235984,0.919758854682739 +545,gene_545,80.5463388470576,130.7674606956,107.987629210224,78.6966949366566,108.023207669567,127.645112185521,100.608761339822,115.842803646778,0.375278279670577,99.4995309223846,113.029971210422,0.183943741337393,0.919758854682739 +546,gene_546,77.6475665769385,76.1938919207952,91.4210883898279,101.956550453729,85.7016645245145,72.761207412279,89.1732573451624,99.3680144749819,0.994993095952624,86.8047743353227,86.7510359392345,-0.000893408522558493,0.999453122312829 +547,gene_547,99.4111520150485,133.754217987331,80.3740180149182,126.891896967062,67.4783406936724,108.485001423882,92.6565618475624,106.625863645284,0.338570462584599,110.10782124609,93.8114419026003,-0.231081151129598,0.919758854682739 +548,gene_548,95.8818231964091,68.4696777436869,107.038975144851,89.3959555431459,107.447144469319,130.593622043703,92.5969845559533,84.2546238529308,0.34002152274025,90.1966079070231,103.723093730476,0.201592059881724,0.919758854682739 +549,gene_549,111.143101702831,56.0350676796744,113.616480316408,117.135791470798,83.4335630147106,104.987803630132,93.0537559857983,109.79331333746,0.920673104444309,99.482610292428,97.8171089920252,-0.0243575363557681,0.989971080047645 +550,gene_550,90.7372114787871,60.3951343256933,94.0185441198391,148.765171624796,96.3152183582991,40.9876074084978,124.719935031919,102.180259286291,0.781280149710688,98.4790153872788,91.0507550212517,-0.113145357014568,0.97704151387307 +551,gene_551,94.6156975400621,133.384817919996,123.869043488681,71.2144925669072,95.9297583479968,82.2289204601189,54.8092842652592,118.069396992552,0.388872324716956,105.771012878912,87.7593400164817,-0.269319721920172,0.919758854682739 +552,gene_552,83.5478610308784,92.9595572253594,117.89951251389,40.3042657430624,109.314455543053,108.518684608179,93.1436403685697,120.413792151427,0.236021609961736,83.6777991282976,107.847643167807,0.366077837317644,0.818289875612779 +553,gene_553,77.5456418448021,114.569563062662,80.7306984180825,99.4818246342211,30.4034237071158,36.5052408108526,26.4117864856811,42.8266714194333,0.00321445111729946,93.081931989942,34.0367806057707,-1.45140657025077,0.0618163676403743 +554,gene_554,121.966158291416,81.9478439928343,97.6245793188403,82.8589855154233,109.010345261792,99.5368342465307,89.8408155123933,83.3732267889694,0.954151606449299,96.0993917796284,95.4403054524213,-0.00992863977973221,0.992641973777354 +555,gene_555,104.211928841243,119.544087769758,67.1648736981454,103.206417593463,111.593877879299,86.5974786279383,95.5701467903183,100.784113336723,0.993583256090017,98.5318269756521,98.6364041585696,0.00153039864957146,0.999453122312829 +556,gene_556,95.3576177720878,74.5525289077867,120.227676570226,147.847689637845,85.1539018911071,132.2251532373,92.8507148357823,101.688630273178,0.743792055344105,109.496378221986,102.979600059342,-0.0885245787544683,0.97704151387307 +557,gene_557,92.918132664593,119.912016156481,76.9350101560789,106.012712748094,69.228078704974,99.5015532850181,111.651955705961,76.2478283092777,0.49592668312707,98.9444679313117,89.1573540013077,-0.150265246086479,0.958914368513127 +558,gene_558,105.459399080058,94.1791062147454,96.7709411751151,101.451300083357,76.911290335089,119.344442288445,104.849530249226,114.539407544651,0.677835042851919,99.4651866383189,103.911167604353,0.0630871448483148,0.976960798897723 +559,gene_559,156.231552480629,123.528332228678,76.1406186938671,83.854180963218,99.4168406708937,114.282114839446,85.3568739099829,79.3481577703203,0.489022639241791,109.938671091598,94.6009967976607,-0.216771655456932,0.958914368513127 +560,gene_560,106.706559637786,79.2786185343871,98.633662924931,90.7326436805514,93.5868150696222,96.0729515960691,94.5568501268215,92.3735520136419,0.961326458798295,93.8378711944139,94.1475422015387,0.00475314783559477,0.992641973777354 +561,gene_561,92.3530248722892,111.106530978734,79.0433909483183,109.771650849409,292.245600385903,182.843201999353,225.620357419527,265.150265597891,0.00626199617706902,98.0686494121877,241.464856350668,1.29994931492013,0.090753567783609 +562,gene_562,44.8892876684121,106.813542731898,107.167278216771,123.091609405516,95.550231586058,116.719043901347,111.949628024115,94.5555252700802,0.642021230150449,95.4904295056492,104.6936071954,0.132745299155741,0.976960798897723 +563,gene_563,90.8059251148286,72.7440275379385,105.109823567112,104.944398278049,79.7796459549678,107.154291105614,119.456076006175,114.691809166426,0.3508922317639,93.4010436244821,105.270455558295,0.172590021642613,0.919758854682739 +564,gene_564,94.7489124544654,91.4396519485663,99.423837848038,105.523985555862,119.675796048978,94.7604119182385,102.535155603189,64.774685771353,0.854387138938095,97.784096951733,95.4365123354396,-0.0350585309000616,0.97704151387307 +565,gene_565,101.59511657467,85.5216020871695,97.4554481338656,131.808860735807,88.8455708603215,87.5717812776679,110.533959678413,107.285316208633,0.651789346318721,104.095256882878,98.5591570062588,-0.0788425119286396,0.976960798897723 +566,gene_566,121.615939760636,106.584470564162,123.0616457406,101.419773295408,114.245322181355,117.235280299804,83.8707706442714,100.922154250923,0.371004801198973,113.170457340201,104.068381844088,-0.120965583785259,0.919758854682739 +567,gene_567,115.435155357049,65.9874317732863,93.6023020683081,101.652928048099,72.0175790691255,67.4239064283181,82.9933617575737,85.3621608109345,0.201444010153741,94.1694543116857,76.9492520164879,-0.291351866674102,0.760743228338604 +568,gene_568,124.519309617224,95.250291933362,111.703331464114,95.7068531807281,129.1940526498,69.7039535894455,125.384754240731,53.4429288441563,0.581039149387963,106.794946548857,94.4314223310331,-0.177504475900953,0.976960798897723 +569,gene_569,108.028623747783,132.710084438921,83.3718077210155,117.499517688792,92.2132677295453,120.517478825565,103.291902628993,65.4806848743574,0.370162043486743,110.402508399128,95.3758335146151,-0.211077286019095,0.919758854682739 +570,gene_570,92.149426926439,118.773387933921,120.54064742667,100.625939595456,109.297687668583,120.798956099522,91.9579428103943,113.922331937712,0.920033562316905,108.022350470622,108.994229629053,0.0129219123740164,0.989971080047645 +571,gene_571,102.459867985911,91.7090969591609,68.743648819813,119.120138370088,117.022228704855,121.465705660322,87.4663319817548,103.564753033443,0.400794712388516,95.5081880337431,107.379754845094,0.169025688675982,0.924314844197119 +572,gene_572,114.163747566545,94.6849812011885,88.5701563835298,83.9600942114224,118.399730364305,63.0851024329703,124.266538814494,118.800827555275,0.531965030738206,95.3447448406714,106.138049791761,0.15471661748197,0.972014394251591 +573,gene_573,89.2364538979078,121.496449380233,87.4762586193201,115.219365804055,103.44537641515,97.8160169519862,82.4705797259432,131.456223562437,0.975028896169865,103.357131925379,103.797049163879,0.00612748793307662,0.997693106634484 +574,gene_574,110.644953478238,136.906073333665,108.465634499395,110.362369468652,118.047995972509,131.780630107715,63.7139372946785,125.753513473553,0.71089274291569,116.594757694987,109.824019212114,-0.0863093084533631,0.97704151387307 +575,gene_575,79.6225476327339,123.529509952755,125.522473494284,86.444965759265,101.758089706784,95.0099672531515,86.7441142602631,127.413252057328,0.94647601468426,103.77987420976,102.731355819382,-0.014650101891237,0.992641973777354 +576,gene_576,80.2505467631719,91.5456239352049,75.1469995136663,125.610838447842,101.09255701813,80.6505964415734,122.902454191437,123.007354531247,0.40115264238155,93.1385021649712,106.913240545597,0.198990946687531,0.924314844197119 +577,gene_577,87.8183950531373,82.9709776448952,62.7901823507574,101.887056732327,134.102614591119,102.188384850361,110.188773063158,82.4577006044908,0.135483675609906,83.8666529452793,107.234368277282,0.354598173666339,0.679258489118046 +578,gene_578,126.21354646526,104.552163849776,82.5258890144802,84.9587886310127,110.935796929115,90.770139591219,81.5433964234793,125.328435950461,0.861364033907052,99.5625969901322,102.144442223569,0.0369349406243368,0.97704151387307 +579,gene_579,103.783012583272,131.351540534769,100.979979307701,89.6539853178223,112.437449052788,83.1926111985624,84.458622203199,85.6719961166904,0.234673846155726,106.442129435891,91.44016964281,-0.219169292500994,0.818289875612779 +580,gene_580,93.1025198136645,53.5165069121558,133.248228545829,108.845188794609,88.4317739106346,88.5824747483208,97.6975683117021,140.188002826156,0.764450481876579,97.1781110165648,103.724954949203,0.0940597363949055,0.97704151387307 +581,gene_581,132.170400504065,103.999377151775,78.4321702422436,82.0041471318413,99.5760852205477,113.746918504256,80.1150539120869,76.7394963653172,0.67896170767495,99.1515237574811,92.544388500552,-0.0994894300804149,0.976960798897723 +582,gene_582,91.6856104008144,104.139485349885,69.654052509996,72.9202582640456,82.2532863929196,60.7902757643318,77.0768154980785,101.050585461854,0.723378241353326,84.5998516311853,80.2927407792959,-0.0753855727837702,0.97704151387307 +583,gene_583,76.6332329644249,76.2219338589341,83.0916244962003,88.5809463198117,91.6265767435072,66.9928827932706,99.9074949432722,119.287047567828,0.310800594605659,81.1319344098427,94.4535005119696,0.219334378224757,0.9106092231063 +584,gene_584,104.072364781607,119.697247272448,81.0806111414016,76.9652120401058,118.324062901827,111.589154125592,112.813291745201,93.4048110168849,0.291648455347814,95.4538588088906,109.032829947376,0.191887171860884,0.896912120687058 +585,gene_585,100.601097152811,109.427132820125,99.4462492618025,92.9381420430142,128.850226753188,123.82171840425,56.8035134492685,103.526375808401,0.883842757412269,100.603155319438,103.250458603777,0.0374726350545661,0.988530250143975 +586,gene_586,95.2306135491493,115.573159040951,105.848152533333,77.4645238815636,109.391507822733,91.481494526658,102.183108516047,108.738312884508,0.652041460896688,98.5291122512493,102.948605937487,0.0633023304307724,0.976960798897723 +587,gene_587,89.0485508344309,113.678978204055,154.489395006014,91.4652914056996,82.9393605437893,96.9263109927504,110.244505589368,99.6011448520082,0.415743425915658,112.17055386255,97.4278304944789,-0.203288155011845,0.930988787286778 +588,gene_588,115.017027132965,85.7848115095729,101.526349837374,145.768050156925,31.0668056660103,35.092383920237,32.7845574775514,33.5547927885272,0.00831131896874706,112.024059659209,33.1246349630815,-1.75783215530534,0.108636064222392 +589,gene_589,92.9834388639958,110.34307354873,88.0426119176892,96.4056500801817,136.50563845632,103.220389927648,129.587498389747,75.8736551394037,0.385824335226884,96.9436936026493,111.29679547828,0.199193098309298,0.919758854682739 +590,gene_590,108.385486334565,82.6505347381428,97.1429834235237,126.220256462653,76.089761115351,144.326289954779,120.322768792339,73.3362519437382,0.996880771745503,103.599815239721,103.518767951552,-0.00112907808546586,0.999453122312829 +591,gene_591,93.0806135889127,127.87082471128,97.6076936485377,115.205435427037,103.004696496515,68.0346255502978,92.8267663725569,87.0455952918011,0.106380255070741,108.441141843942,87.7279209277927,-0.305804225888143,0.611375107177026 +592,gene_592,112.910045817166,109.977862482067,97.661400118741,86.0346653249664,94.2985634142929,110.744358253249,92.6789553440131,96.7596874848421,0.699500209977009,101.645993435735,98.6203911240993,-0.0435954701904292,0.976960798897723 +593,gene_593,126.663974112731,86.2529590172853,112.650628658374,146.061271262917,110.771327576257,104.962643218978,130.626421600842,61.3064315879498,0.439275418208728,117.907208262827,101.916705996007,-0.210261365481125,0.950746766052417 +594,gene_594,84.2112170079272,105.778934065434,97.2927513399596,78.50653870228,84.3989319879255,82.6363948687896,53.5293951266007,84.1231175127259,0.170770996132779,91.4473602789002,76.1719598740104,-0.263681509565247,0.729535871197449 +595,gene_595,103.715882400659,83.4934011253207,92.7802012504166,99.9313625126835,296.129684398815,231.695533194559,267.079946399099,404.751769181401,0.0112835739628147,94.9802118222699,299.914233293469,1.65885111230692,0.13274792897429 +596,gene_596,102.691015186723,139.127722877022,70.1118121287466,83.5327660898423,114.635838361424,99.8953950741671,113.085582512992,62.4970754182893,0.947074080315261,98.8658290705835,97.5284728417182,-0.0196485030709475,0.992641973777354 +597,gene_597,69.1532093978682,115.706434631397,99.3574516458565,73.8141951479288,93.3136883014199,116.521765336849,89.948684305313,97.4786341698275,0.47009688995778,89.5078227057627,99.3156930283524,0.150007923317316,0.958914368513127 +598,gene_598,64.9105513019885,89.7422353390492,98.2660910495504,118.296995386826,123.304474385,130.04494742978,118.890320522775,93.5903910060228,0.138190188383428,92.8039682693534,116.457533335894,0.327545565785136,0.684109843482319 +599,gene_599,96.0990167710822,92.5859117078917,71.1923734851747,98.265281846452,75.0956734081665,101.693369715655,106.168289710078,102.514282935948,0.498949016121066,89.5356459526502,96.3679039424618,0.106090563152359,0.958914368513127 +600,gene_600,147.590356988901,86.4737844517765,97.489932310651,138.875994207949,113.623015798177,52.3522203010813,98.5701127920477,115.669152176147,0.325755943985448,117.607516989819,95.0536252668632,-0.307166718032787,0.919758854682739 +601,gene_601,123.777113218416,89.2278151555189,90.532050606308,102.566995225067,34.1692620182667,35.2694487597409,30.2648893176717,37.1679877428842,0.00289948795289631,101.525993551328,34.2178969596409,-1.56902614652737,0.058121808852825 +602,gene_602,106.312273120859,113.890171001325,106.333533111172,112.828807619914,85.7693044375861,109.309114100154,112.70644152091,100.644606757664,0.295236059137239,109.841196213317,102.107366704078,-0.105332286613355,0.900109936394022 +603,gene_603,83.338053640375,90.4724210212033,110.551069464503,84.3678196657036,70.7109914092074,66.6152701478333,80.7785984669078,107.101893899416,0.368434451888514,92.1823409479463,81.3016884808412,-0.181205090393683,0.919758854682739 +604,gene_604,74.1918114369193,100.576144401636,135.440699989785,110.83073871512,114.807574535299,85.3522973704773,82.0439081194298,94.4764906718303,0.484768559952379,105.259848635865,94.170067674259,-0.160614753812127,0.958914368513127 +605,gene_605,107.039101847543,134.159010650948,114.012045778305,87.7395576702589,34.2539052723624,43.0101801072873,34.9914522801324,28.3401514829318,0.00254634040047633,110.737428986764,35.1489222856785,-1.65559057195435,0.0553552260973115 +606,gene_606,146.381543380182,118.58564177842,133.336411924633,67.8857295342747,100.546057524814,112.486211918724,91.0654673504757,117.727966831458,0.577532295678005,116.547331654378,105.456425906368,-0.144268967085433,0.976960798897723 +607,gene_607,83.3262350964801,80.6660492633036,83.8739428996413,109.230038469508,326.52262708967,455.20448801896,204.994485581515,339.641675357169,0.0169222906914959,89.2740664322331,331.590819011828,1.89309101520006,0.17148539342323 +608,gene_608,75.1784184304149,100.352804250067,71.6713325128505,93.4544085166442,111.51815804855,67.538277507075,91.681469973574,100.896731217257,0.533844752992358,85.1642409274942,92.908659186614,0.125565270070166,0.972014394251591 +609,gene_609,117.028656239798,110.406740358496,91.7536939778027,131.908926082899,102.990358627911,124.225561318339,69.0417269402366,109.07802185138,0.45788775462213,112.774504164749,101.333917184467,-0.154323807695547,0.958914368513127 +610,gene_610,133.513911415819,93.2385087122683,107.176300106503,70.4153584495219,26.4765447496598,43.6551470031934,30.1123011343729,17.4651052244555,0.00743963050698559,101.086019671028,29.4272745279204,-1.78035764923461,0.100535547391697 +611,gene_611,112.383735365563,56.5455914031512,100.165690234051,124.096174012138,74.7981280496464,80.8465170556817,96.8429828600491,109.228668483439,0.658949455018192,98.2977977537258,90.4290741122041,-0.120372402783849,0.976960798897723 +612,gene_612,93.2439673577412,80.5502084035454,67.5322909566643,105.44638938238,84.4153043899354,131.454269337132,79.7851798501963,107.658339835407,0.369557840436684,86.6932140250828,100.828273353168,0.217909268106334,0.919758854682739 +613,gene_613,91.1590829493924,112.581597553073,103.861117873067,88.4023071024151,114.206990303651,142.978929511294,133.118224017271,80.3545799490351,0.279074621504819,99.0010263694868,117.664680945313,0.24916594873111,0.869815082780919 +614,gene_614,100.121603115446,134.062762557209,120.007937174791,76.3574749481072,116.240259221943,144.143686644231,86.0702623901588,135.441743461776,0.50171315137962,107.637444448888,120.473987929527,0.162541637700076,0.958914368513127 +615,gene_615,77.8739636291655,114.379042218132,64.2388010936036,104.640486061539,95.8200791897631,112.276680825261,108.821965564439,117.923325551528,0.216050741126783,90.28307325061,108.710512782748,0.267964027987202,0.788506354477309 +616,gene_616,94.0069160282804,117.762650242307,97.2431398835854,130.477455084614,322.91181157051,298.029604413837,274.813689139532,340.854870932706,8.46971692988698e-05,109.872540309697,309.152494014146,1.49248777578298,0.0105871461623587 +617,gene_617,92.5181731328317,143.79634701308,72.0449237803925,69.0156199131026,86.6226170346304,53.6249355244947,103.01240532779,78.4456405949078,0.520610599037365,94.3437659598518,80.4263996204557,-0.230258053085099,0.960536160585544 +618,gene_618,138.683016455532,122.930020395159,130.713040819545,77.0843916213737,86.6239603902026,86.1699382340679,99.563308664034,92.1365616837218,0.152284207347639,117.352617322903,91.1234422430066,-0.364955866875726,0.711320181265988 +619,gene_619,108.446473502594,96.3084945747404,111.9784226864,107.278992886729,128.749530951058,80.2297398332112,104.42645604673,111.419065547271,0.98572078935487,106.003095912616,106.206198094567,0.00276156236732376,0.997693106634484 +620,gene_620,122.087307998815,111.074972540963,118.87953631861,76.3296021867352,113.975353230947,126.224860437346,107.315204838626,124.807769389794,0.390318091871073,107.092854761281,118.080796974178,0.140912137225852,0.919758854682739 +621,gene_621,78.0380747123012,48.9056780233247,64.5646649242052,86.3877549479882,104.674128203243,119.825012586625,101.703676861483,74.1970159473101,0.051322763657684,69.4740431519548,100.099958399666,0.526895409798106,0.38300569893794 +622,gene_622,86.7692849640213,110.497131309455,100.717552594967,99.9191287787318,117.457637045629,112.190368833772,90.5419521301431,67.1253479295581,0.842251154026391,99.4757744117936,96.8288264847755,-0.0389086153898814,0.97704151387307 +623,gene_623,99.6293382668948,67.9863266412927,82.4420503292284,62.3458089523197,107.220168944069,91.3152739393515,85.2727990589006,99.9700478497405,0.125263865018163,78.1008810474339,95.9445724480153,0.29686237261603,0.652415963636263 +624,gene_624,105.829971002193,107.347628526434,124.601959434516,87.9389552220759,109.801262075161,118.905674006227,105.936110771504,110.091352014852,0.584963471530672,106.429628546305,111.183599716936,0.0630441638954279,0.976960798897723 +625,gene_625,89.59837303183,60.5592402153436,115.620710717816,119.214355692896,113.638965088426,120.226022702475,95.4574063680346,53.9660074826133,0.98384350688552,96.2481699144714,95.8221004103871,-0.00640067166921667,0.997693106634484 +626,gene_626,83.9866623720307,93.6594179085968,90.3402051436257,96.6583452780776,97.2873214898181,42.207638777395,89.6456204355,104.809190742144,0.62783835669848,91.1611576755827,83.4874428612143,-0.126860024092862,0.976960798897723 +627,gene_627,63.9676258957144,110.18098465295,98.8806812395671,97.2419191545568,101.71461707269,95.454979657976,102.784967020002,82.9006251922897,0.787568453945206,92.5678027356971,95.7137972357396,0.048216428192325,0.97704151387307 +628,gene_628,82.6563071200145,74.7129710939851,78.3065558550886,101.252104071318,109.800733540811,81.9264214803921,140.677728237151,91.7188547670441,0.196085403880007,84.2319845351015,106.03093450635,0.332045170205515,0.760743228338604 +629,gene_629,81.2181785096134,96.5809609262544,79.4507498928585,98.0659357372905,104.098878903489,117.629536933651,118.525692823717,90.6814068019655,0.0643705302775823,88.8289562665042,107.733878865706,0.278370057874754,0.435625239696705 +630,gene_630,128.517375171551,73.2358946643038,109.867301274419,63.2754782745941,258.751117728509,308.028048641379,259.150453203657,318.470220537892,0.000125274058999238,93.724012346217,286.099960027859,1.61002867335904,0.0125274058999238 +631,gene_631,83.7698865211548,120.847661412016,98.407164859417,63.0072991985123,32.3320670066878,33.1502199209335,21.7848419820815,23.0514078867848,0.0110110760677847,91.508002997775,27.5796341991219,-1.73029460053958,0.131084238902199 +632,gene_632,102.517529176772,113.728793509184,99.7235764801132,125.586595346924,100.063113978598,126.744351395047,102.843966434619,111.556177192644,0.992068397280671,110.389123628248,110.301902250227,-0.001140362237945,0.999453122312829 +633,gene_633,110.177501941298,103.035690051727,102.920974912077,109.650983421042,362.994496442876,271.835745141986,335.653854356499,349.378907385177,0.00145937569644027,106.446287581536,329.965750831635,1.63219065081235,0.0416964484697219 +634,gene_634,97.1830971102384,91.2820943215403,106.441441219487,113.881170176183,124.961145165855,82.2362350213301,92.1907599063555,105.155162354689,0.923651467999993,102.196950706862,101.135825612057,-0.0150580131499725,0.989992953448256 +635,gene_635,68.0890606115744,104.391187755045,111.621968125482,58.202841760927,136.892999290394,94.8884364641772,104.25016401725,89.7545372645781,0.265339586479711,85.5762645632571,106.4465342591,0.314846367292185,0.84773030824189 +636,gene_636,113.907368986791,102.942783819112,105.189666428943,110.552030259954,111.2609036106,95.3815179083707,78.5959081161795,98.994382699533,0.1714409297314,108.1479623737,96.0581780836709,-0.17102613296008,0.729535871197449 +637,gene_637,121.376297982036,110.557171406675,89.2928327367677,98.4746851501355,112.058609144047,112.148051132637,84.8242624543816,123.167642748006,0.781517041354976,104.925246818904,108.049641369768,0.0423324267966547,0.97704151387307 +638,gene_638,89.381514413898,128.426615585584,89.2120902807279,125.942221107545,120.000157847532,97.5896255713678,93.5320903492369,97.1814132607286,0.644343051788717,108.240610346939,102.075821757216,-0.0846006975488876,0.976960798897723 +639,gene_639,97.6371269157041,90.8829872931255,119.286741401299,108.486334772915,32.5360440214113,38.62265732602,28.1409475243295,46.5808523091751,0.000235516594174973,104.073297595761,36.470125295234,-1.51281289817887,0.013084255231943 +640,gene_640,99.1605299053147,112.392761412717,111.369265321941,128.81150978405,96.3419549236594,100.617368559888,82.8224804242785,117.635348193085,0.200407211135092,112.933516606006,99.3542880252277,-0.184819576097216,0.760743228338604 +641,gene_641,108.233935874227,67.9634087237153,102.002246437766,41.2756840832871,99.8563608066673,62.6113072552117,76.1458254529111,99.1445292380394,0.810865413805606,79.8688187797488,84.4395056882074,0.0802857560257801,0.97704151387307 +642,gene_642,105.977760771972,91.5852625082129,89.3390429884637,127.88543139411,120.377652704034,103.423690290972,76.7746697675357,73.6469728696792,0.504801715936974,103.69687441569,93.5557464080553,-0.148474234813371,0.958914368513127 +643,gene_643,83.1029812008982,105.276719549994,153.98327873495,107.203079520026,65.8518658758967,106.801210010449,105.561557645346,78.8035708998116,0.252539311919135,112.391514751467,89.2545511078757,-0.332535480738419,0.839001036276196 +644,gene_644,1.61311110438797,110.804916836753,121.70736760872,105.461937436732,110.490348174877,85.9321407934164,97.7163705192075,85.8750670132875,0.745201362784025,84.8968332466483,95.0034816251971,0.162269644820134,0.97704151387307 +645,gene_645,65.1807327389646,120.435018238079,73.8123892844979,99.1205535254042,64.6710211373194,63.9706141395482,108.45057112795,106.281293900133,0.837019334452483,89.6371734467365,85.8433750762378,-0.06239035748792,0.97704151387307 +646,gene_646,107.558441803484,90.3299788014821,73.5800490007582,127.938313582484,125.470515541712,104.498577979072,106.194152260585,103.365572413049,0.474523460763497,99.851695797052,109.882204548604,0.138098925863485,0.958914368513127 +647,gene_647,108.6484005879,107.931774403517,95.2067804824267,93.426481300548,94.3539758559406,51.5261865930163,111.575036083304,99.2847179654512,0.431256971772626,101.303359193598,89.1849791244281,-0.183809362835606,0.940801278082713 +648,gene_648,81.177202104915,112.853980301969,83.7397978717381,112.621930317026,77.6925371303986,75.2770928406716,83.0447040541185,94.2417963933675,0.191573424665261,97.5982276489118,82.5640326046391,-0.241341512362172,0.757207212115658 +649,gene_649,92.3409979725401,64.4696245175297,110.562462938815,67.734105223052,128.617766966339,103.516573607175,108.125793843,123.549984160679,0.0522013964801023,83.7767976629842,115.952529644298,0.468911650571548,0.386677010963721 +650,gene_650,102.074923063254,77.8344433032885,124.686530957096,82.4851219410414,93.2008685868488,88.1511698692513,131.658389519442,97.8295566832116,0.697021355580133,96.77025481617,102.709996164688,0.0859410315778916,0.976960798897723 +651,gene_651,83.6176344648455,88.7894821488851,119.21964500706,108.214390551783,76.0073818063846,92.840500158859,64.3973348936157,82.5017436802124,0.0906160904979411,99.9602880431434,78.9367401347679,-0.34065811744977,0.555926935570191 +652,gene_652,49.5464755392406,113.85821709811,102.447493224959,102.687950703245,104.820684662702,70.0203751172391,108.300946569927,101.788901364442,0.818452466648486,92.1350341413887,96.2327269285776,0.0627777684970433,0.97704151387307 +653,gene_653,90.5973007581063,117.372996916194,64.3568844394252,92.9003155914776,132.415806678156,104.234060357823,64.1376937293155,86.2181151659789,0.773927782903431,91.3068744263007,96.7514189828185,0.0835593366434545,0.97704151387307 +654,gene_654,99.1851724300571,104.322113191921,103.527863003512,87.7641766828711,162.779409884837,95.2888387592124,125.389625715534,121.125457702724,0.141005261665767,98.6998313270905,126.145833015577,0.353973026146547,0.690038245507954 +655,gene_655,118.819503417408,101.923732553127,118.43459529503,81.2380651034606,113.094383563504,104.783949109731,118.317183986985,105.593283815403,0.603425016484737,105.103974092256,110.447200118906,0.0715396261007832,0.976960798897723 +656,gene_656,96.6342305417938,95.2522222444856,91.578029673324,101.863067524925,135.48834592835,129.631279749968,87.8516391322789,113.959441112966,0.149985661587747,96.3318874961321,116.732676480891,0.277123126178223,0.704158035623226 +657,gene_657,114.670063390189,126.185227353754,119.554620251821,85.0538777202796,110.918023829774,98.8534173469445,106.071172952727,76.9722556352559,0.307965469978639,111.365947179011,98.2037174411753,-0.181458618329927,0.908452713801294 +658,gene_658,79.6948789839223,86.7621806662012,100.738106002032,55.5888222925487,277.343404808871,212.794571819706,233.652823572964,288.013357981991,0.000564200986005863,80.6959969861761,252.951039545883,1.64828915424728,0.0245304776524288 +659,gene_659,132.576105573715,127.782470373938,99.3304290276899,125.834005332923,124.810709101446,143.651574020416,108.197126008055,116.217592821557,0.868905726084964,121.380752577066,123.219250487868,0.0216879945740008,0.979600593105935 +660,gene_660,141.57342354477,127.528035840442,96.9478909620807,106.003477484548,143.874692115184,137.846870681533,109.672771248677,98.6757322120302,0.772430891510922,118.01320695796,122.517516564356,0.0540397070055505,0.97704151387307 +661,gene_661,81.4300517637582,118.960599494957,116.757187934473,133.554655083691,72.588584661878,124.638616990773,100.610486447613,119.340563940908,0.622309110989852,112.67562356922,104.294563010293,-0.111511483688839,0.976960798897723 +662,gene_662,137.523489138525,85.5778438871372,83.0669689099354,105.840347045533,95.7048970890635,144.852849638488,66.5509960107252,97.2126031898769,0.928613390334464,103.002162245283,101.080336482038,-0.0271722511857696,0.989992953448256 +663,gene_663,133.300596498545,107.570605489372,79.085466746545,118.777086895416,154.545535547579,76.7839727824412,77.6964692935552,127.87425479376,0.984492399195922,109.683438907469,109.225058104334,-0.00604183653959694,0.997693106634484 +664,gene_664,115.56200919312,112.922862831232,110.692142968126,117.225385068389,117.665189980789,102.609240481755,100.607301266753,107.198402953095,0.159879608434008,114.100600015217,107.020033670598,-0.0924254903239464,0.711320181265988 +665,gene_665,82.2214157123838,116.265205230701,119.937724653601,117.997469943756,97.3517038154328,129.103232301146,111.869407205458,107.542703553544,0.840121726971429,109.105453885111,111.466761718895,0.0308903570745988,0.97704151387307 +666,gene_666,104.191750456035,98.2191582859902,136.142055595287,76.494528656262,89.2022220166094,81.9249209185113,123.342579357093,87.0875254366324,0.610392753510946,103.761873248393,95.3893119322115,-0.121376899375053,0.976960798897723 +667,gene_667,120.686876348389,132.56091282071,100.118385412471,106.228136639357,95.9550783306314,117.594312123804,117.504940290046,105.21309190814,0.54287674384817,114.898577805232,109.066855663155,-0.0751481931296772,0.975593151676992 +668,gene_668,42.039149827064,151.258496147685,127.558266106399,117.930656507015,90.2126689165436,136.703254002337,71.0235413191086,152.34165876612,0.92787061193139,109.696642147041,112.570280751027,0.0373066322784165,0.989992953448256 +669,gene_669,91.7208712758751,107.002863977662,119.998258379844,84.9795924260035,94.3742649314804,110.254679478895,115.989462757998,105.108192256133,0.572207365174196,100.925396514846,106.431649856127,0.0766379777342554,0.976960798897723 +670,gene_670,80.4503237977303,106.693580373531,131.958113708646,78.7808170718409,103.93570587015,74.733572963719,62.7013957520589,135.981953704041,0.812384016249502,99.4707087379369,94.3381570724922,-0.076430338397834,0.97704151387307 +671,gene_671,115.383026579666,120.147714683367,121.76379975297,76.896481551611,100.673908162674,94.760103061121,112.656611171956,114.14007371661,0.809367216963139,108.547755641904,105.55767402809,-0.0402984305456671,0.97704151387307 +672,gene_672,84.4930138990056,103.893185169092,103.301330630589,129.096202542967,86.3936723078712,102.334894252913,76.9353419391149,125.508315936041,0.616843889909364,105.195933060413,97.7930561089851,-0.105274996266115,0.976960798897723 +673,gene_673,82.8044557459364,117.993582891873,121.0933869061,100.200069105176,106.914676093423,113.654409982056,119.013055262789,99.0342968361558,0.695056837153056,105.522873662271,109.654109543606,0.0554041228126482,0.976960798897723 +674,gene_674,115.717334949781,80.2992746999003,86.8886337408591,120.297595008618,101.021257948649,75.3603233125043,113.615548247392,108.037864058036,0.925003363164325,100.80070959979,99.5087483916454,-0.018610522874662,0.989992953448256 +675,gene_675,98.2276550334332,99.1286156730525,139.302174915547,115.296892436269,86.7684769823904,102.279336958005,98.8663991268846,65.709455996423,0.101560777432605,112.988834514575,88.4059172659258,-0.353965371720736,0.602693097509172 +676,gene_676,113.18717855005,121.87678273982,82.3342656938261,106.585578848623,109.553851157188,79.8538321258447,94.7800313176175,112.100846751059,0.562808698367462,105.99595145808,99.0721403379273,-0.0974578364230966,0.976960798897723 +677,gene_677,84.5816059234872,59.0936617268344,100.939272094511,111.839324855319,105.757554352047,103.908179011425,114.653771998978,93.8113901771086,0.279210641572675,89.113466150038,104.532723884889,0.230239285083287,0.869815082780919 +678,gene_678,107.198474999066,102.43104018328,114.195876033466,86.8004057290155,91.0128089412613,80.4999078460509,101.640623651436,87.7674924063475,0.142599960842698,102.656449236207,90.2302082112738,-0.186141845454741,0.692232819624749 +679,gene_679,96.3988876475218,116.599604905356,81.5620083267639,132.952265996026,95.2395038552081,81.1577310136154,99.6082021942245,109.877302319486,0.454897798798606,106.878191718917,96.4706848456336,-0.147804990788136,0.958914368513127 +680,gene_680,56.4166510444478,84.3996771966744,81.4278485141404,98.7261226498227,104.72623717625,119.153194556324,122.797302786276,104.537300878021,0.0252856681820011,80.2425748512713,112.803508849218,0.491372139193754,0.229869710745465 +681,gene_681,105.641977685972,138.535977775316,100.100489703643,86.2763094661859,116.808125875746,88.1813716152101,126.981089516194,80.5345936406063,0.783602725155436,107.638688657779,103.126295161939,-0.0617844818489443,0.97704151387307 +682,gene_682,110.1845594658,128.766197364206,90.158382704858,166.613689899327,75.983198860632,109.776945850809,45.0287405717556,121.540067741189,0.182006790729642,123.930707358548,88.0822382560964,-0.492610665735862,0.755040008590345 +683,gene_683,115.651948897211,80.1551366108029,92.0072237616954,97.4850521160281,144.72130199659,76.8128744208599,96.7730280260326,101.020536474946,0.622267706102033,96.3248403464345,104.831935229607,0.122098481030429,0.976960798897723 +684,gene_684,101.294322110778,134.680639531833,97.8487112236505,79.8802098241364,102.396599594315,100.797043826028,94.3189531360195,112.226068614989,0.938581180260375,103.425970672599,102.434666292838,-0.0138944578054354,0.99139661091521 +685,gene_685,116.839427976762,104.64774787106,83.4713072793859,78.4089127816696,109.194673280426,119.609998576259,104.42381836723,120.344232282077,0.147118290168411,95.8418489772193,113.393180626498,0.242606234460174,0.697243081366878 +686,gene_686,60.9100130310252,86.6567134070185,139.214401175193,83.608502460009,135.158747969188,98.2248187275064,114.714377244858,86.3534671862469,0.451654550991554,92.5974075183113,108.61285278195,0.230151128094017,0.958914368513127 +687,gene_687,118.100793762449,102.360643131941,105.125126955511,111.235506330254,115.494635148002,87.2962545183153,97.144724252508,102.278633397736,0.262418509659337,109.205517545039,100.55356182914,-0.119081563432569,0.84773030824189 +688,gene_688,104.696481633611,87.6091869560788,124.840654744816,90.4978745138791,131.01204747853,66.4249621152318,111.67789336549,134.641826503447,0.635814271180416,101.911049462096,110.939182365675,0.122458517041752,0.976960798897723 +689,gene_689,94.2283269654872,89.6870870685282,92.3318949026689,116.244620612027,320.269355962709,256.031408467753,426.572028239555,305.276087649567,0.00686472791769176,98.1229823871779,327.037220079896,1.7367918485795,0.096686308699884 +690,gene_690,82.5887331516445,95.1390640327296,109.234003697375,122.053703064184,218.242401675413,258.011447593551,312.446058833555,312.041374247426,0.00249015904853609,102.253875986483,275.185320587486,1.42824798304098,0.0553552260973115 +691,gene_691,115.648506118271,80.8493116049015,104.289539183095,75.5085233222125,285.844399108834,221.508171829215,254.030728998164,288.240656866078,0.000274922606383522,94.0739700571201,262.405989200573,1.47993315411377,0.0137461303191761 +692,gene_692,87.4756258943878,96.9468805355411,76.112670980803,75.4077902472966,119.694002483944,107.298876961241,111.019288326191,75.0205977812175,0.146933025490002,83.9857419145071,103.258191388148,0.298039903563929,0.697243081366878 +693,gene_693,74.1207417427876,66.3009248867676,101.935324864111,69.1039582066193,90.7198316832844,83.8693739348336,100.513683166608,70.4913890212363,0.442451620766688,77.8652374250714,86.3985694514906,0.150028037599818,0.953559527514414 +694,gene_694,125.327805010521,96.0817756980073,68.656948435965,82.8545204912061,84.2533310717237,87.8829194210991,55.2249596477967,117.969314970534,0.709010916752676,93.2302624089248,86.3326312777883,-0.110892367479729,0.97704151387307 +695,gene_695,134.42054291107,127.075078568169,127.875051198333,83.0913796983726,81.811012146299,123.975146555868,99.9431465942293,112.144272977741,0.395468011629238,118.115513093986,104.468394568534,-0.177131916945158,0.919758854682739 +696,gene_696,79.2943470115176,120.771521577798,79.2161628456133,111.193780925789,149.245440183738,108.83234531795,122.624726459484,101.033864615839,0.181877455275399,97.6189530901795,120.434094144253,0.303010683114085,0.755040008590345 +697,gene_697,102.869683224861,92.7346894476659,129.185971842028,97.2013988152675,333.763135620217,337.650751184216,376.017403667588,260.98588276728,0.00135986434072548,105.497935832456,327.104293309825,1.63253592370161,0.0412299694711023 +698,gene_698,84.7556818514544,94.1441849235725,51.5072693692848,101.074106349237,130.995203345589,101.390405992042,116.971331695296,79.8586055509123,0.166364565080446,82.8703106233871,107.30388664596,0.372775097827012,0.726177314590369 +699,gene_699,109.97346870765,121.015661118735,98.0462995469878,93.7592190424417,69.8511158002947,117.121775399276,114.586505987508,116.173010190955,0.926990730977317,105.698662103954,104.433101844509,-0.0173780446355823,0.989992953448256 +700,gene_700,109.626409338007,107.16268737904,58.0876638366868,91.9175826383041,104.849554412501,113.085534682381,101.41234812096,119.196466693446,0.231443713773581,91.6985857980094,109.635975977322,0.257749892862349,0.815523488873472 +701,gene_701,107.968478360357,97.8440188344705,83.9934639413407,128.823638458949,122.237729703183,88.8335206118486,116.187564675286,109.769661828204,0.713516675965419,104.657399898779,109.25711920463,0.0620529666450002,0.97704151387307 +702,gene_702,75.2402237027919,97.5383571499429,118.201875392081,117.130101737315,86.2930337395314,97.0848936898623,136.033234548799,103.844871482087,0.805683612458516,102.027639495533,105.81400836507,0.0525705995274423,0.97704151387307 +703,gene_703,113.079748170599,83.6218965461022,117.888542640877,107.62150239482,106.422854656407,104.50822676158,120.112251818276,66.7889213576664,0.674892540745948,105.552922438099,99.4580636484824,-0.0858062743971625,0.976960798897723 +704,gene_704,102.843264930353,86.1252894321219,99.7744405868079,123.60284901058,75.2197482532481,103.134116332854,91.7965967133782,101.386451666265,0.350208940372017,103.086460989966,92.8842282414363,-0.150349314059406,0.919758854682739 +705,gene_705,121.744682537025,121.168468034105,145.111642188644,118.616324385435,108.418025095041,92.9066801134889,79.8205745108718,110.705594688978,0.0241832227602287,126.660279286302,97.9627186020949,-0.370659449299379,0.221864428992924 +706,gene_706,100.650870204096,102.64070714911,91.6963325838476,120.002241709573,122.350934064546,98.8049873629808,91.1598544945097,100.893460205609,0.961870072590256,103.747537911657,103.302309031911,-0.0062045975536393,0.992641973777354 +707,gene_707,128.002423554776,97.9649888188374,114.705083711153,110.623967425218,108.933559380793,136.126078480866,54.7309372907816,126.191909721597,0.759223340302296,112.824115877496,106.495621218509,-0.0832813608532024,0.97704151387307 +708,gene_708,136.292612703797,86.3580766594883,111.629972851254,87.8282277456357,96.3093990159174,72.1749171696906,82.8938049772253,105.582542354811,0.293290263464668,105.527222490044,89.240165879411,-0.241850113583608,0.896912120687058 +709,gene_709,95.5512742327204,99.8449942419083,65.3183996470956,104.419355536247,50.5275675563495,134.347207350916,75.6501686040599,107.940817184046,0.969183112302047,91.2835059144929,92.1164401738429,0.013104457368921,0.997693106634484 +710,gene_710,114.934913537648,91.8746577657023,79.65660832252,108.197813114509,143.360026356607,88.0918278013576,94.2857341317661,95.273075235387,0.680442899607326,98.6659981850948,105.252665881279,0.0932318742837006,0.976960798897723 +711,gene_711,87.2300876501565,105.150325675629,73.8473967917091,115.510678702818,50.3993934543164,107.753058223297,101.315803253898,107.872507932527,0.837543362215291,95.4346222050783,91.8351907160096,-0.0554656566269391,0.97704151387307 +712,gene_712,74.9175396183141,84.6714803435336,104.305023076415,94.2136299578598,59.3745487574765,121.163323117248,63.7792537639723,92.4537041939986,0.750144180164024,89.5269182490307,84.192707458174,-0.0886262493820717,0.97704151387307 +713,gene_713,96.649957362248,102.303580078185,110.817296122854,120.122482557174,61.0622204682074,128.24687870998,71.0438238733722,81.0097887529695,0.237522496155005,107.473329030116,85.3406779511322,-0.332673203267021,0.818289875612779 +714,gene_714,73.7731941606672,85.9193372794261,82.3138858077901,119.907758135592,98.9912849616172,80.4423766544348,76.11551889721,96.9612163517181,0.848566562981451,90.478543845869,88.127599216245,-0.037981807340958,0.97704151387307 +715,gene_715,107.032738108464,89.7950334108446,70.0085439643651,130.411227985852,37.3839642597194,24.0119186812048,39.2576510142216,27.79448993106,0.0103937717560446,99.3118858673815,32.1120059715515,-1.62885360294126,0.12760205427247 +716,gene_716,103.962950932076,133.489279331687,127.75761620696,91.7441417116728,96.9806806259444,77.2427658079634,125.485001521836,86.5456413108236,0.26464973198272,114.238497045599,96.5635223166419,-0.242498697205346,0.84773030824189 +717,gene_717,111.84072986147,102.151295412481,83.963862193487,91.8034170292591,122.577596172285,129.637295030091,94.8893206517353,115.419882261622,0.110503735991534,97.4398261241743,115.631023528933,0.246945057473495,0.624314892607537 +718,gene_718,95.8874103667545,126.664945244159,116.049985225005,106.167734509194,110.763177983281,117.669962633932,75.0195524823496,99.0423154305773,0.395521660833642,111.192518836278,100.623752132535,-0.144088833090207,0.919758854682739 +719,gene_719,100.590683801985,124.765899873572,113.036485225629,69.255258224197,85.7551669621889,115.423003813781,64.3825257239386,72.8360706819159,0.330920301569237,101.912081781346,84.5991917954561,-0.268609308640104,0.919758854682739 +720,gene_720,110.478085012807,135.43604448774,55.91199326511,131.632190383223,89.0276182540128,111.022152326189,106.100724925241,104.683790828527,0.782477766581685,108.36457828722,102.708571583492,-0.0773366649064627,0.97704151387307 +721,gene_721,87.3803325858503,72.8847204805401,102.17370141855,95.7578067863947,298.107152590481,202.719054829831,363.503664761971,398.829441675629,0.0124601072850828,89.5491403178337,315.789828464478,1.81821321563974,0.139167300763332 +722,gene_722,84.0748783312249,106.444421039819,103.265487051844,109.053321983511,142.120050125629,96.4652625183423,100.188221317725,95.8179604763338,0.558208230962396,100.7095271016,108.647873609508,0.109459770770723,0.976960798897723 +723,gene_723,125.451426058344,141.054786499562,58.3778048389106,123.447689608663,75.5649509856285,117.384203954037,107.562531857672,90.2082120998376,0.518176734226002,112.08292675137,97.6799747242936,-0.198431801440877,0.958914368513127 +724,gene_724,84.4219933589568,99.3122045907729,108.665919120893,89.7394518830637,68.2747472485807,99.637160788927,81.1890180736125,137.857758392267,0.944040602567463,95.5348922384215,96.7396711258467,0.0180798878829702,0.992641973777354 +725,gene_725,117.284890459056,145.218214895669,75.4355292498099,81.1772861496265,69.6789695889367,89.513832316266,117.638056143477,85.2547507941274,0.490625256511661,104.77898018854,90.5214022107019,-0.211018487688039,0.958914368513127 +726,gene_726,93.5680769641234,101.663299454503,72.4449431693962,102.825856449769,85.6314379887502,75.6089217421862,147.164500985626,93.8314947893153,0.672390168125168,92.625544009448,100.559088876469,0.118561467468749,0.976960798897723 +727,gene_727,62.6352857630904,86.0869362876847,86.3654597599878,94.4363165320329,108.402260791831,82.4668010555048,81.6040185983802,87.150390384972,0.449748210439442,82.3809995856989,89.905867707672,0.126103644793753,0.958914368513127 +728,gene_728,105.898594038117,127.549473198484,89.222952401763,77.3599529982012,83.4593787228628,67.104342526571,105.270002982201,130.286253204765,0.849363760085281,100.007743159141,96.5299943591,-0.0510625061324985,0.97704151387307 +729,gene_729,124.786531655571,87.1501200233724,82.1720350537602,100.458236828318,113.521261274547,110.940538548114,108.790940611994,72.7062508701247,0.840578987822745,98.6417308902554,101.489747826195,0.0410639778805804,0.97704151387307 +730,gene_730,87.5678706254993,65.2705510662666,95.8968753611043,90.4918851403157,67.639919966656,146.443135441947,79.8129542965499,125.642199530333,0.371787779312083,84.8067955482965,104.884552308872,0.306550432045586,0.919758854682739 +731,gene_731,60.6665803459069,93.045615469477,104.300954611144,70.8885901884415,69.4438455375133,61.3766968570736,112.764419300659,74.5442827138183,0.86495548107353,82.2254351537425,79.5323111022659,-0.0480436437988196,0.977350826071785 +732,gene_732,134.36471164793,104.232958393155,89.3541018366083,100.32619314287,326.365526128564,225.2326586283,226.532266124798,273.677074573715,0.00396699929283492,107.069491255141,262.951881363844,1.29625136681123,0.0698916679642577 +733,gene_733,107.156743741256,106.487741890582,94.5731685878505,136.171634671849,142.301239468106,81.552436931705,86.8839469698775,66.1843285337128,0.414828012226478,111.097322222885,94.2304879758504,-0.237558223999495,0.930988787286778 +734,gene_734,72.4097545041956,90.7427654633321,101.469699346696,92.8839245683655,301.326442714104,331.503577033609,303.181319294055,405.677366323618,0.00136546425083319,89.3765359706472,335.422176341346,1.9080100400446,0.0412299694711023 +735,gene_735,88.8738938570707,157.399118935177,118.356813066823,104.697479434252,111.21721154908,94.7550748130167,114.22565308131,83.6313759814812,0.368013007886965,117.331826323331,100.957328856222,-0.216848753383413,0.919758854682739 +736,gene_736,103.287446754284,122.069057941324,113.02323359573,129.775046196703,250.617920586722,276.384673764682,296.080675498572,384.51181453055,0.0066376440389526,117.03869612201,301.898771095132,1.36707928201849,0.0948234862707514 +737,gene_737,102.296100125603,103.06105802913,110.014057258732,91.3875717064136,97.6642415755781,92.9600078400998,126.881433465733,73.3380664205033,0.752333109419111,101.68969677997,97.7109373254787,-0.0575815472774682,0.97704151387307 +738,gene_738,146.250459626704,81.7726649968296,75.2914436582962,102.664232025424,73.6214190345142,101.414438533799,100.997033743824,104.206111619485,0.731865954895534,101.494700076813,95.0597507329056,-0.0944978699895073,0.97704151387307 +739,gene_739,110.660497645178,85.1956171298689,137.36887350216,99.1868405007807,87.7268778954464,96.9095199898079,87.7692787439093,150.500798286436,0.903393662330078,108.102957194497,105.7266187289,-0.0320673401049594,0.989971080047645 +740,gene_740,77.9306819771878,98.447056957701,103.795531229749,70.9732309212802,132.985666611117,130.030730120022,124.154667244443,102.362179515439,0.0169770539488997,87.7866252714795,122.383310872755,0.479333774620787,0.17148539342323 +741,gene_741,98.1599385191861,133.033699916192,112.318419609868,99.2883489675602,86.4553755818163,144.81712160714,92.0261485096307,123.793195907334,0.949077764796181,110.700101753202,111.77296040148,0.0139146720514827,0.992641973777354 +742,gene_742,98.7879704554382,76.1326735284644,98.8287472099428,87.4847598772645,92.3971318059135,107.558817670582,119.215638613206,123.978041095171,0.0634395617960878,90.3085377677775,110.787407296218,0.294859614448863,0.435625239696705 +743,gene_743,109.552906692905,95.375777531603,81.877743692408,76.6462534729855,77.1877799680589,126.426846513696,74.8414711556664,55.8841069928869,0.684816324732374,90.8631703474754,83.5850511575771,-0.120450698684775,0.976960798897723 +744,gene_744,80.2110783096497,130.13774081131,96.7299733891126,157.382434085043,215.708395963086,322.254850250925,343.898027218902,254.219774780546,0.00501405342652065,116.115306648779,284.020262053365,1.29043569062042,0.079385983280146 +745,gene_745,108.635072376673,119.334936389082,85.8534606601628,103.022994038809,99.4542641511128,89.721530878303,72.9875802151495,83.8116936874835,0.0966937636154916,104.211615866182,86.4937672330122,-0.268848014885425,0.582492551900552 +746,gene_746,126.6633452194,94.3222648789607,108.594464597858,116.153246839524,79.7633224458202,127.609743577212,116.129041579044,94.9636793010594,0.613329624769052,111.433330383936,104.616446725784,-0.0910711409028977,0.976960798897723 +747,gene_747,114.372765749286,59.5044507515812,122.535249207837,82.1722225394803,91.9981064835249,94.7035154653174,80.9998438823743,75.9422818196676,0.601338656484243,94.646172062046,85.9109369127211,-0.139702352013095,0.976960798897723 +748,gene_748,96.77602571399,86.9372423152628,130.89659669336,116.021187082469,76.7820024729471,77.8191518451851,86.4239170758954,132.548678337126,0.422572146400904,107.65776295127,93.3934374327883,-0.205059269286968,0.934894129205539 +749,gene_749,144.103134720524,83.020930334287,120.497939032367,79.4662524914026,21.946536938696,43.7790340353044,27.6691419290821,36.10979610913,0.0132994918837692,106.772064144645,32.3761272530532,-1.72153189979979,0.144559694388795 +750,gene_750,115.975085547853,71.2677881444403,125.317068951873,96.5816543326547,99.9793149596144,84.5042952034842,119.784885210221,120.66110879827,0.79898298279284,102.285399244205,106.232401042897,0.0546236355248828,0.97704151387307 +751,gene_751,104.947831810214,77.4852099029584,120.214706988992,87.170624179926,80.6673087521191,89.4485355545193,66.6473383589604,110.963068250898,0.458008791856023,97.4545932205226,86.9315627291241,-0.164850104531401,0.958914368513127 +752,gene_752,89.8494332492959,100.152303582359,100.06924874393,75.2972510845816,91.840671736971,62.9655467592066,65.341843592609,117.1838233951,0.642608757673508,91.3420591650417,84.3329713709716,-0.115182526442599,0.976960798897723 +753,gene_753,85.2344650368912,96.8783893392298,109.813572485943,92.3498774991699,119.374597848414,103.164240038658,109.078643294563,101.489859442632,0.115037109685779,96.0690760903084,108.276835156067,0.172580606272439,0.635564141910384 +754,gene_754,89.1090237861611,59.0014917399403,113.319823256526,75.9418874454936,106.565206382247,115.273883345088,121.411132684318,108.868974318831,0.0830991639203454,84.3430565570304,113.029799182621,0.422361964648272,0.523721344412532 +755,gene_755,118.753978013116,65.8840230913664,91.425413859862,96.9883435612979,106.991162489804,129.94781607969,98.6896602352659,102.341220850003,0.263805255886892,93.2629396314106,109.492464913691,0.23145578040872,0.84773030824189 +756,gene_756,106.406777269602,60.6273500676845,107.425799349491,114.124195599983,67.6243783535749,57.5862902684137,122.885748941104,111.988268035666,0.738018439418597,97.1460305716903,90.0211713996895,-0.109890709977291,0.97704151387307 +757,gene_757,98.2410165048703,96.2661060903292,113.927089402425,68.9502213806385,112.475843047852,99.710365846879,71.2747217726488,107.202784787702,0.808353497222094,94.3461083445657,97.6659288637706,0.0498923504863382,0.97704151387307 +758,gene_758,128.282822094946,71.9692890366709,107.365032103139,94.6851147044396,58.6566658907523,103.756506378389,105.048823929132,99.9015704785306,0.609244655507948,100.575564484799,91.8408916692009,-0.131071281075709,0.976960798897723 +759,gene_759,97.0254226793745,83.0947198679131,76.848756896699,107.647012437391,101.807561783803,82.0304063848836,116.18549977658,83.1226203114584,0.681027249578459,91.1539779703444,95.7865220641812,0.0715170543997597,0.976960798897723 +760,gene_760,108.414644310969,89.0341249927137,119.561142486292,77.5660162927589,102.427677963347,87.7712804886472,94.4110996714745,96.6426361928334,0.755519182230402,98.6439820206832,95.3131735790755,-0.0495554110253327,0.97704151387307 +761,gene_761,110.726017062191,112.200348488987,88.4883860263765,63.7787005303512,111.440585636337,117.257330439484,65.6019254505891,88.2253786606911,0.914676631523143,93.7983630269765,95.6313050467753,0.0279202188562787,0.989971080047645 +762,gene_762,83.5948746318112,116.701227017646,86.0726224528632,87.1291732124651,101.580808935736,120.390952287198,55.6613938065692,100.980828289943,0.938852590536704,93.3744743286963,94.6534958298616,0.0196275738829182,0.99139661091521 +763,gene_763,116.748650466877,78.4311802487005,92.9418052481027,62.6472527139903,103.032153127034,105.47880686376,76.53975496903,122.312460285834,0.379837470993527,87.6922221694176,101.840793811414,0.215794775539956,0.919758854682739 +764,gene_764,95.2516439713116,78.3450416332818,134.743771396424,113.264434605271,106.808670735508,94.0490063897591,68.1710571499705,102.350955922737,0.434084933966164,105.401222901572,92.8449225494938,-0.18299668557902,0.943662899926444 +765,gene_765,115.340976263103,83.1036966836165,68.2944587702677,91.9203418782602,103.729323938826,105.621602445868,78.6977966542586,95.3230698255661,0.617167846165349,89.6648683988119,95.8429482161297,0.0961294540559639,0.976960798897723 +766,gene_766,67.8271683430962,84.5433029249714,115.842141699734,106.587527297291,102.357229651475,72.4896396919017,88.9044412647593,86.3450983496665,0.64191430434488,93.700035066273,87.5241022394507,-0.0983692292174928,0.976960798897723 +767,gene_767,87.9125898900418,104.845723757866,132.674078714374,146.088133528076,87.195786938815,142.990805562217,105.341457812935,94.3043730826498,0.585835863245755,117.88013147259,107.458105849154,-0.133546261450646,0.976960798897723 +768,gene_768,89.6726819847495,73.4792408843032,106.144940506485,81.2360551196945,84.2643851730925,138.64685243604,82.5386911065055,88.0802057125734,0.513807698953614,87.6332296238079,98.3825336070529,0.166924179936821,0.958914368513127 +769,gene_769,102.589051771003,101.08765120555,143.433483051988,73.4678780343025,104.07596217919,102.006418767727,120.541939481993,70.1593181299998,0.751274444741153,105.144516015711,99.1959096397273,-0.0840210687363371,0.97704151387307 +770,gene_770,78.9033238752681,119.440730138637,103.13420564849,111.433660059079,105.623148670295,116.37779948981,90.6900806673221,68.5319368842892,0.581247904147529,103.227979930368,95.305741427929,-0.115199033072649,0.976960798897723 +771,gene_771,105.617454326308,111.159826482296,122.537595326203,104.803439370716,113.561540159601,136.933604385349,103.085145171085,83.594562515373,0.890872711295247,111.029578876381,109.293713057852,-0.0227336547671922,0.988697459677835 +772,gene_772,112.936925431403,113.002650291719,96.4566259944946,92.1970246236432,245.894426779739,287.633209406568,194.218955725843,343.293895895138,0.0125250570686999,103.648306585315,267.760121951822,1.36924456744737,0.139167300763332 +773,gene_773,95.2128994564736,116.871343831061,89.2844735732152,105.390707852788,46.7856896721236,120.887038732375,92.496651299714,111.981725460801,0.649960990461818,101.689856178384,93.0377762912532,-0.128287253593251,0.976960798897723 +774,gene_774,64.7072811093106,80.4719059824215,77.702817126405,95.1764665422818,106.774645648093,132.191807042728,88.4682528316712,93.6371164451709,0.0759334405857583,79.5146176901047,105.267955491916,0.404774323989299,0.493074289517911 +775,gene_775,81.735947329373,117.90072487067,93.0243051115203,104.767307573719,33.0493486699508,39.9722417312175,40.1678197702181,33.4916567023196,0.00279376615249186,99.3570712213204,36.6702667184265,-1.43801188800202,0.058121808852825 +776,gene_776,121.781094319626,100.974061006179,89.0283381101767,82.5231672430861,380.52020512681,331.414680847207,158.130291817231,214.22792820952,0.04173496397172,98.576665169767,271.073276500192,1.45936481263183,0.327770356152906 +777,gene_777,124.482582919379,112.113607264838,105.841822342479,126.148053647765,107.00830487101,95.9891932573913,104.504346861619,126.95914817509,0.340338398485026,117.146516543615,108.615248291278,-0.109087400396999,0.919758854682739 +778,gene_778,77.1957519094571,73.625957043377,52.2237906399143,116.768617824145,79.6507585521344,82.98794861455,109.550423879737,96.2257011798413,0.461472964390877,79.9535293542234,92.1037080565658,0.204097520404361,0.958914368513127 +779,gene_779,99.4364302362531,119.731307472267,101.721589921067,117.556485769125,100.726271693696,80.5026497852933,122.455720343391,98.265157166498,0.40697082122977,109.611453349678,100.487449747219,-0.125383224938473,0.930988787286778 +780,gene_780,112.773085615013,91.7635755636531,120.326782351796,66.6721912632432,106.263313028092,110.267004191383,84.7278905962761,94.8145988296557,0.936075474180634,97.8839086984264,99.0182016613517,0.016622035507578,0.99139661091521 +781,gene_781,74.7074781253946,114.618380395088,102.17481947226,132.560799197441,80.0390317755138,95.9079491160458,79.2858757865863,76.9004752585139,0.154340562207756,106.015369297546,83.033332984165,-0.352510916054457,0.711320181265988 +782,gene_782,92.7232567070597,94.2739896427442,87.90780201069,101.112152982413,49.8428982790745,51.0074464279221,117.359273423255,99.9057866936171,0.463650422045349,94.0043003357266,79.5288512059671,-0.241248424706476,0.958914368513127 +783,gene_783,86.0257266968402,87.2605986905988,112.861635576616,86.505798987727,132.027813343656,121.60030056013,119.377216081706,91.3251969982715,0.0837212435345732,93.1634399879455,116.082631745941,0.317316316639,0.523721344412532 +784,gene_784,102.048029708371,104.130113367464,76.1837420757543,80.8121976898648,137.972754534394,91.3685907426651,65.8048213677819,96.4300121490305,0.688975129214221,90.7935207103636,97.894044698468,0.108631751087464,0.976960798897723 +785,gene_785,77.3847016745546,110.945789405991,85.9747912873681,71.6533307727398,132.224473074757,79.7549749920623,77.5872888920256,80.6792318594504,0.716422711188381,86.4896532851635,92.5614922045739,0.0978845684719941,0.97704151387307 +786,gene_786,68.0721320492802,106.618406888193,81.5296339435046,96.45939656824,33.9345540833489,27.2634720386328,31.8307057062809,27.726137197369,0.00532129597998683,88.1698923623045,30.1887172564079,-1.5462766416241,0.0818660919997973 +787,gene_787,95.032422022902,88.0536746461417,90.7190813531479,95.1413925393426,102.789423192291,90.6122802140865,128.634449944458,85.1494985270829,0.39858409098527,92.2366426403836,101.79641296948,0.142274819828538,0.922648358762199 +788,gene_788,68.6615044792668,77.9303529758896,72.6748696132488,101.250109912719,104.230882420381,58.939570088231,107.882974730076,79.1571199927909,0.608205041669228,80.1292092452812,87.5526368078699,0.127822389178962,0.976960798897723 +789,gene_789,94.9136294972279,94.0095598048198,90.3756736896492,79.668812648212,96.6376263222384,124.776048611169,110.101618213397,65.9954044961865,0.505698907620782,89.7419189099772,99.3776744107477,0.147139748191859,0.958914368513127 +790,gene_790,68.8270077569429,99.8801567047872,116.680918568264,122.960358223489,83.6178291264744,106.362876865294,104.632148972267,102.182667811223,0.837330668043315,102.087110313371,99.1988806938146,-0.0414049734323833,0.97704151387307 +791,gene_791,70.3167961908202,78.6515815116065,73.9511084415703,143.5518267503,82.3906841242903,99.4524864397928,88.1171185376254,110.457755621534,0.860067562174081,91.6178282235743,95.1045111808106,0.0538854108495095,0.97704151387307 +792,gene_792,90.9371799262594,95.6557352895549,73.0538184117971,103.75275848584,143.538514163826,95.399858575554,92.1581768544206,116.565607864487,0.184030203731992,90.8498730283629,111.915539364572,0.300853963770652,0.755040008590345 +793,gene_793,126.511709639664,82.5238112626357,154.408219760749,122.971130132183,101.541529353618,98.8567331455445,124.345823581739,72.6294848466795,0.271601514164977,121.603717698808,99.3433927318951,-0.291691412867626,0.853427112583127 +794,gene_794,83.2600714833711,92.684935242953,104.429586231901,137.500660350062,86.6728552512052,79.0927567590972,62.4546616816381,88.9585622209693,0.123372111731255,104.468813327072,79.2947089782274,-0.397775815448938,0.649875266900961 +795,gene_795,79.8928840700252,98.3146392648175,60.7071037744003,94.8295551149564,89.5097683638636,125.312013917198,127.327428358334,93.9162887871776,0.10185513347905,83.4360455560498,109.016374856643,0.385802163788584,0.602693097509172 +796,gene_796,88.990672761723,124.832724935813,97.8725064326229,60.0200837043112,45.4017726670869,38.5814181512545,26.444205232528,36.020957417352,0.020067683063081,92.9289969586174,36.6120883670553,-1.34380876816737,0.194831874398845 +797,gene_797,164.755090749786,86.5407041714435,107.252695929666,114.352964992178,151.981895206499,81.8003538797639,118.319295295512,107.516777921129,0.88537327565395,118.225363960769,114.904580575726,-0.0411032722172184,0.988530250143975 +798,gene_798,80.4515962905776,93.9501121652212,114.343461783421,107.135766707512,138.136616266481,125.006827377723,97.8486693095144,88.2766666909795,0.376922174653927,98.970234236683,112.317194911174,0.182512212098917,0.919758854682739 +799,gene_799,114.604722514614,103.665334527489,148.894018731753,109.580786504249,98.2014531830908,84.1446117142537,54.6888022823987,90.5513834674939,0.0366739078139173,119.186215569526,81.8965626618093,-0.541342585291822,0.299981347693748 +800,gene_800,93.3839718744509,81.68505484193,106.991792731842,91.0728997155492,103.698592266629,87.3782855442535,62.6533263815201,113.431665052011,0.908656033037798,93.283429790943,91.7904673111034,-0.0232765000594863,0.989971080047645 +801,gene_801,126.084190968623,89.4827077288206,80.79774309028,110.908897525692,90.0965877840845,111.587477678874,124.654901974225,138.560760349115,0.36027162437561,101.818384828354,116.224931946574,0.190921496065458,0.919758854682739 +802,gene_802,104.174107013954,105.662618849252,79.4833266680465,96.6882452344774,78.6092963723835,100.362090137464,99.3915168939507,117.951497425424,0.806694014701599,96.5020744414323,99.0786002073057,0.0380135308061442,0.97704151387307 +803,gene_803,111.923298349685,77.0043802870663,130.36874969322,93.0206914141345,90.7890774370489,111.14611091232,127.213710564521,101.643542620884,0.752613868258963,103.079279936026,107.698110383694,0.0632385729623678,0.97704151387307 +804,gene_804,97.6484504901657,85.9585197948641,103.127840360328,80.1489561975926,91.8006744182908,156.492989821837,85.2861045662934,67.1655446098762,0.69969397170181,91.7209417107376,100.186328354074,0.127362576194404,0.976960798897723 +805,gene_805,132.950886123423,125.330913095826,86.6617118999357,107.036961410687,125.866203960839,108.837029347083,107.073764933439,78.7667098333676,0.600170225894213,112.995118132468,105.135927018682,-0.104004692566315,0.976960798897723 +806,gene_806,93.6286923376774,103.814803376481,144.470769167813,109.454393195257,92.0821724970569,94.272446036127,71.191046887262,66.8469977589536,0.0588853186256614,112.842164519307,81.0981657948499,-0.476565054484427,0.417626373231641 +807,gene_807,122.327294091079,111.591913720659,116.535208697794,90.8851547207587,112.677435344851,73.8808865976666,117.112132571069,88.3001882354178,0.36012540637574,110.334892807573,97.9926606872512,-0.171143502020962,0.919758854682739 +808,gene_808,81.2901093295548,89.8375152106652,140.038394925595,92.8207050887759,28.4035946173993,21.9493054527642,34.3585053466516,41.5799170439374,0.00987168813551194,100.996681138648,31.5728306151881,-1.67755237097892,0.123396101693899 +809,gene_809,108.614538585078,115.273744627999,106.018936890161,133.07492342037,83.5287836892757,100.39783975083,95.9428509552828,69.9770397037928,0.0217907031977448,115.745535880902,87.4616285247953,-0.404234435545349,0.205357438279128 +810,gene_810,62.0724361316441,74.7440434657639,120.078795346574,84.9685403288197,94.7610343063136,58.9430406310864,96.9469571665657,107.883885355504,0.807725463670126,85.4659538182005,89.6337293648674,0.0686919006532077,0.97704151387307 +811,gene_811,85.4393537479842,142.831537765211,112.360963293309,109.03505964198,98.4202369399007,72.7367208822211,96.8635912517306,123.227377467588,0.387415594544068,112.416728612121,97.81198163536,-0.200773631071801,0.919758854682739 +812,gene_812,144.03914986645,96.2808491964853,118.181961585331,88.5113501826021,42.1619770212707,26.1455143045695,23.1227606545871,26.6378322795404,0.00433880084104452,111.753327707717,29.5170210649919,-1.92069875825247,0.0711278826400741 +813,gene_813,95.1843273277699,84.9085783491286,79.7937325496119,74.7495669014593,143.598735140674,104.156486490462,106.601212475071,120.811085518114,0.0219732458958667,83.6590512819924,118.79187990608,0.505842680573624,0.205357438279128 +814,gene_814,146.120275646792,115.367557531055,103.216726134678,78.5804455106986,76.7204139575522,87.0879545297505,131.316714845632,105.713321466005,0.586634291263446,110.821251205806,100.209601199735,-0.145213819250363,0.976960798897723 +815,gene_815,114.453358769569,90.5415888927938,85.0299572538563,108.774268788278,72.8855223482495,78.7518282503748,110.583051888457,126.850362419228,0.87543072839385,99.6997934261242,97.2676912265774,-0.0356298414296166,0.984736477383409 +816,gene_816,98.3850888047366,114.115346287568,119.313374485678,43.885249132504,313.540215685976,228.126087563688,248.225909713298,221.45800249697,0.00126299815242366,93.9247646776216,252.837553864983,1.42863326096604,0.0407418758846342 +817,gene_817,76.9457231953472,127.027011736836,90.2361574356369,79.4152386538034,80.9358374572447,80.9618158448992,127.754717683523,65.3896404185299,0.802873414126442,93.4060327554059,88.7605028510491,-0.073597890565409,0.97704151387307 +818,gene_818,119.698983085544,105.91913256932,124.584967630377,77.9777869520192,104.236812247055,132.931944914992,87.4980733319457,80.5651835922092,0.726840480368974,107.045217559315,101.308003521551,-0.0794721878811598,0.97704151387307 +819,gene_819,87.6403773336347,98.7690134415024,104.834405961217,100.212968326079,59.8095065587958,75.74192388774,152.953324551653,120.37788173622,0.851923041609024,97.8641912656082,102.220659183602,0.0628338238565274,0.97704151387307 +820,gene_820,109.957918763212,86.5796771401949,94.7772534743661,108.754079072005,95.0989570867145,127.082901495372,108.031557044981,142.678272681011,0.191317224998244,100.017232112445,118.22292207702,0.241261199346164,0.757207212115658 +821,gene_821,135.270396410523,102.998630365889,94.4588350732427,86.9630077173296,91.583321738042,116.393373563975,114.21955299772,93.4052814314369,0.938079620463219,104.922717391746,103.900382432794,-0.0141261130627662,0.99139661091521 +822,gene_822,85.0380602163783,93.5934638841828,102.163928769055,99.755581904674,80.5570931247534,122.691259281294,87.8759778374554,145.047464871783,0.431370264869413,95.1377586935724,109.042948778821,0.196806538635311,0.940801278082713 +823,gene_823,95.3910763856041,122.687447400869,137.313906738683,72.6470974722668,95.7136886962037,109.944168625588,87.8773948316964,91.245196352685,0.518626913939596,107.009881999356,96.1951121265433,-0.153708536129523,0.958914368513127 +824,gene_824,116.720190969776,96.4814007222474,88.5908191448329,61.9716650381223,97.7318384778553,95.7469051793576,79.2399732052088,88.4846424736957,0.960393810184184,90.9410189687447,90.3008398340293,-0.0101917637573708,0.992641973777354 +825,gene_825,122.854333664461,127.246723441678,84.4759681734241,99.8713437045352,132.80952964863,64.0299562037085,59.5210890427419,99.0722856485071,0.366436178214032,108.612092246025,88.858215135897,-0.289607665619772,0.919758854682739 +826,gene_826,90.3801263448909,121.509533994004,100.859097055917,99.3496774572734,75.7560953765355,92.4191193712648,86.6781443983785,123.05761413951,0.510096526784441,103.024608713021,94.4777433214223,-0.124942573977812,0.958914368513127 +827,gene_827,115.636106439311,120.737278992146,103.927568150887,76.4923180643911,97.9403298772682,121.058453547859,104.850161821349,85.6490039370374,0.887700643210223,104.198317911684,102.374487295878,-0.0254757614836828,0.988530250143975 +828,gene_828,131.691837110946,140.16692616093,120.090366687607,91.0793278792112,116.902399596751,131.304308979239,107.965713907138,112.494884173463,0.77602202173243,120.757114459673,117.166826664148,-0.0435440299375632,0.97704151387307 +829,gene_829,95.3553482753254,69.8846990509513,118.475907583934,101.314618473254,86.7120225257662,111.54426972651,102.592284523642,137.867672600489,0.39641606636826,96.257643345866,109.679062344102,0.188315134885326,0.919758854682739 +830,gene_830,70.3963517087606,91.7909956909165,120.071907621296,82.6115062439081,94.766749270913,119.873013634192,90.9545750330497,84.8370397421977,0.643970035597759,91.2176903162202,97.6078444200881,0.0976834562836512,0.976960798897723 +831,gene_831,84.0009371718011,100.650250872942,77.9944585610253,115.238126832521,108.361855114114,99.8392396941448,90.484786276727,92.837635517479,0.732003871611037,94.4709433595723,97.8808791506162,0.0511563949321062,0.97704151387307 +832,gene_832,99.6380089041347,80.7910979285787,83.7019314717155,88.4639380401619,300.608906156991,292.02149158779,385.054520413452,219.120330127501,0.00786340864334604,88.1487440861477,299.201312071434,1.76310458204481,0.104845448577947 +833,gene_833,70.6554366281025,112.242066151491,90.2666782811488,104.467484374307,100.509881420216,101.938997598363,89.8286332844131,81.9566694269822,0.937689825255176,94.4079163587624,93.5585454324937,-0.013038406447473,0.99139661091521 +834,gene_834,121.417829530874,81.4245679595555,93.0933369303626,130.524941860743,140.3184673954,109.298027748259,113.844323424647,89.2913032031791,0.688845502073869,106.615169070384,113.188030442871,0.0863086847053057,0.976960798897723 +835,gene_835,91.571026718315,79.2838619468458,80.3264070026176,94.2481091308132,114.096327755047,102.311211762609,90.6527513109468,142.879815273204,0.0976446945417637,86.3573511996479,112.485026525452,0.381342071472062,0.58469876971116 +836,gene_836,94.7519807511842,85.4332033758455,83.7718090988468,107.723630856087,120.98511762937,86.6866840846699,64.5326611897918,123.117856014516,0.717490699787328,92.9201560204908,98.8305797295869,0.0889659267796949,0.97704151387307 +837,gene_837,81.9266346413369,125.727486809543,110.502666508392,92.1298408502545,102.259115781504,124.019991207458,112.086207574182,81.4332908785002,0.86358650261076,102.571657202382,104.949651360411,0.0330652363047652,0.97704151387307 +838,gene_838,102.265390540061,107.159896925729,118.987706852615,84.0255917000765,109.773221220072,108.416720069007,130.621097148204,91.5887226518237,0.541702282448482,103.10964650462,110.099940272277,0.0946343747630039,0.975593151676992 +839,gene_839,127.241158329661,113.879369460781,101.462542434665,103.056435086138,110.333476066746,74.8874745211651,102.172553207105,101.564895044075,0.199216954880017,111.409876327811,97.2395997097729,-0.196261271633263,0.760743228338604 +840,gene_840,95.6409968151303,84.4640849380009,124.467893288336,137.406022558209,104.231495512793,105.770968597141,87.7376643077809,118.761002846897,0.667055974405368,110.494749399919,104.125282816153,-0.0856574016982058,0.976960798897723 +841,gene_841,87.5202886066582,99.5554834884791,96.1547881365402,103.694710855139,94.0779018594908,78.1349241528824,106.565388613794,101.156773643596,0.815020100758584,96.7313177717042,94.9837470674408,-0.0263023818678772,0.97704151387307 +842,gene_842,108.180524621247,71.8166803459154,101.289691847948,99.845588715038,80.031965707115,76.1676434594617,92.2848920782046,115.954291238011,0.740768493986446,95.2831213825372,91.1096981206981,-0.0646160461995941,0.97704151387307 +843,gene_843,109.824643732009,97.3499709509584,89.9148794262906,140.644668069993,115.414152620939,74.6718331924127,114.523753498557,119.625474589649,0.833364590439944,109.433540544813,106.058803475389,-0.0451906033063705,0.97704151387307 +844,gene_844,96.6584419127602,122.460119497845,81.2748042202805,85.7543908558665,146.953175545058,82.6861223255623,87.431413705551,107.423017875194,0.602946417487883,96.536939121688,106.123432362841,0.136590253327884,0.976960798897723 +845,gene_845,120.568097686258,75.3076978894039,99.0475109301351,77.0551230837192,293.244070298847,280.219965775586,232.417145860691,308.567493679305,0.000190638455523865,92.9946073973791,278.612168903607,1.58303930742617,0.0129272899548559 +846,gene_846,104.551697598966,127.6888688137,94.8101760844863,75.0464743187739,102.508979821108,80.4930948998351,109.63922822881,67.2996720853938,0.499934817117581,100.524304203982,89.9852437587869,-0.15978400488667,0.958914368513127 +847,gene_847,94.2035309387862,113.812857273917,78.7653710033552,119.610932020408,120.46472686659,109.606471565826,85.0200845036591,90.311768178168,0.984846423738519,101.598172809117,101.350762778561,-0.00351750946548029,0.997693106634484 +848,gene_848,82.1551227803698,80.9316924932418,98.0551070813141,112.708067802441,87.8526002245221,104.960672737606,138.662255015944,83.3075649808127,0.515952892497369,93.4624975393417,103.695773239721,0.149897594362777,0.958914368513127 +849,gene_849,149.212823842002,79.485800380881,76.313355107045,107.108059695223,116.997319272755,77.4515011914329,86.6315735261151,91.3814859213487,0.624770202500632,103.030009756288,93.1154699779128,-0.145971836621315,0.976960798897723 +850,gene_850,90.3124027464676,104.877066028911,73.7688028376937,95.3431357718271,112.931147001251,111.145001943349,101.874091859702,97.9703107859584,0.105485551750204,91.0753518462249,105.980137897565,0.218661341105167,0.610405724320116 +851,gene_851,128.109610600498,90.1731768783043,74.2816774018878,118.721699832604,82.3572235458726,111.133968339978,87.971475528508,99.6025864708638,0.615562329363943,102.821541178323,95.2663134713056,-0.110104474727168,0.976960798897723 +852,gene_852,71.1138626232285,116.946875758452,87.9729909413373,153.173302728711,125.119638228577,96.0696287295003,102.670325933746,94.2688733610536,0.893153560220407,107.301758012932,104.532116563219,-0.0377274475124243,0.988944302445566 +853,gene_853,97.47939349818,134.010407438931,69.70286638598,110.526250333842,97.5035908891603,130.728256659858,98.4787357401579,69.6333407989279,0.840821538821161,102.929729414233,99.0859810220261,-0.0549068789236691,0.97704151387307 +854,gene_854,93.7946755612892,94.4508902417361,92.8436305511212,122.512665079682,112.17381113092,135.161144421104,128.373849009459,119.232272458007,0.0454253121831923,100.900465358457,123.735269254872,0.294323953607557,0.349425478332249 +855,gene_855,76.0503564328067,138.035267010174,87.4710470201739,99.1015607556683,97.3721092954075,93.4965792682299,126.438003831948,116.190246179971,0.621335161110528,100.164557804706,108.374234643889,0.11364968886919,0.976960798897723 +856,gene_856,102.524439048432,71.1012355363724,103.409785836694,109.794709818135,112.932024648551,108.165866698411,142.276121538738,106.363056504704,0.137119751275621,96.7075425599082,117.434267347601,0.280153128601067,0.682187817291646 +857,gene_857,103.941531227745,107.663117600673,71.209483269502,99.6712613166064,129.378504944015,85.578941022806,140.920342583886,89.8397282166849,0.375148741971052,95.6213483536317,111.429379191848,0.220725005863945,0.919758854682739 +858,gene_858,99.3297341154788,103.617561257934,108.161051948366,114.084368417621,81.0236321032896,118.526529435904,101.661749985068,100.042674360268,0.510600285655599,106.29817893485,100.313646471132,-0.0835990006115715,0.958914368513127 +859,gene_859,147.022589705032,100.684504722664,118.723112418252,103.03794501049,97.2611471703133,76.6099569220035,105.437016741719,106.039247587859,0.156890882982785,117.36703796411,96.3368421054736,-0.284867751860813,0.711320181265988 +860,gene_860,98.9342807972269,123.355476022553,107.80246574319,79.5382967660635,103.51405757849,68.2097730273051,86.4100474251214,100.666913702642,0.338398275683916,102.407629832258,89.7001979333896,-0.191140132930645,0.919758854682739 +861,gene_861,118.916345320423,104.066857021304,95.2125271141508,88.31595823117,75.2382069242418,98.0736934030605,107.63409664624,113.050471851352,0.779216974166398,101.627921921762,98.4991172062235,-0.0451141324163276,0.97704151387307 +862,gene_862,90.1113686070886,108.014046171112,75.3083475205763,102.731185751413,123.995724683148,77.1951961680144,80.1754253096202,83.4440467692463,0.837887172730409,94.0412370125473,91.2025982325073,-0.0442185909276182,0.97704151387307 +863,gene_863,112.690375770273,103.925527108127,62.5196037807378,85.0117509250529,70.0637909133434,103.596170391219,91.5646001524591,82.9449902416444,0.773825035570044,91.0368143960478,87.0423879246665,-0.0647319389598251,0.97704151387307 +864,gene_864,103.538079894113,89.0919963151143,96.6210500370576,125.842355039966,129.523096007398,103.122858608635,89.1822109650598,87.009805035138,0.905352810077026,103.773370321563,102.209492654058,-0.0219070836806859,0.989971080047645 +865,gene_865,111.976538448435,131.283459687503,100.134921719034,86.4210487302609,32.0477998440241,36.3076077573591,38.2214281127229,35.2710021380145,0.0043204002475854,107.453992146308,35.4619594630302,-1.59937492280378,0.0711278826400741 +866,gene_866,88.3448147724947,70.3826678534654,83.2559829998048,93.1373030903087,87.9926345279915,108.365158925658,78.0323806406431,92.5391138479276,0.360606482246165,83.7801921790184,91.7323219855549,0.130820965066692,0.919758854682739 +867,gene_867,93.3220554850677,124.027480259421,96.3139214879249,122.896065395372,131.557218113796,77.7786353288154,82.8417595734917,98.6675274882281,0.469924428629972,109.139880656946,97.7112851260828,-0.15958127083554,0.958914368513127 +868,gene_868,110.128414256297,121.285287324643,93.6946997500282,103.26846700225,88.391959493285,125.603061608395,108.493468242677,91.2622472678323,0.73863856780047,107.094217083305,103.437684153047,-0.0501186985700573,0.97704151387307 +869,gene_869,90.9246293686421,75.7762730967633,78.2620456709481,85.2462611582782,114.645250219359,97.5156395607783,102.756638201001,124.473166947807,0.0123158701706309,82.5523023236579,109.847673732236,0.412123961294724,0.139167300763332 +870,gene_870,137.894579278795,91.8210369608233,78.7918460070994,60.8975110232485,73.5049904048182,99.9344312892624,122.545468150042,126.25407478804,0.544417822885154,92.3512433174915,105.559741158041,0.192856428822998,0.975593151676992 +871,gene_871,85.9532007670577,85.7995711292845,129.061380744206,86.5898921744019,88.0363171486469,75.6445313996474,121.086317106252,91.2450255815442,0.850095653984465,96.8510112037375,94.0030478090227,-0.0430595785679094,0.97704151387307 +872,gene_872,119.22079379733,71.4326140425762,77.3922926422794,76.1740302524475,240.606280816229,385.763747690255,323.89549525327,349.395756154517,0.00236722607220421,86.0549326836584,324.915319978567,1.91673397404653,0.0553552260973115 +873,gene_873,124.469690378839,73.6461413522343,108.669256788213,64.1188368350345,88.8889354044577,98.5422059573608,109.417066975424,100.104141710613,0.687120437033608,92.7259813385802,99.238087511964,0.0979203011376959,0.976960798897723 +874,gene_874,73.3046033535225,99.1981926267346,75.0427563193999,114.094812014346,91.2842046379562,81.9207152558915,96.9669559852054,81.9005336357363,0.83200338162199,90.4100910785008,88.0181023786974,-0.0386835389697946,0.97704151387307 +875,gene_875,79.694288515602,64.6471066158765,118.659015299148,72.7707138377818,74.5425408936733,123.224077116373,119.867676531577,79.8957381476718,0.413548091623466,83.9427810671021,99.3825081723238,0.243585691217339,0.930988787286778 +876,gene_876,102.363473762937,112.706652380812,111.890651332942,94.8170277677871,86.379866754895,146.116378407513,59.1923354811653,101.595972593537,0.725970951385966,105.44445131112,98.3211383092775,-0.100909656086762,0.97704151387307 +877,gene_877,76.080613229531,112.702883529932,96.346603018124,75.8062123097356,95.3856565927907,90.8554407965631,128.279620501061,116.950992235059,0.21012736120014,90.2340780218305,107.867927531368,0.257521677531175,0.772527063235808 +878,gene_878,125.131636193318,93.5744803340168,94.8805192115844,77.8112536577815,106.375549553361,93.6393354677612,101.138855486022,91.6837530660013,0.974315097381975,97.8494723491751,98.2093733932864,0.00529665502009279,0.997693106634484 +879,gene_879,86.2949856971292,105.353562129797,104.700334740958,84.1889604905821,86.9909918536556,111.802433517985,109.170017099815,131.837426577272,0.228762585933287,95.1344607646166,109.950217262182,0.208810523504944,0.815523488873472 +880,gene_880,96.7460157066218,78.7770108225944,111.297462188613,74.9612553871457,104.526388322109,114.967673184455,129.276450526061,85.7862657751051,0.194097424947799,90.4454360262437,108.639194451932,0.264425077448723,0.760743228338604 +881,gene_881,88.3784409183185,100.49644255448,97.1092330026337,91.3329835592338,56.0009184406687,113.294689705039,89.2325801699057,105.731847213547,0.816856190293887,94.3292750086664,91.0650088822901,-0.0508087649195723,0.97704151387307 +882,gene_882,115.026647077129,108.077879904308,138.285907948298,116.276658230942,106.464211665791,53.4813024322088,112.701189834975,110.76916185969,0.202271537139343,119.416773290169,95.8539664481663,-0.317095454775978,0.760743228338604 +883,gene_883,108.97048097934,116.228946607105,89.4898072703805,102.479662471763,99.459773161825,104.31815092607,100.623079082313,107.40144588041,0.834040297421021,104.292224332147,102.950612262655,-0.018679189591981,0.97704151387307 +884,gene_884,78.1582490540912,82.2351323818095,105.745969423134,113.109077489381,69.6216078450531,70.2767467751413,135.290245595262,138.297559306251,0.705571013818263,94.812107087104,103.371539880427,0.124695837594716,0.97704151387307 +885,gene_885,75.4167145347716,79.5970581022391,137.813240832035,123.646929410999,75.0999177412045,101.488396657871,74.7051305195794,96.5589702780773,0.372074366263366,104.118485720011,86.9631037991829,-0.259750897107912,0.919758854682739 +886,gene_886,77.2944637693096,84.9830828577967,94.7545654769546,86.9590381170414,119.150751262677,119.064977402513,93.7187229278032,84.3632800218216,0.133196854190461,85.9977875552756,104.074432903704,0.275244247796604,0.672711384800308 +887,gene_887,110.122558746169,103.387162750048,76.3331715120594,92.0681890852157,91.9787752111594,84.5605587608287,114.013413541889,105.651658074048,0.731353184156091,95.4777705233729,99.0511013969812,0.053008138410382,0.97704151387307 +888,gene_888,116.182481363581,56.8503949260897,105.375182084275,99.5014914272542,89.8987003086945,102.667408766625,115.229732334383,94.6078405302097,0.687033455079995,94.4773874503001,100.600920484978,0.0906025296058508,0.976960798897723 +889,gene_889,104.60061548,75.7983993600026,113.360833157166,104.788669957785,103.7140578102,122.796110202688,114.064003590747,120.2876252494,0.15906787579509,99.6371294887386,115.215449213259,0.209578816655019,0.711320181265988 +890,gene_890,80.6353388695309,99.394455524072,113.795029029022,130.69450104391,94.9277594502335,43.9681977012768,91.7469397451986,107.647191860477,0.268469919915165,106.129831116634,84.5725221892964,-0.327569318342864,0.851746318223856 +891,gene_891,102.746265778193,116.027477113165,100.508389936819,91.4120045306315,89.3158537127099,125.388496834221,135.875657360091,81.3125094808084,0.730244550680174,102.673534339702,107.973129346958,0.0726079687675135,0.97704151387307 +892,gene_892,118.433601305528,91.6630956693589,107.126067322907,91.7668566983494,91.8431996125423,90.8415770133109,97.8607067532248,77.181799501204,0.160047040784847,102.247405249036,89.4318207200705,-0.193204079168244,0.711320181265988 +893,gene_893,68.8604103862805,76.6828995668808,143.630785392103,104.21054374531,111.052477867836,96.5321583003608,100.450326319525,98.6432659924082,0.858319298151878,98.3461597726435,101.669557120032,0.0479471339202751,0.97704151387307 +894,gene_894,79.3644549951717,113.030937663067,75.0534063533061,97.3666860782072,85.1642233854303,105.961309273345,120.873270621517,81.7338890438176,0.589446727146254,91.2038712724379,98.4331730810273,0.110049539042906,0.976960798897723 +895,gene_895,78.8571975456283,75.4110182074307,121.609514674224,79.1139778617778,78.7512508427107,101.981580407823,67.4368498657671,158.515335371517,0.601140403722077,88.7479270722653,101.671254121954,0.196126511215113,0.976960798897723 +896,gene_896,117.349440954762,126.020818142847,91.7693609722083,104.927544107102,88.5925169267877,89.5744787300359,68.4403755974081,99.1484584858867,0.0549548989315023,110.01679104423,86.4389574350296,-0.347970151706304,0.401130649135053 +897,gene_897,62.1959986506912,141.766382734151,86.587259210336,89.1250181123098,101.183373765169,100.844916355632,159.170508805989,84.4155524874626,0.50828705662669,94.9186646768721,111.403587853563,0.231031986886465,0.958914368513127 +898,gene_898,91.352650310266,96.8520779993393,103.427103353084,106.279531843518,92.9328529496021,89.9462160031403,125.918961392361,59.4698635742593,0.629291225580818,99.4778408765518,92.0669734798407,-0.111691473272494,0.976960798897723 +899,gene_899,103.802086366765,120.844631062449,103.19051223621,98.83375585373,109.276949219504,127.805707387944,79.5003898020355,136.170285032286,0.654208525449124,106.667746379789,113.188332860443,0.0856012491035584,0.976960798897723 +900,gene_900,137.463641657286,100.761838609067,117.168723399861,71.5478898764835,132.323016423712,88.285715253206,127.245115862805,101.402401746192,0.760611175869094,106.735523385674,112.314062321479,0.0734981628168539,0.97704151387307 +901,gene_901,131.531823298013,105.604124739188,118.798707611486,85.6348578110511,108.892500625416,102.417320269156,106.464653292616,107.579612307153,0.708755449059308,110.392378364934,106.338521623585,-0.0539762554547608,0.97704151387307 +902,gene_902,67.3393755805288,134.748238261559,87.1942803694111,94.7026015562366,95.542912097591,98.1983056853368,92.9592394744042,110.564300336196,0.833768264810078,95.9961239419339,99.316189398382,0.0490527537274685,0.97704151387307 +903,gene_903,47.5108727838211,110.0000623466,83.2004856891235,135.420493075803,89.0397202879117,71.5443917328978,69.5538850624027,95.6546127830736,0.563988304989888,94.0329784738368,81.4481524665714,-0.207284842017024,0.976960798897723 +904,gene_904,123.767491603745,112.754283113555,136.155120081167,96.5236592688754,133.863888068716,110.635560755035,79.5880798349399,120.581117091873,0.684165166879135,117.300138516836,111.167161437641,-0.0774740353137773,0.976960798897723 +905,gene_905,82.5733071753172,103.580491063612,78.5754791029579,99.0681200905661,100.727777035659,84.1026936805024,109.694063884994,141.116930253831,0.24559113451236,90.9493493581133,108.910366213747,0.260006055820475,0.829699778757974 +906,gene_906,71.030271553484,122.961647461657,116.194695742847,96.6458935326673,114.898642312281,116.89507566955,112.339370756681,132.417510194376,0.237544903873647,101.708127072664,119.137649733222,0.228194440414128,0.818289875612779 +907,gene_907,87.971530254434,137.616863230136,94.8733814418977,96.1407420607923,95.4773891510896,130.384691945009,112.872432910157,95.2405537957485,0.768842567392369,104.150629246815,108.493766950501,0.0589406053872852,0.97704151387307 +908,gene_908,101.284681936703,93.7880624766076,78.0795902340998,93.9451797217038,102.057882434439,86.2152586858839,104.665626879254,82.826179017785,0.778641001825602,91.7743785922785,93.9412367543405,0.0336671462604774,0.97704151387307 +909,gene_909,100.662778417762,97.8077475802745,97.5097309960692,122.895129047338,125.033621686165,56.9500947337352,76.6520721402468,94.1825173376995,0.351046956921454,104.718846510361,88.2045764744615,-0.247595694295743,0.919758854682739 +910,gene_910,142.890805490614,110.634560516838,124.997106650617,100.665378623727,92.8047663677532,99.3066370473167,92.2732128699461,103.183983368864,0.0837954151060051,119.796962820449,96.8921499134699,-0.30613964228396,0.523721344412532 +911,gene_911,106.523084485138,89.039463843485,126.61567519042,102.617821131717,94.116459656892,93.5254950082348,132.162945584202,80.665408499403,0.671516508306277,106.19901116269,100.117577187183,-0.085075049211862,0.976960798897723 +912,gene_912,91.6359217754672,96.9495440390779,123.767703975179,76.7027809000317,95.1907787186906,76.571353559454,93.5399462727449,109.209639138134,0.771208757743738,97.263987672439,93.6279294222559,-0.054966787854678,0.97704151387307 +913,gene_913,124.420027929341,82.8103098124957,104.770864078846,93.5716707228691,96.0563554491942,106.507824261228,80.7375293545295,132.588787068484,0.86083045685338,101.393218135888,103.972624033359,0.0362425587450304,0.97704151387307 +914,gene_914,93.3397730770956,84.5672417822008,89.8789572887726,96.6674455181943,63.2532222523285,83.3459967648776,120.828593261055,127.428162967179,0.656049769807031,91.1133544165658,98.71399381136,0.11559209305389,0.976960798897723 +915,gene_915,77.5324096303685,99.8453319696896,97.8429580840696,117.828789917263,74.4822733433208,109.350582070084,92.9595015126617,116.560520239874,0.995348024008046,98.2623724003476,98.3382192914851,0.001113159815014,0.999453122312829 +916,gene_916,106.401866411276,97.6226768723596,79.1964585735624,73.5867841173151,90.8078175892695,85.9405111607707,105.545725094738,95.5164832841674,0.576977028317062,89.2019464936282,94.4526342822364,0.0825158420850402,0.976960798897723 +917,gene_917,104.237045520222,87.6062709873064,127.41690158447,120.733883665255,36.900758942474,35.7672884829022,42.2618159090431,40.3509562792725,0.00348805980435328,109.998525439313,38.8202049034229,-1.50260454603858,0.0645937000806163 +918,gene_918,87.464445503244,111.905723331972,96.0054672710803,107.319476127215,106.18923093004,89.0499777425581,106.523393025634,115.830965908951,0.652183834773921,100.673778058378,104.398391901796,0.0524115280760055,0.976960798897723 +919,gene_919,114.41619174246,105.948672182697,70.8660408138482,80.493899845652,63.2548613811964,84.5235072073243,81.2190197325904,103.311119040219,0.483878245984861,92.9312011461643,83.0771268403325,-0.161711732438411,0.958914368513127 +920,gene_920,104.785068701913,121.581002508372,95.4031859656884,100.1787727286,121.891707519534,99.0932886390302,78.5153562405187,132.881388057819,0.854429772338159,105.487007476144,108.095435114225,0.0352402817621433,0.97704151387307 +921,gene_921,122.339579986045,125.017780939164,80.784166445608,90.2088778282501,111.592588159675,90.1774125610968,100.964541921686,100.847312197091,0.774533121402154,104.587601299767,100.895463709887,-0.0518505205268258,0.97704151387307 +922,gene_922,78.786985039954,119.117918544335,116.397652850791,123.607616751353,117.914653012587,102.352511502165,80.1567645921905,101.530498771955,0.514671584189546,109.477543296608,100.488606969725,-0.123603022546843,0.958914368513127 +923,gene_923,110.275814103329,138.452053428872,116.933309708105,71.8079840229271,288.185050162721,373.737630869361,318.892146854011,240.588278160934,0.00236171447769517,109.367290315808,305.350776511757,1.48128619408979,0.0553552260973115 +924,gene_924,122.316503444121,138.446324234119,108.657795285428,88.8682216881363,80.2243376083586,72.7698482225107,84.5610742720756,129.96041896765,0.223986960068604,114.572211162951,91.8789197676486,-0.318451369084839,0.808617184363191 +925,gene_925,105.056354167357,110.796100328853,141.865718110194,123.718909040055,114.163119956338,120.52442278601,73.9930459370872,128.353718561114,0.479803478503462,120.359270411615,109.258576810137,-0.139600730658281,0.958914368513127 +926,gene_926,98.9662817012323,76.3326302356165,84.2058509309199,78.393597826629,86.7812243366488,112.754475763703,96.5672090023059,135.681878125197,0.113544387633311,84.4745901735994,107.946196806964,0.353723063468915,0.630802153518396 +927,gene_927,103.951897523235,102.787048826335,89.3473856843342,118.771274758097,102.449641734316,102.794607974451,97.0204159543077,101.565184491888,0.682324451201097,103.714401698,100.957462538741,-0.0388686842856605,0.976960798897723 +928,gene_928,96.7574375298017,98.1341029926311,120.208766137476,97.6991076685506,115.517437870335,87.7672367764154,106.516822653722,108.10020891022,0.881362882036682,103.199853582115,104.475426552673,0.0177227250174138,0.986968512919017 +929,gene_929,102.054412540596,112.822921824194,87.7307304795778,87.691651420328,146.548662235936,74.6673560883898,91.2556454155367,123.135159537803,0.547533906786405,97.574929066174,108.901705819416,0.158444138398509,0.97599626878147 +930,gene_930,94.4718303370999,77.2762981069265,99.0284865678331,99.4886785295852,118.933782270978,78.3682250798672,106.747423705561,82.255310466138,0.732950049410417,92.5663233853612,96.5761853806361,0.0611800591601553,0.97704151387307 +931,gene_931,101.338294421135,85.7968648088731,100.14748945684,98.0139497767946,62.1374932914012,98.9810700138701,106.73960612252,97.2415785375758,0.658789374264276,96.3241496159108,91.2749369913418,-0.0776787765692425,0.976960798897723 +932,gene_932,99.7421392716281,108.83262276086,101.698993585655,120.923919584407,76.8991090335988,91.9827156938962,77.2798349493232,109.887379631017,0.0954004945162479,107.799418800638,89.0122598269587,-0.276273439842656,0.578184815249987 +933,gene_933,96.6697098787064,88.6494135162854,109.537586573415,99.0591403187856,105.236476888985,104.115752761107,124.115358822734,94.6458308414669,0.304119630278207,98.478962571798,107.028354828573,0.120105588932678,0.905117947256569 +934,gene_934,64.4763183221081,87.578233220916,84.1306142164763,107.662100444772,118.459750971935,114.400989471661,73.3889170061303,130.052250648165,0.183931160281852,85.9618165510682,109.075477024473,0.34355890779634,0.755040008590345 +935,gene_935,62.5587417898938,92.1266660255948,105.050983600448,93.8387414214571,110.618469228642,86.8062866280521,129.432706248058,104.429347834319,0.175180001803953,88.3937832093485,107.821702484768,0.286630782106709,0.739156125755075 +936,gene_936,123.260063570063,110.715225143747,68.2475402533167,118.532558972622,93.8931025562814,89.6480076042718,90.6385867753531,100.358859159687,0.429464830265893,105.188846984937,93.6346390238984,-0.167867504375654,0.940801278082713 +937,gene_937,112.708147100466,132.711542753771,116.417669210148,83.5218398490915,94.0598312016571,81.2713947044818,84.7283430205324,112.296706707522,0.197255533469771,111.339799728369,93.0890689085483,-0.258285720571058,0.760743228338604 +938,gene_938,104.111381593334,99.559468671371,98.8279124392266,98.9488333326745,117.112365103804,131.931499705511,103.864612909701,77.9631432126046,0.567684839602308,100.361899009152,107.717905232905,0.10204640520549,0.976960798897723 +939,gene_939,99.3982371535208,115.418998871238,104.710139200047,58.4133059079722,106.730219011756,99.7295137720605,136.844375032948,95.3208675041079,0.371118484478459,94.4851702831945,109.656243830218,0.214828144339316,0.919758854682739 +940,gene_940,88.1602517449506,123.35680417363,86.3496342241712,83.4735815096163,113.947573672438,119.84489541002,110.667163579757,114.779026790217,0.128063181605913,95.3350679130921,114.809664863108,0.268165199800534,0.663539801066907 +941,gene_941,86.4279889300158,68.7546324685577,162.388932795679,87.8254291892102,124.382092270137,112.171848255067,83.6728336595382,65.7161561693254,0.851574831017606,101.349245845866,96.4857325885168,-0.0709478225870575,0.97704151387307 +942,gene_942,101.58716951155,116.278805030858,126.896812888987,117.641700491697,112.403044992812,86.6199785696049,86.2968997566824,112.364871348078,0.132624956581795,115.601121980773,99.4211986667942,-0.217529997879173,0.672711384800308 +943,gene_943,92.6023038797994,123.145621045673,100.39000648635,86.3108501057487,87.9184020084568,115.322642385961,106.477907986298,81.6532399667156,0.813684621568126,100.612195379393,97.8430480868577,-0.0402639336237089,0.97704151387307 +944,gene_944,97.2832999292323,115.075467622091,93.096922056469,113.948136370316,102.962812815322,83.8444606383624,108.290484999733,87.5013363899652,0.303389039246612,104.850956494527,95.6497737108456,-0.132506561819255,0.905117947256569 +945,gene_945,135.617547638486,69.8056218492396,98.9037372422101,88.0004823920497,75.4978235566361,130.435027409855,90.8457602163502,66.4862175310499,0.726323809883004,98.0818472804964,90.816207178473,-0.111036365379248,0.97704151387307 +946,gene_946,129.653362860594,115.346596908663,90.1558229972278,107.687753193312,81.1253713060965,135.467847275026,71.5928866186319,105.658300207061,0.491863495416632,110.710883989949,98.4611013517037,-0.169171278217844,0.958914368513127 +947,gene_947,71.8633880429336,78.9169682516224,85.5004834901629,74.6175554713139,107.240265599355,90.6379050354402,40.4321861124809,132.62266958923,0.498879752760574,77.7245988140082,92.7332565841267,0.254715555102549,0.958914368513127 +948,gene_948,84.7270592106077,81.7241607560688,98.2602710882587,51.3521052952642,267.960175087792,282.619249997245,265.900087816633,341.87400660117,0.000210860875782853,79.0158990875499,289.58837987571,1.87378883576771,0.0129272899548559 +949,gene_949,82.4384664262543,104.73159009496,123.932680685557,125.45763536789,38.2671438370146,34.9946443056603,38.9760188968614,37.1192230144793,0.00546862525390071,109.140093143665,37.3392575135039,-1.54741603491571,0.082857958392435 +950,gene_950,100.155314751478,123.400226705112,98.0343907401166,98.7187641580292,85.9196489140269,91.1006364570375,110.674131646634,101.660173339582,0.384559476286403,105.077174088684,97.33864758932,-0.110364671486572,0.919758854682739 +951,gene_951,111.212142265596,86.5736700006795,86.0132211312997,86.5260246218577,71.596810429973,113.787785073082,134.426777859871,101.513715735587,0.426761043971162,92.5812645048583,105.331272274628,0.186141655499832,0.93793636037618 +952,gene_952,104.67069820176,105.82655961286,99.28281521482,125.913058911011,82.3301253756067,92.7807463259734,96.313489270883,78.6282934338048,0.0278008836749073,108.923282985113,87.513163601567,-0.315740425023182,0.246025519246968 +953,gene_953,144.345902533628,110.202739222615,106.546174147696,98.8663271232701,97.3435566317983,90.3380129772447,118.412927076162,79.2147303288206,0.203483188247386,114.990285756802,96.3273067535064,-0.255495254466836,0.760743228338604 +954,gene_954,147.712704179132,115.238012008937,104.788830927484,92.1440185702974,129.796085986676,119.195761499158,99.3797800818625,111.292120861462,0.996925102962097,114.970891421462,114.915937107289,-0.000689750853064631,0.999453122312829 +955,gene_955,124.547463015728,108.503476374423,136.53299830672,120.817762955245,74.943713283074,89.6083983947806,116.574199687419,103.234360825329,0.0538975788372302,122.600425163029,96.0901680476505,-0.351503255113145,0.39630572674434 +956,gene_956,130.8224091283,126.217432814832,86.0824243129126,119.244326627102,31.4678007247902,28.8986594249031,40.1487488085324,43.3116079916227,0.00238679689846966,115.591648220786,35.9567042374621,-1.68470446759997,0.0553552260973115 +957,gene_957,118.92178165644,91.7064981852795,81.9792351657061,83.5759514421181,79.5554348421731,93.9465200890889,99.8567487094265,98.579431659113,0.917824193831521,94.0458666123859,92.9845338249504,-0.0163737657774316,0.989971080047645 +958,gene_958,72.4282114065803,118.371964196438,96.7147869375061,77.9158363907809,115.502950494743,68.3760019841074,110.970725293187,87.0951158629532,0.793993510420477,91.3576997328262,95.4861984087476,0.0637658948449589,0.97704151387307 +959,gene_959,97.6485139450689,79.0922543387625,102.569165361136,119.7689344118,109.16885475946,60.7398226149872,81.693532600942,96.7304021847284,0.380812973637678,99.7697170141919,87.0831530400293,-0.196208337996458,0.919758854682739 +960,gene_960,110.134020958913,89.3166683565052,87.2197635258722,90.6838156269038,109.971880174981,125.887220906158,99.6702791844169,86.0905334218662,0.315443672821728,94.3385671170487,105.404978421856,0.160023415609785,0.911686915669735 +961,gene_961,141.698271108126,102.019074305197,98.5705464404435,103.74626198873,276.717431008288,339.247447027692,341.701701643469,169.495724135946,0.0209485696345202,111.508538460624,281.790575953849,1.33746917897686,0.201428554178079 +962,gene_962,106.720123648675,125.893788002151,91.0077682151954,110.558146703519,74.9490372078959,90.4387516084314,97.8784589417505,165.981136720118,0.956925031178315,108.544956642385,107.311846119549,-0.0164833516096491,0.992641973777354 +963,gene_963,126.294491519202,82.5376834113625,83.6583576951132,93.9775035610312,126.516357951623,93.6601917436027,96.9237897029636,111.125426009129,0.444712837496787,96.6170090466773,107.05644135183,0.14802250478523,0.95431939376993 +964,gene_964,94.6114689519718,144.87701513881,139.705859641803,56.7751631353625,118.072794722665,111.238503448601,103.292072273342,76.780363407475,0.783256284667125,108.992376716987,102.345933463021,-0.090773451193569,0.97704151387307 +965,gene_965,135.449815435595,83.5888272766543,70.7626695027858,65.1729683684778,112.352123284131,121.982003956904,84.1975001666546,121.432677496283,0.302123048667196,88.7435701458782,109.991076225993,0.309671981121682,0.904560025949688 +966,gene_966,89.5682659489825,77.8909384624925,85.380463237268,120.53909033174,99.7229399645042,101.308903696982,100.730696327372,120.754760763895,0.305243682537319,93.3446894951207,105.629325188188,0.178370563384172,0.9053922491424 +967,gene_967,100.741616549117,112.647195062004,87.7925644060596,85.2324800571019,86.9025129289094,126.55333439187,64.2789422988338,106.415714564075,0.971128117398548,96.6034640185706,96.0376260459222,-0.00847518028958805,0.997693106634484 +968,gene_968,68.1083410012787,77.5172159619244,65.4979000314787,86.2883930203574,98.6339281054959,103.629777751859,58.3811430208774,87.2833107681972,0.318405117528496,74.3529625037598,86.9820399116074,0.226327317569025,0.913540450506902 +969,gene_969,86.747996529479,83.4719063283289,72.6117934629535,120.318301447819,91.649905052926,107.809963578649,131.144797497327,106.788993747391,0.209760775148623,90.7874994421451,109.348414969073,0.26836673714132,0.772527063235808 +970,gene_970,112.050168239423,112.52331537933,127.792905833329,74.254460624911,93.5016517480411,83.6655045157211,123.977802637439,118.681908897193,0.913546974481161,106.655212519248,104.956716949599,-0.0231599774677738,0.989971080047645 +971,gene_971,101.897755403593,100.23338403509,98.6515804622757,92.9645718671587,86.119197611157,111.955591562889,99.0724268999721,125.332643151136,0.461668184784785,98.4368229420293,105.619964806288,0.101612565262239,0.958914368513127 +972,gene_972,111.673054939019,101.786016068227,113.565107224881,129.464627192474,77.0225991199192,96.8790036369626,77.0285318527094,103.465849833197,0.0295049319666929,114.12220135615,88.5989961106971,-0.365217223885302,0.258815192690289 +973,gene_973,134.059453655561,84.7749697385879,126.21974844511,107.368912476563,90.3391284641844,112.334373142628,65.0258919497277,92.4296188298978,0.167053406590245,113.105771078956,90.0322530966095,-0.329158713598324,0.726177314590369 +974,gene_974,127.921090608048,81.6637287739463,102.176965156603,138.883570842702,377.275125949419,318.800681972105,284.172482911984,325.884555060708,0.000192573259068984,112.661338845325,326.533211473554,1.53523721327994,0.0129272899548559 +975,gene_975,139.888821169325,116.192710031794,69.8656829977031,112.262156495745,29.1035448356383,28.2133094562636,41.2029886840696,26.428670668427,0.0104633684503425,109.552342673642,31.2371284110996,-1.81028659573732,0.12760205427247 +976,gene_976,101.139486193031,107.747228497558,83.0944877742205,91.604693641347,93.5182422092669,80.2001303838738,108.423356416815,125.736176020652,0.612144863925841,95.8964740265392,101.969476257652,0.0885876821278986,0.976960798897723 +977,gene_977,94.210712071405,92.4160492587251,90.3864946264029,88.9599312884756,77.4905269725568,112.144008684148,104.104546566751,103.287126090353,0.379873646927423,91.4932968112522,99.2565520784521,0.117496290646182,0.919758854682739 +978,gene_978,95.5177251890397,124.157404980031,96.4813260493467,150.127067954404,91.6038596464358,104.771343060834,65.3044182943925,95.0380720551831,0.135851697823609,116.570881043205,89.1794232642114,-0.386424679196639,0.679258489118046 +979,gene_979,102.572489231228,133.038848558243,94.4593756446041,80.7462161804499,108.382124979765,93.4003501366892,61.2689189496872,144.284814364821,0.967713245349003,102.704232403631,101.834052107741,-0.012275573492319,0.997642520978353 +980,gene_980,157.910339782907,116.870798066509,85.9085295148282,74.1043017340915,84.6899734479077,89.2835176855243,101.056038335195,98.9887054843271,0.48062909687359,108.698492274584,93.5045587382386,-0.217223320053824,0.958914368513127 +981,gene_981,90.8016412046239,53.7386564780171,125.15443567866,78.2681256157605,160.146356844286,98.2201082678217,100.298640867355,100.170866221119,0.23951065132339,86.9907147442653,114.708993050145,0.399045178150608,0.818289875612779 +982,gene_982,57.8439762109734,120.864140842435,90.6014849644221,92.9066541106447,106.159268241201,85.9084341422407,78.7042330714969,82.2877901845142,0.879902370873647,90.5540640321189,88.2649314098631,-0.0369390365112307,0.986437635508572 +983,gene_983,74.777530083301,88.1967047484637,92.415831356761,117.119240708515,121.696789955018,128.331897891044,79.123400234384,72.3100804437172,0.685675856612846,93.1273267242602,100.365542131041,0.107987572100227,0.976960798897723 +984,gene_984,110.003580811437,100.439497027237,72.1344662642049,99.352944537465,91.5191081600093,104.517259918609,84.5426039032343,72.0650822506383,0.516109828808176,95.4826221600859,88.1610135581228,-0.115097376307546,0.958914368513127 +985,gene_985,93.8800165037386,109.77194132714,113.834738499415,135.218085797529,339.174909698783,389.637751104506,326.034113141962,346.260590550588,2.67936942503888e-05,113.176195531956,350.27684112396,1.62992505966707,0.00446561570839813 +986,gene_986,77.714905902985,83.7242477444728,73.0607132344692,99.3814806726917,100.345719762043,123.659898090068,88.8371398461985,63.4029759375388,0.482935278480584,83.4703368886547,94.0614334089622,0.172339724024179,0.958914368513127 +987,gene_987,119.989264730389,95.0452147991485,84.4139172031669,107.53405322662,317.952398524556,333.719442196889,350.157672080563,220.27503387134,0.00433726720379456,101.745612489831,305.526136668337,1.58632921929577,0.0711278826400741 +988,gene_988,74.0040114063824,88.4754875240172,83.127570394897,126.646171535315,75.235901504785,70.2086607453105,64.1388912094074,57.4513745127889,0.103960427143181,93.063310215153,66.7587069930729,-0.479256491616418,0.610405724320116 +989,gene_989,121.220374576699,105.294872843192,139.415364742902,85.0400209236574,85.274264717349,113.757938850706,64.8666068772476,88.313736513096,0.15892249041175,112.742658271613,88.0531367395997,-0.356587185597066,0.711320181265988 +990,gene_990,117.736050254803,75.0262717814831,117.236261426449,125.278925445658,132.595017986537,76.6041092658045,114.280997479751,104.626250808856,0.916173327561171,108.819377227098,107.026593885237,-0.0239661560768661,0.989971080047645 +991,gene_991,104.381065234165,104.208717406497,100.658610975018,103.505189185828,138.200901071705,74.9097660354606,85.0104715424207,59.8604924703171,0.480594865894102,103.188395700377,89.4954077799759,-0.205395176826364,0.958914368513127 +992,gene_992,96.6186582253033,68.3820149667797,88.820343929057,109.345862535839,109.393669924077,87.5116910711712,100.033206390492,90.7227772488489,0.564509156335951,90.7917199142447,96.9153361586473,0.0941642482548241,0.976960798897723 +993,gene_993,49.7880199594223,135.403601671227,106.876046548008,95.1956228264267,103.235206483877,75.824235493665,112.65529418557,95.4078657048325,0.998641330370191,96.8158227512711,96.780650466986,-0.00052421286224413,0.999453122312829 +994,gene_994,74.0297993291178,109.549674703932,90.1431441867674,108.349003622822,73.7979213440134,95.3673526330238,71.6515122144149,120.427196381997,0.7267147865162,95.5179054606598,90.3109956433623,-0.0808695502011429,0.97704151387307 +995,gene_995,128.878882393198,123.373805357807,105.890237540014,91.7022504066598,98.9667638173111,104.644655368138,89.7260198942483,108.915660224141,0.270758883869231,112.46129392442,100.56327482596,-0.161325014272551,0.853427112583127 +996,gene_996,51.7594542355681,83.7059921596596,125.902691255067,110.348969009178,84.5593098540796,104.562783885492,82.0356924701964,109.670457625606,0.903650199215118,92.9292766648682,95.2070609588435,0.034935395509936,0.989971080047645 +997,gene_997,122.843663869955,114.723383190231,114.15284852477,73.0460046155991,97.0522107021027,96.2226092089618,88.4780205638776,75.8237838075997,0.240577223430157,106.191475050139,89.3941560706355,-0.248415525752703,0.818289875612779 +998,gene_998,96.6241383793317,106.290665698315,97.9000101762215,108.448829539706,105.772244823064,136.02520057712,97.5431156815019,93.3891574912543,0.595256576148078,102.315910948394,108.182429643235,0.0804356908795218,0.976960798897723 +999,gene_999,66.5810424187714,113.76931481247,82.0513304312682,87.6692862669802,128.043855132794,152.753052557934,108.827753706899,109.598725980443,0.0398155325621408,87.5177434823724,124.805846844517,0.512038076538454,0.315996290175721 +1000,gene_1000,77.326869624959,90.9413088579062,120.031893499164,116.933386896242,255.857457871127,202.539037969613,200.988692469966,284.930691247829,0.0031770462682266,101.308364719568,236.078969889634,1.22051623287815,0.0618163676403743 diff --git a/data/output_results.xlsx b/data/output_results.xlsx new file mode 100644 index 0000000..1f9f2c7 Binary files /dev/null and b/data/output_results.xlsx differ diff --git a/scripts/as_own_script.R b/scripts/as_own_script.R new file mode 100644 index 0000000..67beced --- /dev/null +++ b/scripts/as_own_script.R @@ -0,0 +1,261 @@ + +3 + 4 + +6 + 5 + +# this is a comment +# Hands on 1 +x = 6 + +y = 5 + 7 + +y/2 + +z = 3 * 4 + +z <= 12 + +remove(x) + +x = 10.5 +x = '6' +x = 'six' + +Apple = "Apple" + +# Hands on 2 + +# Hands on 3 + +n = c('Alice', 'Ben', 'Charly', 'Dawn') +a = c(25, 32, 27, 33) +h = c(1.65, 1.96, 1.86, 1.74) +s = c('Ski', 'Basketball', 'Soccer', 'Volleyball') + +df = data.frame(Name = n, Age = a, Height = h, Sport = s) +# access column +df$Numbers +df[,1] + +# acces row +df[2,] + +# access element +df[3, 1] + + + +# Basic functions +M = matrix(c(5, 6, 7, 8), nrow = 2) + +sum(M) + +rowSums(M) +colSums(M) + +mean(M) +rowMeans(M) +colMeans(M) + +var(M) +var(as.numeric(M)) +sd(M) + +mean(c(5, 6, 7, 89)) +median(c(5, 6, 7, 8)) + +x = c(5, 6, 7 , 89) +quantile(c(5, 6, 7, 89), probs = c(0.25, 0.5, 0.75)) + + +colMeans(df[, c('Age', "Height")]) + + +seq(from = 10, to = 20, by = 2) +seq(from = 1 , to = 0, by = -0.1) + +rep(x = NA, times = 3) + +rep(c(0,1), times = 5) + +rep(c(0,1), each = 5) + +set.seed(1) +RN = rnorm(n = 1000, mean = 5, sd = 2) + + + +set.seed(124) +df <- data.frame(A=rnorm(10), B=rnorm(10), C=rnorm(10)) + +C1<-c(3,2,4,4,5) +C2<-c(3,7,3,4,5) +C3<-c(5,4,3,6,3) +DF<-data.frame(ID=c("A","B","C","D","E"),C1=C1,C2=C2,C3=C3) + +data.frame(ID=DF[,1], Means=rowMeans(DF[,-1])) + +DF$Mean <- rowMeans(DF[,2:4]) + + +# read in tables +D = read.table('data/mouse.tab', as.is = TRUE, header = FALSE) +D = read.csv('data/mouse.csv') +D = D[,-1] + +library(readxl) +mouse <- read_excel("data/mouse.xlsx") + + + +D = read.table('data/mouse.tab', as.is = T, header = T, sep = '\t') + + + +M = matrix(round(rnorm(30, 10, 5),1), ncol = 5) + + +M[,1] + M[,2] +M[3,] + M[4,] + +M * 2 +M + 2 + +SUMS = colSums(M) + + +colSums(t(t(M)/SUMS) * 100) + + +summary(Experiment1) +table(Experiment1$cage) + +# correlation between two columns +cor(Experiment1$cage, Experiment1$weight, method = 'spearman') + +# t.test for one column split by a group column with paired data +t.test(Experiment1$lifespan ~ Experiment1$treatment, paired = TRUE) + + +## Hands on + +# 1 read in data +airway.ge <- read.delim("data/airway_gene_expression.tsv", as.is = T, header = T, sep = '\t') + +# 2. calculate correlation (cor()) between column 'S_01.control.Rep1' and column 'S_03.control.Rep2' + +# 3. calculate if there is a signficant difference between +# 'S_01.control.Rep1' and 'S_02.__treat.Rep1' using t.test() + +t.test(airway.ge$S_01.control.Rep1, airway.ge$S_02.__treat.Rep1, paired = TRUE) + + + +# plotting +plot(x = Experiment1$lifespan, y = Experiment1$weight, col = '#20508080', + ylab = 'weight [g]', xlab = 'lifespan [weeks]', pch = 19) + +L = lm(Experiment1$weight ~ Experiment1$lifespan) # y ~ x !!! + +abline(L, col = 'red') + +#subset +Exp_cage10 = subset(ExperimentP, cage == 10) + +Exp_cage10_11 = subset(ExperimentP, cage %in% c(10,11)) + + +# Conditional statements + +x = 5 +y = NA +z = 'six' + +if(x == 5) { + print('x is equal to 5') +} + + +if (x == 5) { + x = x*2 +} else { + print('x is not equal to 5') +} + + +if (x < 5) { + x * 2 +} else if (x == 5) { + x +} else { + x / 2 +} + + +if(is.na(y)){ + print('y is not available') +} else { + print(y) +} + + + +if (is.character(z)){ + print(length(z)) + print(nchar(z)) +} else if(is.numeric(z)){ + print(z * 3) +} else { + print("can't work with z. It's neither a number nor a character") +} + + + +number = 1 + +while (number < 50){ + print(number) + number = number * 2 +} + + +for( i in 1:8){ + print(paste("i is now:", i)) +} + +files = list.files('.') +for(i in files){ + print(i) +} + + +for(x in 2:4){ + if( x == 3){ + break + } else { + print(x) + } +} + + +gene = read.csv("data/gene_exp1.csv") +head(gene) + +for(row in 1:nrow(gene)){ + TT = t.test(gene[row,2:4], gene[row,5:7]) + gene[row, 'Diff'] = TT$p.value +} + +significant = subset(gene, Diff <= 0.05) + + +source('data/create_gene_expression_table.R') + +# rewrite this using Experiment_DEG and group1 = rep 1-4, group2 = 5-8 +for(row in 1:nrow(gene)){ + TT = t.test(gene[row,2:4], gene[row,5:7]) + gene[row, 'Diff'] = TT$p.value +} + +significant = subset(gene, Diff <= 0.05) + diff --git a/scripts/day2_scripts.R b/scripts/day2_scripts.R new file mode 100644 index 0000000..9307413 --- /dev/null +++ b/scripts/day2_scripts.R @@ -0,0 +1,351 @@ +for(i in 1:nrow(Experiment_DEG)){ + ttest = t.test(Experiment_DEG[i, 2:5], Experiment_DEG[i, 6:9]) + Experiment_DEG[i, 'pvals'] = as.numeric(ttest$p.value) +} + + +sig_genes = subset(Experiment_DEG, pvals < 0.05) + + +# write our own function +Square <- function(number_to_square = 3){ + + our_result = number_to_square ^ 2 + + return(our_result) + +} + +Square(number_to_square = 4) + + +exponent_2_and_3_list <- function(x, y){ + + sq = x ^ 2 + cb = x ^ 3 + + return(list(square = sq, cube = cb)) + +} + +exponent_2_and_3_list(4) + +rain = exponent_2_and_3_list(4) + + +# hands on + +return_bigger <- function(input_value, vector_to_subset){ + return_vector = numeric(0) + + for(value in vector_to_subset){ + if(value > input_value){ + return_vector = c(return_vector , value) + } + } + return(return_vector) +} + +return_bigger(5, c(10,3,2,16,4,7)) + + + + + +myVolcanoPlot <- function(D, group1, group2, alpha ){ + # Input: + # D > dataframe to be analyzed + # group1 > column indeces for group1 + # group2 > column indeces for group2 + # alpha > p.value cut off for significant genes + + # this function calculates the pvalue using a t.test + # the group means and the log2fc and makes a plot + + # calculate the pvalue for each row using apply + for(i in 1:nrow(D)){ + # calculate p.value + D[i,'p.value'] = as.numeric(t.test(D[i,group1], D[i,group2])$p.value) + + # calculate mean for group 1 + D[i,'mean.g1'] = mean(as.numeric(D[i,group1]), na.rm = TRUE) + + # calculate mean for group 2 + D[i,'mean.g2'] = mean(as.numeric(D[i,group2]), na.rm = TRUE) + + # calculate log2 fold change + D[i,'log2fc'] = log2(D[i,'mean.g2']/D[i,'mean.g1']) + } + + D[, 'q.value'] = p.adjust(D[,'p.value'], method = 'fdr') + plot(D[,'log2fc'], -log10(D[,'q.value']), pch = 19, + xlab = 'log2fc', ylab = '-log10(q.value)', cex.axis = 1.3, cex.lab = 1.3, + col = ifelse(D[,'q.value'] <= alpha, + ifelse(D[, 'log2fc'] < 0, '#2120ac50', '#b2182b50'), + '#bdbdbd30')) # nested ifelse call to make three colors + # add legend + legend('bottomleft', c('n.s', 'sig down', 'sig up'), col = c('#bdbdbd30', '#2120ac50', '#b2182b50'), pch = 19, cex = 0.8, bty = 'n') + + return(D) +} + + +AD = myVolcanoPlot(Experiment_DEG[1:1000, ], 2:5, 6:9, 0.01) +AD = myVolcanoPlot(Experiment_DEG[1:1000, ], 2:5, 6:9, 0.5) +AD = myVolcanoPlot(Experiment_DEG[1:1000, ], 2:5, 6:9, 0.05) + +text(x = c(-2, 1), y = c(3.5, 2.5), labels = c('A', 'B')) + + +# save a table +write.table(AD, 'data/output_results.csv', sep = ',', quote = FALSE) + +AD[, 'neglog10'] = -log10(AD[, "q.value"]) +write.xlsx(AD, 'data/output_results.xlsx', row.names = FALSE) + +install.packages(c('pheatmap', 'gplots', 'ggplot2')) + + +if (!requireNamespace("BiocManager", quietly = TRUE)) + install.packages("BiocManager", repos='http://cran.us.r-project.org' , + dependencies = TRUE, version = "1.30.10") +BiocManager::install(c('edgeR', 'DESeq2')) + +library(edgeR) +library(DESeq2) +library(pheatmap) +library(gplots) +library(ggplots2) + + +## Plotting + +x = runif(n = 100, min = 20, max = 80) +y = rnorm(n = 100, mean = x, sd = 10) + +plot(x = x, y = y, main = 'Simple Plot', + xlab = 'this is the x axis', + ylab = 'this is the y axis', + cex.lab = 1.5, cex.axis = 1.7, cex.main = 3, cex = 1.5, + pch = ifelse(abs(x - mean(x)) > sd(x), 6, 17), + col = ifelse(y > x, 'firebrick2', 'dodgerblue2') + ) + +legend('topleft', legend = c('outside sd', 'inside sd'), + pch = c(6, 17), cex = 0.8, bty = 'n') +legend('bottomright', legend = c('x bigger', 'y bigger'), fill = c('dodgerblue2', 'firebrick2')) + +abline(a = 0, b = 1) + + + +# Hints for hands on +airway.D = read.delim2('data/airway_gene_expression.tsv') +airway.info = read.delim2('data/airway_sample_info.tsv') + +# remove 0 +airway.D = subset(airway.D, rowMeans(airway.D[, -1]) > 5) + +mean_before = rowMeans(airway.D[, c(2,4, 6)], na.rm = TRUE) +mean_after = rowMeans(airway.D[, c(3, 5, 7)], na.rm = TRUE) + +# calculate log2 fold change log2(mean_after/mean_before) + +log2fc = log2(mean_after/mean_before) + +# pvalue +airway.pvalue = numeric(0) +for(i in 1:nrow(airway.D)){ + airway.pvalue[i] = as.numeric(t.test(airway.D[i, c(2,4, 6)], + airway.D[i, c(3, 5, 7)])$p.value) +} + +qvalues = p.adjust(airway.pvalue, method = 'fdr') +# plot a volcano plot x = log2fc, y = -log10(airway.pvalue) + +plot(x = log2fc, y = -log10(qvalues), + col = ifelse(qvalues < 0.05, 'red', 'gray')) + + + + + +# example ggplot2 +D = data.frame(value1 = x, value2 = y) +D[,'bigger'] = ifelse(y > x, 'bigger than x', 'smaller than x') +D[, 'sd'] = ifelse(abs(x - mean(x)) > sd(x), 'outside', 'inside') + + +library(ggplot2) + +p <- ggplot(data = D, + mapping = aes(x = value1, y = value2, color = bigger, shape = sd)) + + geom_point() + +p = p + ggtitle('this is a ggplot2 plot') + +p + + +# Volcano plots + +head(Experiment_DEG) +for(i in 1:nrow(Experiment_DEG)){ + # calculate p.value + Experiment_DEG[i,'p.value'] = as.numeric(t.test(Experiment_DEG[i,2:5], Experiment_DEG[i,6:9])$p.value) +} + +mean_groupA = rowMeans(Experiment_DEG[,2:5]) +mean_groupB = rowMeans(Experiment_DEG[, 6:9]) + +log2fc = log2(mean_groupB/mean_groupA) +qvalues = p.adjust(Experiment_DEG$p.value, method = 'fdr') + +plot(x = log2fc, y = -log10(qvalues), + col = ifelse(qvalues < 0.05, 'red', 'gray')) + + +## PCA +wine <- read.csv('data/wine.csv') +head(wine) + +wineClasses = factor(wine$Cvs) + +winePCA = prcomp(scale(wine[, -1])) + +names(winePCA) + +plot(winePCA$x[,1:2]) + +plot(x = winePCA$x[,1], y = winePCA$x[,2], col = wineClasses, pch = 19) + + +# Hints for hands on +airway.D = read.delim2('data/airway_gene_expression.tsv') +airway.info = read.delim2('data/airway_sample_info.tsv') + +# remove 0 +airway.D = subset(airway.D, rowMeans(airway.D[, -1]) > 5) + +PCA <- prcomp(t(airway.D[,2:9])) + +plot() + +# histogram +x = rnorm(1000, 20, 80) + +hist(x, main = 'test plot', col = 'gray', breaks = 50) + +x.hist <- hist(x, breaks = 20) + + +x = runif(100, 20, 80) +y = rnorm(100, x, 10) + +hist(x, xlab = 'WT',main = 'Simple Histogram', + cex.main = 2, cex.axis = 1.5, cex.lab = 1.5, + col = 'gray', xlim = c(0, 100)) + +hist(y, col = '#0000FF50', add = TRUE) + + + +# hands on + + +# Hints for hands on +airway.D = read.delim2('data/airway_gene_expression.tsv') +airway.info = read.delim2('data/airway_sample_info.tsv') + +# remove 0 +airway.D = subset(airway.D, rowMeans(airway.D[, -1]) > 5) + +mean_before = rowMeans(airway.D[, c(2,4, 6)], na.rm = TRUE) +mean_after = rowMeans(airway.D[, c(3, 5, 7)], na.rm = TRUE) + +# draw two histograms one of mean_before and one of mean_after + +hist(log2(mean_before), breaks = 100) + +hist() + +# advanced: try to draw both distributions in one plot + + +library(pheatmap) +pheatmap(data_subset, cutree_cols = 2, cutree_rows = 5) +pheatmap(airway.D[1:300,2:9], scale = 'row') + +significant_airway = subset(airway.D, airway.pvalue < 0.05) + +pheatmap(significant_airway[, 2:9], + scale = 'row', show_rownames = FALSE, + cutree_rows = 2) + + + + + + + + + + +# cran libraries +install.packages("magrittr") +install.packages("dplyr") +install.packages("ggplot2") +install.packages("pheatmap") +install.packages("RColorBrewer") +install.packages("PoiClaClu") +install.packages("ggbeeswarm") +install.packages("dbplyr") + +library("magrittr") +library("dplyr") +library("ggplot2") +library("pheatmap") +library("RColorBrewer") +library("PoiClaClu") +library("ggbeeswarm") + + +# bioconductor libraries +if (!requireNamespace("BiocManager", quietly = TRUE)) + install.packages("BiocManager", repos='http://cran.us.r-project.org' , dependencies = TRUE) + +BiocManager::install("airway") +BiocManager::install("GenomicFeatures") +BiocManager::install("GenomicAlignments") +BiocManager::install("Rsamtools") +BiocManager::install("BiocParallel") +BiocManager::install("DESeq2") +BiocManager::install("vsn") +BiocManager::install("apeglm") +BiocManager::install("genefilter") +BiocManager::install("AnnotationDbi") +BiocManager::install("org.Hs.eg.db") +BiocManager::install("ReportingTools") +BiocManager::install("Gviz") +BiocManager::install("sva") +BiocManager::install("RUVSeq") +BiocManager::install("fission") +BiocManager::install("tximeta") + +library("airway") +library("GenomicFeatures") +library("GenomicAlignments") +library("Rsamtools") +library("BiocParallel") +library("DESeq2") +library("vsn") +library("apeglm") +library("genefilter") +library("AnnotationDbi") +library("org.Hs.eg.db") +library("ReportingTools") +library("Gviz") +library("sva") +library("RUVSeq") +library("fission") +library("tximeta") diff --git a/venn1.tiff b/venn1.tiff new file mode 100644 index 0000000..db15fd4 Binary files /dev/null and b/venn1.tiff differ