diff --git a/.nojekyll b/.nojekyll
new file mode 100644
index 0000000..e69de29
diff --git a/404.html b/404.html
new file mode 100644
index 0000000..3e612db
--- /dev/null
+++ b/404.html
@@ -0,0 +1,452 @@
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Introduction to statistics with R
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ 404 - Not found
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
\ No newline at end of file
diff --git a/assets/Scripts/Day1.R b/assets/Scripts/Day1.R
new file mode 100644
index 0000000..2386827
--- /dev/null
+++ b/assets/Scripts/Day1.R
@@ -0,0 +1,171 @@
+#-----------------
+#-----------------
+# Introduction to statistics with R
+# 2024
+# In Lausanne
+#-----------------
+#-----------------
+
+
+
+#-----------------
+#-----------------
+# 1st exercise
+#-----------------
+
+library(ISwR)
+?hellung
+data(hellung)
+
+summary(hellung)
+
+glucose <- hellung$glucose
+mean(hellung$glucose)
+sd(hellung$glucose)
+mean(hellung$conc)
+sd(hellung$conc)
+mean(hellung$diameter)
+sd(hellung$diameter)
+
+means.hellung <- c()
+for (i in 1:3){
+ means.hellung <- c(means.hellung, mean(hellung[,i]))
+ print(means.hellung)
+}
+means.hellung
+
+stdev.hellung <- c()
+for (i in 1:3){
+ stdev.hellung <- c(stdev.hellung, sd(hellung[,i]))
+}
+stdev.hellung
+
+par(mfrow=c(2,2)) # for viewing multiple plots (2 rows x 2 columns = 4 plots)
+hist(hellung$conc, main="Hellung data", xlab="concentration", ylab="freq")
+hist(hellung$diameter, col="red")
+hist(hellung$glucose)
+hist(hellung$conc, breaks=20)
+
+par(mfrow=c(1,2)) # for viewing multiple plots
+boxplot( conc ~ glucose,data=hellung)
+boxplot(diameter ~ glucose, data=hellung)
+boxplot(hellung$conc ~ hellung$glucose)
+boxplot(hellung$diameter ~ hellung$glucose)
+
+
+cor(hellung$conc, hellung$diameter)
+plot(diameter ~ conc, data=hellung)
+cor(log(hellung$conc), hellung$diameter)
+plot(diameter ~ log(conc), data=hellung)
+
+# a fancy plot with ggplot :)
+library(ggplot2)
+ggplot(hellung, aes(x=log(conc), y=diameter)) + geom_point()
+
+
+
+#-----------------
+#-----------------
+# 2nd exercise
+#-----------------
+
+setwd("/Users/Rachel/Desktop/Introduction-to-statistics-with-R/docs/assets/exercises/")
+data <- read.csv("data.csv")
+
+
+data
+summary(data)
+sd(data[,1]); sd(data[,2]); sd(data[,3])
+
+datatoplot <- data[,1]
+#pdf("datanumber1.pdf")
+## Plot 4 rows of graphs on one plot
+par(mfrow=c(4,1))
+
+# 1st plot: individual points on the x-axis; random noise on the
+# y-axis so that points are not too much superimposed
+plot(datatoplot, runif( length(datatoplot), -1, 1), xlim=range(datatoplot))
+
+# 2nd plot: histogram, with the density line superimposed
+hist(datatoplot, xlim=range(datatoplot), breaks=20)
+lines(density(datatoplot))
+
+# 3rd plot: average +/- Sd
+plot(mean(datatoplot), 0, xlim=range(datatoplot), main="Mean and standard deviation of a")
+arrows(mean(datatoplot)-sd(datatoplot), 0, mean(datatoplot)+sd(datatoplot), 0, angle=90, code=3)
+
+# 4th plot: boxplot
+boxplot(datatoplot, horizontal=TRUE, ylim=range(datatoplot))
+#dev.off()
+
+## now I am looking at the second column
+
+datatoplot <- data[,2]
+#pdf("datanumber2.pdf")
+## Plot 4 rows of graphs on one plot
+par(mfrow=c(4,1))
+
+# 1st plot: individual points on the x-axis; random noise on the
+# y-axis so that points are not too much superimposed
+plot(datatoplot, runif( length(datatoplot), -1, 1), xlim=range(datatoplot))
+
+# 2nd plot: histogram, with the density line superimposed
+hist(datatoplot, xlim=range(datatoplot), breaks=20)
+lines(density(datatoplot))
+
+# 3rd plot: average +/- Sd
+plot(mean(datatoplot), 0, xlim=range(datatoplot), main="Mean and standard deviation of a")
+arrows(mean(datatoplot)-sd(datatoplot), 0, mean(datatoplot)+sd(datatoplot), 0, angle=90, code=3)
+
+# 4th plot: boxplot
+boxplot(datatoplot, horizontal=TRUE, ylim=range(datatoplot))
+#dev.off()
+
+## now I am looking at the third column
+
+datatoplot <- data[,3]
+#pdf("datanumber3.pdf")
+## Plot 4 rows of graphs on one plot
+par(mfrow=c(4,1))
+
+# 1st plot: individual points on the x-axis; random noise on the
+# y-axis so that points are not too much superimposed
+plot(datatoplot, runif( length(datatoplot), -1, 1), xlim=range(datatoplot))
+
+# 2nd plot: histogram, with the density line superimposed
+hist(datatoplot, xlim=range(datatoplot), breaks=20)
+lines(density(datatoplot))
+
+# 3rd plot: average +/- Sd
+plot(mean(datatoplot), 0, xlim=range(datatoplot), main="Mean and standard deviation of a")
+arrows(mean(datatoplot)-sd(datatoplot), 0, mean(datatoplot)+sd(datatoplot), 0, angle=90, code=3)
+
+# 4th plot: boxplot
+boxplot(datatoplot, horizontal=TRUE, ylim=range(datatoplot))
+#dev.off()
+
+
+## Last exercise
+
+
+student <- read.table("students.csv",header=TRUE,sep=",")
+student[,8]<- as.numeric(gsub(",",".",student[,8]))
+student[,1]<- as.factor(student[,1])
+student[,5]<- as.factor(student[,5])
+student[,6]<- as.factor(student[,6])
+student[student[,"leftrighthanded"] =="D","leftrighthanded"] <- "R"
+student[student[,"leftrighthanded"] =="G","leftrighthanded"] <- "L"
+
+student[student[,"smoker"] =="NS ","smoker"] <- "NS"
+student[student[,"smoker"] =="nS","smoker"] <- "NS"
+student$smoker <- factor(student$smoker,levels=unique(student$smoker))
+student$leftrighthanded <- as.factor(as.character(student$leftrighthanded))
+summary(student)
+
+student[student[,"height"] ==1.77,"height"] <-177
+
+plot(student$height,student$weight,col=student$gender)
+boxplot(height~gender,data=student)
+boxplot(weight~gender,data=student)
+hist(student$weight)
+
diff --git a/assets/Scripts/Day2.R b/assets/Scripts/Day2.R
new file mode 100644
index 0000000..60c485c
--- /dev/null
+++ b/assets/Scripts/Day2.R
@@ -0,0 +1,214 @@
+#-----------------
+#-----------------
+# Introduction to statistics with R
+# 6 - 9 February 2023
+# In Lausanne
+#-----------------
+#-----------------
+
+library(faraway)
+library(ggpubr)
+library(ISwR)
+library(rstatix)
+library(tidyverse)
+
+
+
+#-----------------
+#-----------------
+#-----------------
+# 1st exercise
+#-----------------
+
+data(intake)
+?intake
+attach(intake)
+intake
+names(intake)
+summary(intake)
+mean(intake$pre)
+sd(intake$pre)
+
+# Assumption: no significant outliers in the data
+
+ggboxplot(intake$pre, width = 0.5, add = c("mean","jitter"),
+ ylab = "premenstrual intake", xlab = F)
+
+identify_outliers(as.data.frame(intake$pre))
+
+# Assumption: normality
+qqplot
+qqline
+ggqqplot(intake,"pre")
+
+shapiro_test(intake$pre)
+
+# t test
+
+t.test(pre, mu=7725)
+t.test(pre, mu=7725, alternative="less")
+
+
+
+#-----------------
+#-----------------
+# 2nd exercise: two samples t-test
+#-----------------
+
+data(energy)
+?energy
+energy
+
+# assumption 1: data in each group are normally distributed.
+
+ind.obese <- which(energy$stature == "obese")
+ind.lean <- which(energy$stature == "lean")
+
+shapiro_test(energy$expend[ind.obese])
+shapiro_test(energy$expend[ind.lean])
+
+# assumption 2: the variances for the two independent groups are equal.
+
+levene_test(energy, expend~stature)
+# if the command above does not work, use the levene test from the car package
+car::leveneTest(expend~stature, energy, center = "median")
+
+# t test
+
+t.test(energy$expend ~ energy$stature,var.equal=TRUE)
+
+t.test(energy$expend ~ energy$stature)
+
+
+#-----------------
+#-----------------
+# 3rd exercise: paired t-test
+#-----------------
+
+data(intake)
+?intake
+attach(intake)
+intake
+
+# assumption 1: Each of the paired measurements must be obtained from the same subject
+# check your sampling design !
+
+# assumption 2: The measured differences are normally distributed.
+
+intake.diff <- intake$post - intake$pre
+#intake.diff.df <- as.data.frame(intake.diff)
+
+shapiro_test(intake.diff)
+
+# t test
+
+t.test(intake$pre, intake$post, paired = T)
+
+
+
+#-----------------
+#-----------------
+# 4th exercise: simulations of datasets
+#-----------------
+## change these how you want!
+KO <- rnorm(1000, mean=0,sd=1)
+WT <- rnorm(10, mean=4, sd=1)
+KO <- as.data.frame(KO)
+names(KO) <- "weight"
+KO$genotype <- "KO"
+WT <- as.data.frame(WT)
+names(WT) <- "weight"
+WT$genotype <- "WT"
+
+KO_WT <- rbind(KO,WT)
+
+boxplot(KO_WT$weight ~ KO_WT$genotype, main="Mice weight at 18 weeks", xlab="", ylab="")
+
+res.welch.test <- t.test(KO_WT$weight ~ KO_WT$genotype)
+res.t.test <- t.test(KO_WT$weight ~ KO_WT$genotype, var.equal = T)
+
+res.welch.test
+res.t.test
+
+res.welch.test$p.value
+res.t.test$p.value
+
+sim.p.welch.test <- NULL
+sim.p.t.test <- NULL
+
+for (i in 1:1000) {
+ KO <- runif(10, min=27, max=34)
+ WT <- runif(10, min=27, max=34)
+ KO <- as.data.frame(KO)
+ names(KO)[1] <- "weight"
+ KO$genotype <- "KO"
+ WT <- as.data.frame(WT)
+ names(WT)[1] <- "weight"
+ WT$genotype <- "WT"
+
+ KO_WT <- rbind(KO,WT)
+
+ res.welch.test <- t.test(KO_WT$weight ~ KO_WT$genotype)
+ res.t.test <- t.test(KO_WT$weight ~ KO_WT$genotype, var.equal = T)
+
+ sim.p.welch.test <- c(sim.p.welch.test, res.welch.test$p.value)
+ sim.p.t.test <- c(sim.p.t.test, res.t.test$p.value)
+}
+
+str(sim.p.welch.test)
+str(sim.p.t.test)
+sum(sim.p.welch.test < 0.05)
+sum(sim.p.t.test < 0.05)
+plot(sim.p.t.test,sim.p.welch.test)
+adj.bonf <- p.adjust(sim.p.welch.test, method="bonf")
+sum(adj.bonf < 0.05)
+adj.BH <- p.adjust(sim.p.welch.test, method="BH")
+sum(adj.BH < 0.05)
+
+
+
+#-----------------
+#-----------------
+# 5th exercise: ANOVA
+#-----------------
+
+data(coagulation)
+
+# check the data
+summary(coagulation)
+get_summary_stats(group_by(coagulation,diet),coag, type = "mean_sd")
+coagulation %>% group_by(diet) %>% get_summary_stats(coag, type = "mean_sd")
+
+boxplot(coagulation$coag ~ coagulation$diet)
+
+ggboxplot(coagulation, x="diet",y="coag")
+
+# check normality
+
+?ggqqplot
+ggqqplot(coagulation[coagulation$diet=="A",], "coag")
+ggqqplot(coagulation[coagulation$diet=="B",], "coag")
+ggqqplot(coagulation[coagulation$diet=="C",], "coag")
+ggqqplot(coagulation[coagulation$diet=="D",], "coag")
+
+shapiro.test(coagulation[coagulation$diet=="A","coag"])
+shapiro.test(coagulation[coagulation$diet=="B","coag"])
+shapiro.test(coagulation[coagulation$diet=="C","coag"])
+shapiro.test(coagulation[coagulation$diet=="D","coag"])
+
+# check variance equality
+levene_test(coagulation,coag~diet)
+# if the command above does not work, use the levene test from the car package
+car::leveneTest(coag~diet, coagulation, center = "median")
+
+# do anova
+anova_diet <- aov(coagulation$coag~coagulation$diet)
+
+summary(anova_diet)
+
+# check pairwise
+
+TukeyHSD(anova_diet)
+
+pairwise.t.test(coagulation$coag,coagulation$diet,p.adj="bonf")
+pairwise.t.test(coagulation$coag,coagulation$diet,p.adj="BH")
diff --git a/assets/Scripts/Day3.R b/assets/Scripts/Day3.R
new file mode 100644
index 0000000..bcd1a22
--- /dev/null
+++ b/assets/Scripts/Day3.R
@@ -0,0 +1,204 @@
+#####
+## Exercise class
+#####
+
+### Go to the right directory
+
+class<- read.csv("class.csv")
+
+##inspect the data
+dim(class)
+head(class)
+summary(class[,-1])
+
+## Problem the data set does not have column of Gender as a factor
+#
+class <- as.data.frame(class)
+class$Gender <- as.factor(class$Gender)
+
+#inspect the pairs of variables on 2by2plots
+pairs(class[,-c(1)])
+
+# Investigating Height ~ Age without the attach function
+Height2 <- class$Height
+Age2<- class$Age
+lm( Height2 ~ Age2)
+
+## with the attach function
+attach(class)
+lm( Height ~ Age, data=class)
+model <- lm( Height ~ Age, data=class)
+model
+
+summary(model)
+
+##plot the age vs Height and add the fitted line with abline
+plot( class$Age, class$Height)
+abline(model, col="red", lwd=2)
+
+#change the range of xaxis and yaxis in order to visually see the intersept
+plot(class$Age, class$Height,
+ xlim=range(0,class$Age),
+ ylim=range(coef(model)[1], class$Height))
+abline(model, col="red", lwd=2)
+
+##Do a summary of the linear model to see the residuals the degrees of freedom and the p-values estimated
+summary( lm( Height ~ Age, data = class) )
+
+##
+data(anscombe)
+
+##
+
+anscombe
+dim(anscombe)
+anscombe[1:3, ]
+summary(anscombe)
+boxplot(anscombe)
+par(mfrow=c(2,2),pty="s")
+plot(x1,y1)
+plot(x2,y2)
+plot(x3,y3)
+plot(x4,y4)
+plot(x2,y2)
+plot(x2, y2)
+#urve( -5.99+2.78*x+0.02415*x^2, add=TRUE)
+
+plot(x2, y2)
+curve( 5.30362+0.02415*x^2, add=TRUE)
+summary(lm(y2 ~ (x2 + I(x2^2)) ))
+
+z2 <- x2^2
+
+summary(lm(y2 ~ x2 + z2))
+
+summary(lm(y2 ~ z2))
+####
+## Afternoon script 3rd Day
+####
+
+####
+## Thuesen
+####
+
+
+library(ISwR)
+data(thuesen)
+?thuesen
+thuesen
+
+sv <- thuesen$short.velocity
+bg <- thuesen$blood.glucose
+
+summary(thuesen)## we already see a NA
+cor(thuesen)## this gives a problem
+?cor
+round(cor(thuesen,use="complete.obs"),4)
+
+plot(bg, sv)
+
+plot(bg, sv, pch=16, xlab="Blood Glucose", ylab= "Shortening Velocity")
+## linear model
+th.lm <- lm(sv ~ bg)
+summary(th.lm)
+
+abline(lm(sv ~ bg))
+
+
+## regression line
+reg_line <- 1.09781 + 0.02196 * bg
+reg_line2 <- coef(th.lm)[1]+coef(th.lm)[2]*bg
+
+
+### look at residuals
+th.resid <- resid(th.lm)
+
+th.resid
+th.lm$residuals
+bg.1 <- bg[! is.na(sv)]
+plot(bg.1,th.resid,pch=16)
+abline(h=0)
+
+qqnorm(th.resid)
+qqline(th.resid)
+shapiro.test(th.resid)
+
+### here same as the previous plot but in general with several variables you will not have it.
+th.fv <- fitted.values(th.lm)
+plot(th.fv, th.resid,pch=16)
+abline(h=0)
+
+#### caculating the hat
+
+th.hat <- lm.influence(th.lm)
+sort(th.hat$hat)
+
+index <- seq(1:length(th.hat$hat))
+
+plot(index,th.hat$hat,xlab="Index",ylab="Hat value", ylim=c(0,0.3)) # ylim sets the range of the y-xis
+abline(h=c(2*2/23,3*2/23),lty=c(2,3),col=c("blue","red") ) # h for horizontal lines, here two specified together
+
+
+#### Identification of influencial points
+
+th.highlev <- identify(index,th.hat$hat)
+th.highlev <- c(4,13)
+th.hat$hat
+
+thuesen[th.highlev,]
+thuesen
+
+### ploting influencial points on the final picture
+plot(bg, sv, pch=16, xlab="Blood Glucose", ylab= "Shortening Velocity")
+abline(lm(sv~bg))
+points(bg[th])
+points(bg[th.highlev],sv[th.highlev],pch=16,col="blue",cex=2)
+pd <- predict.lm(th.lm,interval="confidence")
+lines(sort(bg.1),as.data.frame(pd)$lwr[order(bg.1)],col="grey")
+lines(sort(bg.1),as.data.frame(pd)$upr[order(bg.1)],col="grey")
+pd <- predict.lm(th.lm,interval="confidence",level=0.99)
+lines(sort(bg.1),as.data.frame(pd)$lwr[order(bg.1)],col="pink")
+lines(sort(bg.1),as.data.frame(pd)$upr[order(bg.1)],col="pink")
+
+names(as.data.frame(pd))
+####
+## ESR1 expression
+####
+
+### go in the directory where you have the data
+setwd("/Users/Rachel/Downloads/2020/IS20/")
+##open it and look at it
+clin <- read.csv("clindata.csv")
+expr <- read.csv("expression-esr1.csv")
+head(clin)
+summary(clin)
+clin$er <- as.factor(clin$er)
+clin$treatment <- as.factor(clin$treatment )
+rownames(clin)<-clin[,1]
+summary(clin)
+head(expr)
+dim(expr)
+#rownames(expr)<- expr[,1]
+##check all the correlation (Pearson) and see which one correspond
+cor(expr)
+rownames(expr) == clin$sample
+##for loop to see all the correlations with ER status
+for(i in 1:9){
+ print(cor(expr[,i],as.numeric(clin[rownames(expr),"er"]),method="spearman"))
+}
+### put them in a variable
+s <- c()
+for(i in 1:9){
+ s[i] <-cor(expr[,i],as.numeric(clin[rownames(expr),"er"]),method="spearman")
+}
+head(clin)
+
+### do some boxplots
+plot(clin$er,expr[,1])
+
+pat0 <- expr[clin$er==0,1]
+pat1 <- expr[clin$er==1,1]
+shapiro.test(pat0)
+shapiro.test(pat1)
+
+t.test(pat0,pat1)
diff --git a/assets/Scripts/Day4.R b/assets/Scripts/Day4.R
new file mode 100644
index 0000000..9b1f906
--- /dev/null
+++ b/assets/Scripts/Day4.R
@@ -0,0 +1,258 @@
+
+#####################
+## Morning
+#####################
+
+############
+### PCA exercise
+############
+
+### open the data
+
+data(iris)
+iris
+head(iris)
+summary(iris)
+
+boxplot(iris[, 1:4])
+
+pairs(iris[,1:4], col = iris$Species, pch = 19)
+
+boxplot(iris$Petal.Width ~ iris$Species)
+?prcomp
+pca.iris.cov = prcomp(iris[, 1:4], center = TRUE, scale. = FALSE)
+summary(pca.iris.cov)
+names(pca.iris.cov)
+d <- round(pca.iris.cov$sdev^2/sum(pca.iris.cov$sdev^2),5)
+
+plot(pca.iris.cov$sdev,type="b")
+
+plot(pca.iris.cov$x, col = iris$Species, pch = 19,xlab=paste0("PC1 (",d[1]*100,"%)"),ylab="PC2 (5%)")
+
+
+pca.iris.cov_nc = prcomp(iris[, 1:4],center=FALSE, scale. = TRUE)
+plot(pca.iris.cov_nc$x, col = iris$Species, pch = 19)
+
+pca.iris.cov_nc_ns = prcomp(iris[, 1:4],center=FALSE, scale. = FALSE)
+plot(pca.iris.cov_nc_ns$x, col = iris$Species, pch = 19)
+
+pca.iris.cov_c_s = prcomp(iris[, 1:4],center=TRUE, scale. = TRUE)
+
+
+
+plot(pca.iris.cov_c_s$x[,c(1,3)], col = iris$Species, pch = 19)
+legend("bottomright", fill = unique(iris$Species), legend = c( levels(iris$Species)))
+
+pca.iris.cov$rotation
+summary(pca.iris.cov)
+biplot(pca.iris.cov, scale = 0)
+biplot(pca.iris.cov, scale = 0,col = c("white", "deeppink3"))
+summary(iris)
+# iris.centered_scaled = scale(iris[, 1:4], center = TRUE, scale = TRUE) # compute linear combination
+iris.centered = scale(iris[, 1:4], center = TRUE, scale = FALSE) # compute linear combination
+# summary(iris.centered_scaled)
+summary(iris.centered)
+scores.sample1 = iris.centered[1, ] %*% pca.iris.cov$rotation # compare to PCA scores
+pca.iris.cov$x[1, ]==scores.sample1
+
+?prcomp
+
+var(iris[, 1:4])
+
+
+pca.iris.corr = prcomp(iris[, 1:4], center = TRUE, scale. = TRUE)
+plot(pca.iris.corr$x, col = iris$Species, pch = 16)
+pca.iris.corr$rotation
+summary(pca.iris.corr)
+biplot(pca.iris.corr, scale = 0)
+
+
+par(mfrow = c(1, 2))
+screeplot(pca.iris.cov, type = "line")
+screeplot(pca.iris.corr, type = "line")
+
+?screeplot
+
+###################
+### Matrix
+####
+
+mat <- matrix(rnorm(300,0,10),nrow=150)
+
+mat.dist <- as.matrix(dist(mat))
+head(dist(mat))
+
+heatmap(mat.dist,scale="none",Colv = NA,Rowv=NA)
+colorScale <- rev(colorRampPalette(c("blue","green","yellow","red","darkred"))(1000))
+head(colorScale)
+heatmap(mat.dist,scale="none",Colv = NA,Rowv=NA,col=colorScale)
+?hclust
+
+hE <- hclust(dist(mat))
+
+plot(hE)
+# if (!require("BiocManager", quietly = TRUE))
+# install.packages("BiocManager")
+#
+# BiocManager::install("GEOquery")
+
+library(GEOquery) ## Retrieve the data from GEO
+gds <- getGEO("GDS5093") ## If you have already downloaded the data, you can load the soft file directly ## gds <- getGEO("GDS5093.soft.gz") ## Look at the elements of the downloaded data
+head(Columns(gds))
+head(Table(gds))
+head(Meta(gds)) ## Convert the gds object to an expression set
+eset <- GDS2eSet(gds)
+eset[1:3,1:3]
+
+pca <- prcomp(t(exprs(eset)), scale. = TRUE)
+?prcomp
+##centering?
+plot(pca$x, pch = 19, cex = 2)
+plot(pca)
+round(pca$sdev^2/sum(pca$sdev^2),2)
+
+plot(pca$x, pch = 19, cex = 2, col = factor(pData(eset)$disease.state))
+legend("topright", legend = levels(factor(pData(eset)$disease.state)), col = 1:4, pch = 19)
+
+
+vars <- apply(exprs(eset), 1, var)
+head(vars)
+vars.order <- order(vars, decreasing = TRUE)
+head(vars.order)
+pca.5000 <- prcomp(t(exprs(eset)[vars.order[1:5000], ]), scale. = TRUE)
+plot(pca.5000$x, pch = 19, cex = 2, col = factor(pData(eset)$disease.state))
+legend("topright", legend = levels(factor(pData(eset)$disease.state)), col = 1:4, pch = 19)
+pca.100 <- prcomp(t(exprs(eset)[vars.order[1:100], ]), scale. = TRUE)
+plot(pca.100$x, pch = 19, cex = 2, col = factor(pData(eset)$disease.state))
+legend("topright", legend = levels(factor(pData(eset)$disease.state)), col = 1:4, pch = 19)
+
+plot(pca.100$x, pch = 19, cex = 2, col = factor(pData(eset)$infection))
+
+pc2.weights <- data.frame(pca.100$rotation[, 2, drop = FALSE])
+pc2.weights$ChromosomeLoc <- fData(eset)[rownames(pc2.weights), "Chromosome location"]
+
+head(pc2.weights[order(pc2.weights$PC2), ])
+tail(pc2.weights[order(pc2.weights$PC2), ])
+
+
+
+#####################
+## Afternooon
+#####################
+
+######
+### Afternoon exercise
+######
+
+
+library(golubEsets)
+data(Golub_Train)
+golub.expr = exprs(Golub_Train)
+golub.sample.annot = Golub_Train$ALL.AML
+dim(golub.expr)
+head(golub.expr[,1:3])
+summary(golub.expr)
+head(golub.expr)
+pca.golub.cov = prcomp(t(golub.expr), center = TRUE, scale. = FALSE)
+plot(pca.golub.cov$x[, 1:2], col = golub.sample.annot, pch = 19)
+legend("topleft",legend=levels(factor(golub.sample.annot)),col=1:2,pch=20)
+
+pca.golub.corr = prcomp(t(golub.expr), center = TRUE, scale. = TRUE)
+plot(pca.golub.corr$x[, 1:2], col = golub.sample.annot, pch = 19)
+
+golub.expr.filtered = golub.expr[order(apply(golub.expr, 1, var), decreasing = TRUE)[1:1000], ]
+pca.golub.filtered.corr = prcomp(t(golub.expr.filtered), center = TRUE, scale. = TRUE)
+plot(pca.golub.filtered.corr$x[, 1:2], col = golub.sample.annot, pch = 19)
+
+library(mclust)
+data(banknote)
+summary(banknote)
+
+banknote.df <- banknote[,-1]
+summary(banknote.df)
+
+pca.banknote = prcomp(banknote[, 2:7], center = TRUE, scale. = TRUE)
+summary(pca.banknote)
+
+plot(pca.banknote$x[, 1:2], col = banknote[,1], pch = 19)
+arrows(0, 0, 2*pca.banknote$rotation[, 1], 2*pca.banknote$rotation[, 2], col = "red", angle = 20, length = 0.1)
+text(2.4*pca.banknote$rotation[, 1:2], colnames(banknote[, 2:7]), col = "red")
+
+par(mfrow = c(2, 3))
+for (v in c("Length", "Left", "Right", "Bottom", "Top", "Diagonal")) { boxplot(banknote[, v] ~ banknote[, "Status"], xlab = "Banknote status", ylab = v) }
+
+
+#Points in plates-continuous
+
+library("cluster")
+mydata1<-read.csv("dataClustering.csv")
+summary(mydata1)
+df<-data.frame(mydata1$Coord_X ,mydata1$Coord_Y )
+colnames(df) <- c("X", "Y")
+plot(df$X, df$Y, pch=20)
+
+
+
+#evaluate Euclidian distance and display distance matrix
+df.dist<-dist(df)
+# classify
+df.h<-hclust(df.dist,method="average")
+plot(df.h)
+
+colorScale <- colorRampPalette(c("blue", "green","yellow","red","darkred"))(1000)
+heatmap(as.matrix(df.dist), scale="none", col=colorScale)
+
+#KMEANS
+kmeans(df,3)$cluster
+
+cl.1 <- kmeans(df, 3, iter.max = 1)
+plot(df, col = cl.1$cluster)
+points(cl.1$centers, col = 1:5, pch = 8)
+
+
+kmeans(df,3)
+
+
+cl.10 <- kmeans(df, 3, iter.max = 10)
+plot(df, col = cl.10$cluster)
+points(cl.10$centers, col = 1:5, pch = 8)
+
+cl.100 <- kmeans(df, 3, iter.max = 100)
+plot(df, col = cl.100$cluster)
+points(cl.100$centers, col = 1:5, pch = 8)
+
+
+
+#CMEANS
+install.packages("e1071")
+library(e1071)
+cmeans(df,3)
+
+cl.1 <- cmeans(df, 3, iter.max = 1)
+plot(df, col = cl.1$cluster)
+points(cl.1$centers, col = 1:5, pch = 8)
+
+cl.10 <- cmeans(df, 3, iter.max = 10)
+plot(df, col = cl.10$cluster)
+points(cl.10$centers, col = 1:5, pch = 8)
+
+cl.100 <- cmeans(df, 3, iter.max = 100)
+plot(df, col = cl.100$cluster)
+points(cl.100$centers, col = 1:5, pch = 8)
+
+
+
+#MCLUST
+library("mclust")
+BIC <- mclustBIC(df)
+plot(BIC)
+summary(BIC)
+mod1 <- Mclust(df, x = BIC)
+summary(mod1, parameters = TRUE)
+plot(mod1, what = "classification",xlim=c(1000,2000),ylim=c(1000,2000))
+
+mod2 <- Mclust(df, modelName = c("VEE"))
+plot(mod2, what = "classification")
+
+mod3 <- Mclust(df, modelName = "EEE",G=9)
+plot(mod3, what = "classification")
\ No newline at end of file
diff --git a/assets/exercises/Exercises_IS.zip b/assets/exercises/Exercises_IS.zip
new file mode 100644
index 0000000..9369e89
Binary files /dev/null and b/assets/exercises/Exercises_IS.zip differ
diff --git a/assets/exercises/Golub_Train.RData b/assets/exercises/Golub_Train.RData
new file mode 100644
index 0000000..b8ca3ac
Binary files /dev/null and b/assets/exercises/Golub_Train.RData differ
diff --git a/assets/exercises/IS_24_exam.csv b/assets/exercises/IS_24_exam.csv
new file mode 100644
index 0000000..2711ccb
--- /dev/null
+++ b/assets/exercises/IS_24_exam.csv
@@ -0,0 +1,508 @@
+Age,Weight,Height,Gender,Shoulder_girth,Chest_girth,Waist_girth,Abdominal_girth,Hip_girth
+21,65.6,174,1,106.2,89.5,71.5,74.5,93.5
+23,71.8,175.3,1,110.5,97,79,86.5,94.8
+28,80.7,193.5,1,115.1,97.5,83.2,82.9,95
+23,72.6,186.5,1,104.5,97,77.8,78.8,94
+22,78.8,187.2,1,107.5,97.5,80,82.5,98.5
+21,74.8,181.5,1,119.8,99.9,82.5,80.1,95.3
+26,86.4,184,1,123.5,106.9,82,84,101
+27,78.4,184.5,1,120.4,102.5,76.8,80.5,98
+23,62,175,1,111,91,68.5,69,89.5
+21,81.6,184,1,119.5,93.5,77.5,81.5,99.8
+23,76.6,180,1,117.1,97.7,81.9,81,98.4
+22,83.6,177.8,1,123.5,99.5,82.6,82.5,95
+20,90,192,1,116.5,103,85,94.5,103
+26,74.6,176,1,113,99.6,85.6,89.2,98
+23,71,174,1,107.5,101.5,78,89.5,95
+22,79.6,184,1,112,104.1,82,84,97
+30,93.8,192.7,1,112.2,100,88.3,93.5,105
+22,70,171.5,1,120,93.8,73.6,74.9,90.1
+29,72.4,173,1,109,98.5,78.5,86,94.5
+22,85.9,176,1,118.5,104,87.3,88,101.1
+22,78.8,176,1,116,100,92,91,98
+20,77.8,180.5,1,111,100,80,83.7,99.5
+22,66.2,172.7,1,117.7,99,74.5,75.9,92.2
+24,86.4,176,1,123.9,101,90.6,89.6,101.2
+26,81.8,173.5,1,120.6,101.6,81.4,81.6,98.8
+24,89.6,178,1,129.5,108.8,89.5,89.5,106
+21,82.8,180.3,1,115,100,85,94.5,105
+24,76.4,180.3,1,116,88,73.5,77.7,97
+23,63.2,164.5,1,107.8,88.7,75.8,83,89
+19,60.9,173,1,100.2,84.5,74,81,93.5
+23,74.8,183.5,1,113,93.6,77.5,82.1,95
+25,70,175.5,1,117.9,105,74,72,90
+23,72.4,188,1,112.5,90.9,74,78.8,96.4
+23,84.1,189.2,1,110.5,91.2,82,89.5,100
+23,69.1,172.8,1,112,98.4,73,83,95.4
+20,59.5,170,1,104,85,70.5,84,90
+22,67.2,182,1,114.8,97.2,75,77.2,91.3
+24,61.3,170,1,108,91.5,72.1,79.2,91
+22,68.6,177.8,1,111.2,91.2,78.8,78,93.2
+24,80.1,184.2,1,118.3,101.1,77.5,78,97
+21,87.8,186.7,1,115.2,104.3,91.5,93.2,103.9
+23,84.7,171.4,1,129.9,110.8,84.9,83,102.6
+24,73.4,172.7,1,112.9,96.3,79.1,78.3,97.1
+35,72.1,175.3,1,112.2,102.7,77.9,77.9,90.7
+29,82.6,180.3,1,117.1,103.9,91.7,89.4,101.8
+25,88.7,182.9,1,118.7,105.6,86.6,87.3,103.9
+23,84.1,188,1,109.2,95.8,84.7,84,101.4
+20,94.1,177.2,1,128.1,111.2,90.3,93.5,108.7
+25,74.9,172.1,1,113.3,100,79.7,87.1,98.4
+29,59.1,167,1,108.4,91.6,73.1,75.4,86.5
+23,75.6,169.5,1,118.7,108,79.8,82.5,94.8
+23,86.2,174,1,126.3,109.6,81.6,86.5,100.9
+36,75.3,172.7,1,124.2,105.7,76.8,83.4,98
+25,87.1,182.2,1,126.7,109.1,85.9,90.4,100.9
+24,55.2,164.1,1,103.3,88.8,73.3,77.9,85.7
+20,57,163,1,101.2,86.1,69.9,67.4,84.1
+52,61.4,171.5,1,104.3,91.3,72.7,83.2,91.4
+50,76.8,184.2,1,113.2,100.6,82.7,83.5,98
+46,86.8,174,1,121.9,105.5,90.1,89.2,104.5
+51,72.2,174,1,113.1,97.5,82.9,83.6,95.8
+28,71.6,177,1,108.5,94.4,77.9,79,91.7
+48,84.8,186,1,113.9,99.6,92.5,96.2,103.4
+35,68.2,167,1,112.6,98.1,77.8,77.2,90
+23,66.1,171.8,1,110.2,93.6,72.7,77.3,91.7
+23,72,182,1,108.7,93.4,75,79.2,94
+62,64.6,167,1,104,92,76,83,93
+21,74.8,177.8,1,115.2,99.2,82.7,84.2,93
+26,70,164.5,1,111.9,97.6,80,85.7,97.4
+33,101.6,192,1,127,108.8,107.1,107.2,108.3
+36,63.2,175.5,1,111.2,91.9,76.2,78.1,90
+41,79.1,171.2,1,122,105.2,90.2,88.6,100.2
+40,78.9,181.6,1,114.5,98.3,89.4,87.4,97.7
+27,67.7,167.4,1,109.5,92.5,80.9,78.5,96
+27,66,181.1,1,110.8,92.5,73.5,76.4,92
+23,68.2,177,1,118.8,101.6,70.9,76.7,95.3
+31,63.9,174.5,1,108,94.6,76.1,78,86.3
+26,72,177.5,1,114.3,92.5,81,85.2,92.5
+23,56.8,170.5,1,105.4,88.2,72,72,85.5
+24,74.5,182.4,1,115,91,76.8,80,94.5
+24,90.9,197.1,1,119.5,106,86,92,103
+34,93,180.1,1,130,115,98.5,106.6,116.5
+21,80.9,175.5,1,113.3,100,79,82.5,98.5
+25,72.7,180.6,1,113.2,94.7,77.5,80.5,92
+34,68,184.4,1,106.9,92.5,75.2,80.2,91.6
+31,70.9,175.5,1,113.8,96.7,82,82.2,92.7
+40,72.5,180.6,1,117.3,97.4,79.6,80.8,95
+21,72.5,177,1,124.2,106.7,75.2,77.8,94.5
+33,83.4,177.1,1,123,106.2,88.6,88.3,100.5
+25,75.5,181.6,1,117.8,103.6,81.5,83.3,91.8
+29,73,176.5,1,118.8,98.3,79.9,82.4,87.5
+27,70.2,175,1,112,87.8,73.5,77.5,94.9
+44,73.4,174,1,113,99.8,80.3,80.8,93
+26,70.5,165.1,1,116,104.6,81.5,85,92
+22,68.9,177,1,112.8,86.5,74,76.5,91.3
+37,102.3,192,1,125,110,104,99,111.7
+38,68.4,176.5,1,108.3,93.2,76.2,83.8,92.8
+20,65.9,169.4,1,108.2,90,76.5,77.7,91.2
+21,75.7,182.1,1,113,98.4,81,80.5,96.2
+24,84.5,179.8,1,115,107.2,88.8,86.8,100
+45,87.7,175.3,1,123,108.3,94,98,108.2
+25,86.4,184.9,1,120.2,105.7,83.4,86.5,101.1
+22,73.2,177.3,1,114,88.5,77,79,93
+29,53.9,167.4,1,102.9,79.3,75.4,78,88.6
+37,72,178.1,1,112.5,90.9,80.3,80.8,92.8
+20,55.5,168.9,1,104.5,90.2,68,67,81.5
+20,58.4,157.2,1,111.3,91.6,80.6,78,91.3
+32,83.2,180.3,1,117.2,105.2,88.6,94.7,94.7
+23,72.7,170.2,1,112.8,97,81.1,88.2,93.9
+25,64.1,177.8,1,104.8,85.3,70.8,84.9,89.4
+27,72.3,172.7,1,117.7,99.6,73.3,82.1,89.3
+21,65,165.1,1,107.7,94.3,75.9,79.1,92.6
+27,86.4,186.7,1,125.2,111.8,86.2,93.5,96.3
+25,65,165.1,1,109.1,94.3,75,82.2,88
+38,88.6,174,1,122.6,106.1,101,99.7,105.5
+44,84.1,175.3,1,117.3,102,90,92.3,102.3
+27,66.8,185.4,1,109.1,94.8,75,79.6,91.6
+37,75.5,177.8,1,116.7,102.9,75.9,77,93.4
+28,93.2,180.3,1,124.9,115.8,96,95.9,103.6
+33,82.7,180.3,1,118.6,105.4,84,90.4,94.8
+25,58,177.8,1,108.8,87.1,67.1,80.4,85.9
+21,79.5,177.8,1,121.9,104.1,82.5,90.1,98.4
+30,78.6,177.8,1,117.3,95.8,83.7,84.2,98.4
+26,71.8,177.8,1,115,98.6,76.7,85.8,93.3
+27,116.4,177.8,1,134.8,118.7,105.2,105,115.5
+33,72.2,163.8,1,113.8,100.9,90.6,93.3,97.7
+29,83.6,188,1,119.4,98.5,85.7,92.9,98.6
+27,85.5,198.1,1,117.9,96.9,82.5,90.8,94.9
+34,90.9,175.3,1,127.3,110.7,94.7,92,101.3
+42,85.9,166.4,1,118.8,108,105.2,103.4,108.1
+29,89.1,190.5,1,122.4,109,86,90.2,98
+41,75,166.4,1,111.5,104.2,90.9,92.7,100.2
+43,77.7,177.8,1,113.2,100.5,92.4,92.4,97
+43,86.4,179.7,1,115.3,105.7,96.5,98.2,97.4
+29,90.9,172.7,1,122.5,112.4,98.4,101.5,107.9
+27,73.6,190.5,1,114.4,96.2,76.7,83.5,93.9
+62,76.4,185.4,1,112.8,97.5,94.8,98.2,98.6
+33,69.1,168.9,1,112.2,90.9,80.1,79.8,91.3
+45,84.5,167.6,1,119.4,108.4,97.4,103.7,105.3
+30,64.5,175.3,1,108.4,94.3,73.7,74.5,88.2
+20,69.1,170.2,1,122.4,109.1,76.1,90.1,93.3
+22,108.6,190.5,1,128.8,115,95.6,101.9,107.9
+51,86.4,177.8,1,118,104.4,101,98.9,103.3
+34,80.9,190.5,1,116.5,100.1,84.5,84.5,94.4
+44,87.7,177.8,1,120.4,108.4,98,101.8,101.5
+46,94.5,184.2,1,123.1,107.3,101.6,103.8,110
+34,80.2,176.5,1,117.2,101.8,87.8,90.2,98.4
+32,72,177.8,1,113,94.5,80,85,95
+28,71.4,180.3,1,109.4,91.7,81.8,82.9,98.3
+31,72.7,171.4,1,105.7,95.9,84.4,86.8,99
+29,84.1,172.7,1,119.7,110.5,85,83.5,95.7
+42,76.8,172.7,1,118,104,90,86,96
+29,63.6,177.8,1,104.3,86.8,72.9,73.4,89.5
+31,80.9,177.8,1,114.1,106.7,81,80.2,93.7
+30,80.9,182.9,1,119,102.5,86.5,89,97
+27,85.5,170.2,1,113.8,103,93.9,98.6,103.6
+25,68.6,167.6,1,118,95,77,78,93
+24,67.7,175.3,1,116,99,75,75,90
+33,66.4,165.1,1,108.3,89.7,80.6,80.8,90
+45,102.3,185.4,1,129.2,111.5,100.5,107.3,109.5
+37,70.5,181.6,1,109.2,94.1,81.2,84,91.6
+44,95.9,172.7,1,124.3,118.3,103.4,106.2,108.5
+34,84.1,190.5,1,122.6,106.5,90.3,101.1,101.6
+55,87.3,179.1,1,122.4,110.4,98,98,99.6
+43,71.8,175.3,1,114.9,102.3,86.5,87.7,91.9
+24,65.9,170.2,1,111.1,98.5,77.9,87.3,90.8
+22,95.9,193,1,126,111.6,89.1,95.1,104.8
+38,91.4,171.4,1,115.5,106.7,93.9,111.8,111.4
+24,81.8,177.8,1,124.7,110.4,85.3,82.9,96.5
+29,96.8,177.8,1,125.3,114,98.5,103.8,108.1
+25,69.1,167.6,1,118.2,101.8,79.5,90.1,95.3
+37,82.7,167.6,1,124.3,109.6,94.9,94.7,104.3
+30,75.5,180.3,1,118.3,100.7,76.5,87.2,96.3
+26,79.5,182.9,1,122.3,104.3,88.4,89.6,98.8
+35,73.6,176.5,1,116.5,104.2,84.2,84,93.2
+29,91.8,186.7,1,123,107.4,87.6,89.4,106.7
+30,84.1,188,1,117.6,101,83.7,91.1,99.9
+37,85.9,188,1,117.5,103,92.1,91.3,103.8
+34,81.8,177.8,1,117.3,107.2,89.9,94.7,107.1
+28,82.5,174,1,114.5,99,88.7,91,100
+27,80.5,177.8,1,122.9,100.3,83.9,89.4,103.9
+32,70,171.4,1,115.5,100.2,79.5,88.7,95.3
+28,81.8,185.4,1,116.1,99.8,84.5,92.6,99.5
+22,84.1,185.4,1,121.6,107.5,89.2,88.4,107
+44,90.5,188,1,131.6,110.1,90.7,91.9,101.7
+25,91.4,188,1,124.5,107,88.8,97.5,103.8
+49,89.1,182.9,1,115.6,105.6,103.6,100.7,100.6
+54,85,176.5,1,117,103.6,98.5,99.9,103.6
+49,69.1,175.3,1,108.6,97.1,82.9,88.1,91.2
+60,73.6,175.3,1,120.2,109.8,90.5,92.3,95.2
+42,80.5,188,1,116.2,103.3,84.5,94.5,98.2
+52,82.7,188,1,115.4,103.7,86,93.8,97.1
+23,86.4,175.3,1,120,108.5,84.2,88.9,97.5
+33,67.7,170.5,1,110.3,97.8,85.7,89.5,94.9
+46,92.7,179.1,1,119.7,112.7,112.1,105.9,106.3
+43,93.6,177.8,1,123.5,111.4,99.7,102.9,105.8
+56,70.9,175.3,1,107.8,95.1,84.7,92.9,96.7
+21,75,182.9,1,118.7,100.2,80.3,92.4,96.4
+18,93.2,170.8,1,120.7,106.3,98.6,111.7,118.7
+21,93.2,188,1,118.7,109.5,90,96.2,104.3
+45,77.7,180.3,1,118,106.3,86.6,93.9,95.9
+22,61.4,177.8,1,105,91.5,80.2,85.7,89.2
+55,94.1,185.4,1,110.6,104.9,109.2,104.4,101.7
+42,75,168.9,1,123.1,109.6,88.4,92,95.1
+29,83.6,185.4,1,121,102.5,81,84.5,105
+40,85.5,180.3,1,111.7,101.2,88.8,90.8,101.3
+24,73.9,174,1,111,98.7,78.1,78.6,92
+62,66.8,167.6,1,112,96,81.5,80.5,89.5
+26,87.3,182.9,1,115.9,104.2,87.6,89.6,100.5
+35,72.3,160,1,121,103,92.5,88.5,94
+37,88.6,180.3,1,123.6,107,97,95.5,104.5
+34,75.5,167.6,1,120,101,82,82,98
+25,101.4,186.7,1,128.7,112.1,99.5,97.8,107.4
+30,91.1,175.3,1,124.5,103.4,93.8,92.7,112.2
+32,67.3,175.3,1,112.4,100.3,79.1,80.4,94.3
+27,77.7,175.9,1,112.2,95.7,85.8,94.7,106.8
+42,81.8,175.3,1,127,108,90.8,92.4,100.3
+44,75.5,179.1,1,115.3,101,85.4,86.9,101.8
+46,84.5,181.6,1,111.5,98.6,91.6,102.1,106.7
+19,76.6,177.8,1,118.3,101.6,79.7,82,98.4
+43,85,182.9,1,118,99,86.1,90.8,101.3
+28,102.5,177.8,1,127,116.7,113.2,102.9,107.9
+39,77.3,184.2,1,124.4,105,79.5,85.8,92.7
+30,71.8,179.1,1,112.4,95.1,85.4,84.1,94.3
+36,87.9,176.5,1,125.8,106.7,97.9,94.7,104.6
+48,94.3,188,1,131.7,116.6,94.7,93.1,103.3
+48,70.9,174,1,117.3,103.5,86.1,90.5,96.7
+53,64.5,167.6,1,107.6,90.4,84.9,83.7,97.9
+45,77.3,170.2,1,122.4,107.5,92.2,88.6,97.5
+39,72.3,167.6,1,117,100.8,83.7,82.5,97.7
+43,87.3,188,1,119,104.2,97.8,93.6,102.5
+65,80,174,1,123.5,104.9,98.6,99.2,103.3
+45,82.3,176.5,1,121.4,112.8,89.5,96.9,100.9
+37,73.6,180.3,1,112.3,95.7,82.9,89.6,94.8
+55,74.1,167.6,1,113.2,104.9,90.1,90.8,96.6
+33,85.9,188,1,121.7,109.1,78.9,91,98.1
+25,73.2,180.3,1,116.6,105.4,80.7,87.4,95.5
+35,76.3,167.6,1,117.8,104.3,94.3,99.4,100.4
+28,65.9,183,1,118,100.5,70.2,79.3,92
+26,90.9,183,1,131.1,111.8,83.6,92.7,101.5
+43,89.1,179.1,1,121.4,109.5,91.9,96.5,103.3
+30,62.3,170.2,1,116.3,101.2,71.8,82.3,87.6
+26,82.7,177.8,1,121.8,103.3,85,90.8,97.9
+51,79.1,179.1,1,118.2,101.6,85.7,91,95.9
+30,98.2,190.5,1,126.3,103.1,96.5,99,111.8
+24,84.1,177.8,1,121,104.6,82.4,85.7,99.9
+35,83.2,180.3,1,123.1,104.3,86.3,87.8,103.3
+37,83.2,180.3,1,114.9,95.9,83.2,88,100.6
+22,51.6,161.2,2,95,83,66.5,79,92
+20,59,167.5,2,99.5,78.5,61.5,70.5,90.5
+19,49.2,159.5,2,88,75,61.2,66.5,91
+25,63,157,2,97,86.5,78,91,99.5
+21,53.6,155.8,2,103.3,91,70.5,80.5,91.5
+23,59,170,2,93.5,79.5,66.5,78.5,94
+26,47.6,159.1,2,93.3,77,58,64,85.5
+22,69.8,166,2,94.5,88,74.5,87,104
+28,66.8,176.2,2,98.6,85,73.5,92,104.1
+40,75.2,160.2,2,115.5,98.8,90.5,103.5,108.1
+32,55.2,172.5,2,97.9,79,66.5,74,90.3
+25,54.2,170.9,2,97.7,77.6,61,71.8,91.6
+25,62.5,172.9,2,100.5,85,69.5,81.5,94.4
+29,42,153.4,2,88.7,76.7,62,74.1,80.9
+22,50,160,2,96.6,76.7,63.4,69,87.7
+25,49.8,147.2,2,92,82,71,69,88.5
+23,49.2,168.2,2,90,79,59,79,88.5
+37,73.2,175,2,104,89.5,74,92,101
+19,47.8,157,2,90.1,73.5,60.5,68.3,88.5
+23,68.8,167.6,2,104,90,75,80.5,99
+25,50.6,159.5,2,91,80,65,78.3,91
+26,82.5,175,2,111.4,94.5,82.2,94.2,110.2
+24,57.2,166.8,2,96.2,83.8,70.2,82.5,94.2
+29,87.8,176.5,2,117.1,95.2,85,91.2,111
+22,72.8,170.2,2,101.5,91,75,85,103
+30,54.5,174,2,95.1,80,63,76.5,90
+23,59.8,173,2,97.1,81.7,70,81.5,96
+38,67.3,179.9,2,101.4,89.6,72.6,86.3,93.7
+23,67.8,170.5,2,103.7,90.9,78.7,83.5,101.5
+19,47,160,2,89.2,78.5,61,73,82.5
+46,46.2,154.4,2,86,78,64.2,69.8,89
+20,55,162,2,98.1,80.2,63.1,78.9,93.9
+22,83,176.5,2,114,99,85,92.5,106.4
+25,54.4,160,2,95,80,66,78,92
+21,45.8,152,2,87,75.5,65,76.7,86
+23,53.6,162.1,2,100.8,82.6,63.2,70.5,89.1
+31,73.2,170,2,112.2,94.5,83.6,94.2,104.1
+29,52.1,160.2,2,98.7,83.9,68,76.1,88
+19,67.9,161.3,2,100.1,92.8,75.7,88.6,102.6
+21,56.6,166.4,2,100.3,85.3,65.5,74.4,95.9
+23,62.3,168.9,2,100.5,84.4,66.9,79.7,98.8
+24,58.5,163.8,2,101.2,87.6,67.9,82.7,93.5
+20,54.5,167.6,2,96,81,67.8,73,92.9
+19,50.2,160,2,92.8,84.1,63.2,75,86.9
+20,60.3,161.3,2,95.5,88.2,73.1,80,94.9
+19,58.3,167.6,2,98.7,88.1,65.3,75.8,95.3
+20,56.2,165.1,2,96.9,84.9,65.6,75.5,93.3
+19,50.2,160,2,91,81.2,62.7,75.4,90
+22,72.9,170,2,106.3,91.6,81.8,96.5,99.3
+39,59.8,157.5,2,99.8,88.4,72.1,87.3,95.6
+18,61,167.6,2,105,87.6,68.6,80.7,95.8
+19,69.1,160.7,2,106.2,91.3,80,97.9,104.6
+26,55.9,163.2,2,97.7,87.2,64.9,75.9,92.2
+20,46.5,152.4,2,97.4,82.2,61.7,66,80.7
+20,54.3,157.5,2,96.3,82.1,64,73.6,98.1
+26,54.8,168.3,2,98,82.6,58.6,73,89.6
+21,60.7,180.3,2,94.5,86.5,68.3,89.2,94
+21,60,165.5,2,101.4,85.3,69.5,74.9,94.7
+38,62,165,2,95.1,84.7,70.5,86.1,94.1
+23,60.3,164.5,2,101.1,86.8,69.8,76.5,93.7
+37,52.7,156,2,97.4,85.2,69,76.3,86.7
+19,74.3,160,2,104.8,93.9,81,93.2,105.9
+25,62,163,2,94.5,84.5,71,80.5,97.5
+20,73.1,165.7,2,103.2,90.7,73.6,79.8,105.3
+41,80,161,2,110.8,97.4,96.3,104.2,102.6
+26,54.7,162,2,94.6,83.3,65,68.2,91.6
+21,53.2,166,2,96.6,82.1,62.8,70.6,83.9
+47,75.7,174,2,102.8,92.2,83,101.4,108.1
+19,61.1,172.7,2,96.9,83.6,67.6,86.2,99.1
+44,55.7,167.6,2,95.6,82.6,65.4,74.8,89.3
+35,48.7,151.1,2,92.4,77,61.6,74,89.9
+32,52.3,164.5,2,93.7,79.3,63.2,75.5,85.8
+46,50,163.5,2,96.1,84.3,59.4,74,85.8
+22,59.3,152,2,100.1,85.6,62.7,74,96
+49,62.5,169,2,98.8,85,66.6,82,98.7
+52,55.7,164,2,92.2,79.1,64.6,82.5,94.9
+25,54.8,161.2,2,97.3,85,65.7,77.7,90.5
+48,45.9,155,2,90.5,79,63,79.2,86.6
+41,70.6,170,2,110.5,96.2,78.5,93.4,103
+18,67.2,176.2,2,103,86,68.2,76.2,97.9
+30,69.4,170,2,109,89.8,68.5,80.2,98.1
+20,58.2,162.5,2,104.8,84.5,68.8,70.6,94.8
+24,64.8,170.3,2,109.2,88.2,69,77.6,96.5
+23,71.6,164.1,2,117,99.5,78,87.5,103
+30,52.8,169.5,2,93.9,76.1,62,70.8,86.8
+23,59.8,163.2,2,105.5,85.8,65.8,70.5,89.3
+45,49,154.5,2,99.4,82,65,77.2,89.5
+20,50,159.8,2,89.5,77.5,64.9,74.5,88.4
+20,69.2,173.2,2,98.5,85.7,71.5,82,100.5
+23,55.9,170,2,94.9,78.8,61.4,78.8,94
+21,63.4,161.4,2,96.3,88,75.4,90,101.3
+28,58.2,169,2,96.8,80.2,67.2,78.3,95.5
+45,58.6,166.2,2,102.5,85.6,69.5,75.5,95.3
+24,45.7,159.4,2,95.2,81.3,57.9,66.4,84.1
+25,52.2,162.5,2,103,84.6,64.4,77.9,91
+19,48.6,159,2,99.1,82.2,62.3,68.7,83.9
+20,57.8,162.8,2,104.1,84.9,68.7,78.6,93.1
+29,55.6,159,2,99.5,81.5,68,84.6,92.3
+24,66.8,179.8,2,110.2,89.9,66,79.9,97.1
+24,59.4,162.9,2,107.1,89.8,71.2,85.7,97.5
+25,53.6,161,2,95.7,80.8,64.8,79.8,92
+31,73.2,151.1,2,103.4,88.4,78,85.6,112.1
+22,53.4,168.2,2,94.6,80.2,60.7,77,89.9
+20,69,168.9,2,104.5,89.5,75,95,104.9
+32,58.4,173.2,2,97.7,83.7,68.6,83,94.2
+25,56.2,171.8,2,96.4,82.5,67.1,75,90.4
+19,70.6,178,2,103,85.5,68,84.5,99.5
+23,59.8,164.3,2,103.4,88.3,71,87.1,98.7
+22,72,163,2,109.5,91.5,76,82.5,103.5
+20,65.2,168.5,2,110.7,92.2,70.3,82.8,100
+27,56.6,166.8,2,102.2,80.5,69.5,81,95.2
+34,105.2,172.7,2,129.5,108,101.5,105.5,114
+25,51.8,163.5,2,99.2,80,67.2,75.2,91.2
+26,63.4,169.4,2,104.7,89.5,68.7,81,93.8
+19,59,167.8,2,98.9,84.9,66,81,92
+26,47.6,159.5,2,98.5,80.8,67.5,75.4,85.8
+25,63,167.6,2,102.2,81,65.2,75.9,95.4
+20,55.2,161.2,2,100.2,88.7,64.2,76.8,88.4
+21,45,160,2,85.9,74.5,61,65.3,84.5
+18,54,163.2,2,99.8,81.9,60.2,64.2,91.7
+19,50.2,162.2,2,93.3,75.8,62.6,72.9,87.4
+27,60.2,161.3,2,107.3,88,72.7,76.7,95.9
+26,44.8,149.5,2,90,72.6,58.5,67.2,84.3
+36,58.8,157.5,2,101.5,88,67.5,79.5,96.5
+20,56.4,163.2,2,105.1,86,66.1,73.2,91.8
+28,62,172.7,2,101,85.5,68,86.1,101
+32,49.2,155,2,91.9,80.4,64,85,92.6
+32,67.2,156.5,2,112.1,98.1,90.1,90.1,95.2
+23,53.8,164,2,98.2,82,64.1,74.1,96
+20,54.4,160.9,2,102.5,89,72.4,80.3,89.9
+20,58,162.8,2,98.4,85.8,71,85,92.7
+20,59.8,167,2,96.8,85.9,69.1,77.2,94.1
+23,54.8,160,2,103.9,82.5,66.1,74.9,93.8
+20,43.2,160,2,92.7,74.5,59.5,65.5,78.8
+28,60.5,168.9,2,105,89.4,71.5,80.6,96
+23,46.4,158.2,2,94,80.3,65,73.3,84.9
+19,64.4,156,2,101.5,85.6,71.5,82,97.5
+28,48.8,160,2,92,83,63,72,86
+19,62.2,167.1,2,108.5,88.2,70,81.2,96.8
+29,55.5,158,2,93.8,85.5,70.4,82.4,93.5
+32,57.8,167.6,2,99.8,80.6,64.3,75,93
+20,54.6,156,2,100.3,81,66,73.2,90.2
+28,59.2,162.1,2,101.5,83.6,70.5,78.5,91.9
+36,52.7,173.4,2,94.7,79.4,62,73,88.5
+22,53.2,159.8,2,103.1,82.9,67.6,73.9,90.2
+20,64.5,170.5,2,94.5,83.2,65,80.9,97.6
+22,51.8,159.2,2,97.1,78.1,64,75.9,95
+32,56,157.5,2,98,82.4,70.5,81.6,98
+40,63.6,161.3,2,102.4,90,79.2,95.2,97.4
+40,63.2,162.6,2,109.1,92.4,71.1,91.5,98.2
+42,59.5,160,2,94.7,86.7,74.7,90.8,100
+40,56.8,168.9,2,98.2,84,62.9,76.8,95.5
+44,64.1,165.1,2,101.5,86,70.6,91.9,101.9
+30,50,162.6,2,96.6,84.5,61.6,81,87.6
+28,72.3,165.1,2,106.1,91.2,74.2,98.2,102.6
+37,55,166.4,2,100.1,81.1,65.5,82.3,90.4
+40,55.9,160,2,105.3,87.6,67.7,84.2,92
+45,60.4,152.4,2,99.8,88.2,72.9,97.4,102.2
+35,69.1,170.2,2,103.9,88.2,72.1,96.3,106.7
+41,84.5,162.6,2,111,104.2,93.4,111.1,109.8
+27,55.9,170.2,2,99,84.8,60.7,78,89.1
+20,55.5,158.8,2,102.5,84.3,69.2,85.3,93
+24,69.5,172.7,2,105.6,91,75.5,90.7,98.6
+36,76.4,167.6,2,99.5,90.5,85.6,111.7,112.1
+27,61.4,162.6,2,106.5,89.6,71.6,92.7,95
+32,65.9,167.6,2,104.1,89.3,75.5,98.9,100.2
+64,58.6,156.2,2,99.7,90,73.7,92.7,101.2
+21,66.8,175.2,2,106.6,88.2,67.9,86.9,100.8
+32,56.6,172.1,2,97.2,83.5,71.2,83,96.5
+35,58.6,162.6,2,100.8,91,69.3,85.9,93.2
+41,55.9,160,2,100.7,88.2,75.6,94.7,95.8
+40,59.1,165.1,2,99.1,82.2,63.8,81.8,97.6
+29,81.8,182.9,2,108.9,98.9,83.6,108.6,108.3
+40,70.7,166.4,2,109.8,97.9,84.9,98,102.4
+24,56.8,165.1,2,99.5,81.7,66,85,94.3
+23,60,177.8,2,100.5,86.1,68.3,85.3,96.5
+41,58.2,165.1,2,97.4,87.1,63.8,88.3,94
+44,72.7,175.3,2,105,76.8,73.6,106.3,106.2
+53,54.1,154.9,2,102.9,87.9,76.3,93.8,98.6
+19,49.1,158.8,2,93.9,81.6,58.8,77.4,89.3
+24,75.9,172.7,2,114.2,92.3,78,100.9,106.9
+25,55,168.9,2,95.9,81.3,64.5,80.8,91.9
+20,57.3,161.3,2,98.7,82.2,65.8,80.2,89.1
+34,55,167.6,2,91.2,78.6,62.5,84.5,95.5
+32,65.5,165.1,2,105.1,94.3,77.5,93.9,101.1
+24,65.5,175.3,2,102.3,89.5,70,89.6,98.9
+29,48.6,157.5,2,93.1,81,59.4,73.7,83.3
+31,58.6,163.8,2,101.7,85.4,68.3,84,94
+34,63.6,167.6,2,105,86.2,77.9,96,100.1
+36,55.2,165.1,2,96.4,85.3,68.3,88,93.8
+32,62.7,165.1,2,103.5,86.1,72,91.9,103.9
+39,56.6,168.9,2,99.8,84.5,62.7,78.3,93.5
+37,53.9,162.6,2,87,72.6,58,82.9,90.2
+52,63.2,164.5,2,105.2,90,72.7,97.2,100.2
+24,73.6,176.5,2,102.1,95.8,85.4,105.2,109.5
+33,62,168.9,2,101.3,85.5,67.3,86.9,97.6
+42,63.6,175.3,2,99.6,85.7,70.8,92.1,96.9
+34,53.2,159.4,2,99.4,85.4,67.4,85.9,90.3
+37,53.4,160,2,99.4,79.1,66,85,94.8
+39,55,170.2,2,99,84.4,63.6,84.9,92.7
+41,70.5,162.6,2,108.2,90,71.7,95.8,108.4
+36,54.5,167.6,2,96.4,82.9,73.6,86.9,94.7
+19,54.5,162.6,2,101.4,87.3,66.9,83.3,90.6
+22,55.9,160.7,2,98.2,85.3,65.5,76.7,90.8
+23,59,160,2,100.6,87.3,70.4,91.1,96.7
+36,63.6,157.5,2,108.4,93.2,80.3,98,101.2
+45,54.5,162.6,2,100.8,84.7,65,84.5,94.7
+25,47.3,152.4,2,94.8,78,60.4,79.2,87
+67,67.7,170.2,2,108.2,90.7,75.3,96.3,103.6
+26,80.9,165.1,2,110.7,95,83.4,100.5,107.5
+21,70.5,172.7,2,102.6,88.7,72.2,87.8,96.1
+33,60.9,165.1,2,98.1,86.6,70.1,86.2,97.6
+25,63.6,170.2,2,92,82.5,69.8,86.4,100.2
+24,54.5,170.2,2,98.6,81.4,66.4,78.5,91.6
+21,59.1,170.2,2,96.1,79.9,61.7,79.7,94.7
+35,70.5,161.3,2,107.7,91.1,76.4,98.3,107
+27,52.7,167.6,2,95.4,80.1,63.8,72.5,86.3
+27,62.7,167.6,2,99.3,86.4,70.2,86.7,97.8
+26,86.3,165.1,2,115.2,105.2,88.2,106.5,107.9
+25,66.4,162.6,2,96.7,91.1,75.8,94.4,103.3
+44,67.3,152.4,2,109,96.7,81.5,94.1,94.9
+29,63,168.9,2,95.1,80.5,67.4,77.7,95.1
+26,73.6,170.2,2,108.4,90.4,78.3,95.4,104.9
+23,62.3,175.2,2,98.2,84.1,65.9,83.7,96.3
+32,57.7,175.2,2,99.7,84.2,62.4,81.4,90.4
+32,55.4,160,2,94.4,82.5,65.6,81.8,92.8
+43,104.1,165.1,2,127.1,106.9,96.2,121.1,128.3
+32,55.5,174,2,94.9,79.9,62.5,74,87.6
+41,77.3,170.2,2,98.9,93,80.5,98.8,107.2
+33,80.5,160,2,106.4,96.3,86.1,107.4,112
+28,64.5,167.6,2,102.2,86.8,71.3,85.7,94
+28,72.3,167.6,2,110.3,95.3,79.4,90.9,102.7
+25,61.4,167.6,2,107.3,93,72.3,89,92
+38,58.2,154.9,2,95,86.4,67.4,86.7,98.4
+37,81.8,162.6,2,115.6,109,94.2,110.5,103.5
+25,63.6,175.3,2,99.3,86.2,67,85.3,96.7
+37,53.4,171.4,2,93.1,85.3,69.5,86.2,90.6
+27,54.5,157.5,2,94.9,84.2,66.4,79.3,92
+27,53.6,165.1,2,100,83.7,67.6,84.1,90.4
+20,60,160,2,98.6,86.5,66.6,87.5,96.7
+19,73.6,174,2,107.2,98.2,69.7,86,94.9
+32,61.4,162.6,2,98.3,88,72,86,95.5
+26,55.5,174,2,92.4,80.4,64.5,81.7,88.4
+56,63.6,162.6,2,93,86,72.3,91.7,97.8
+23,60.9,161.3,2,99.5,86.4,69.1,87.8,95.4
+19,60,156.2,2,92.8,87.6,74.7,77,97.7
+31,46.8,149.9,2,95.9,80.9,60.8,77.4,84.6
+34,57.3,169.5,2,96.1,82.1,66.9,82.4,91.6
+34,64.1,160,2,98.5,89.3,68.8,90.8,103.3
+24,63.6,175.3,2,103.8,85.3,63.7,85.3,96.3
+22,67.3,169.5,2,105,89,71.2,86.1,93.5
+34,75.5,160,2,100.2,94.1,79.6,103.5,104.3
+30,68.2,172.7,2,99.1,90.8,77.9,90.6,96.3
+32,61.4,162.6,2,107.6,97,69.6,90.2,98.3
+40,76.8,157.5,2,104,95.4,86,107.1,112.1
+29,71.8,176.5,2,108.4,91.8,69.9,90.4,101
+21,55.5,164.4,2,99.3,87.3,63.5,79.2,89.5
+33,48.6,160.7,2,91.9,78.1,57.9,75.1,86.9
+33,66.4,174,2,107.1,90.9,72.2,89.4,98.6
+38,67.3,163.8,2,100.5,97.1,80.4,100.8,102.2
diff --git a/assets/exercises/PlantGrowth.csv b/assets/exercises/PlantGrowth.csv
new file mode 100644
index 0000000..481fdf6
--- /dev/null
+++ b/assets/exercises/PlantGrowth.csv
@@ -0,0 +1,31 @@
+"weight","group"
+4.17,"ctrl"
+5.58,"ctrl"
+5.18,"ctrl"
+6.11,"ctrl"
+4.50,"ctrl"
+4.61,"ctrl"
+5.17,"ctrl"
+4.53,"ctrl"
+5.33,"ctrl"
+5.14,"ctrl"
+4.81,"trt1"
+4.17,"trt1"
+4.41,"trt1"
+3.59,"trt1"
+5.87,"trt1"
+3.83,"trt1"
+6.03,"trt1"
+4.89,"trt1"
+4.32,"trt1"
+4.69,"trt1"
+6.31,"trt2"
+5.12,"trt2"
+5.54,"trt2"
+5.50,"trt2"
+5.37,"trt2"
+5.29,"trt2"
+4.92,"trt2"
+6.15,"trt2"
+5.80,"trt2"
+5.26,"trt2"
diff --git a/assets/exercises/class.csv b/assets/exercises/class.csv
new file mode 100644
index 0000000..3daa520
--- /dev/null
+++ b/assets/exercises/class.csv
@@ -0,0 +1,20 @@
+Name,Gender,Age,Height,Weight
+JOYCE,F,11,151.3,25.25
+THOMAS,M,11,157.5,42.5
+JAMES,M,12,157.3,41.5
+JANE,F,12,159.8,42.25
+JOHN,M,12,159,49.75
+LOUISE,F,12,156.3,38.5
+ROBERT,M,12,164.8,64
+ALICE,F,13,156.5,42
+BARBARA,F,13,165.3,49
+JEFFREY,M,13,162.5,42
+CAROL,F,14,162.8,51.25
+HENRY,M,14,163.5,51.25
+ALFRED,M,14,169,56.25
+JUDY,F,14,164.3,45
+JANET,F,15,162.5,56.25
+MARY,F,15,166.5,56
+RONALD,M,15,167,66.5
+WILLIAM,M,15,166.5,56
+PHILIP,M,16,172,75
diff --git a/assets/exercises/clindata.csv b/assets/exercises/clindata.csv
new file mode 100644
index 0000000..6a38461
--- /dev/null
+++ b/assets/exercises/clindata.csv
@@ -0,0 +1,21 @@
+"sample","age","size","er","treatment"
+"GSM150950",60,2.3,1,"tamoxifen"
+"GSM150955",79,4,1,"tamoxifen"
+"GSM150974",67,2.3,1,"tamoxifen"
+"GSM150983",61,2.2,1,"tamoxifen"
+"GSM150991",63,2,1,"tamoxifen"
+"GSM65344",66,2.5,1,"tamoxifen"
+"GSM65820",59,0,1,"tamoxifen"
+"GSM65824",43,2,0,"none"
+"GSM65829",45,1,0,"none"
+"GSM65831",NA,3,1,"none"
+"GSM65832",45,2.5,0,"none"
+"GSM65836",47,1,0,"none"
+"GSM65837",64,2.1,1,"none"
+"GSM65839",NA,4.5,0,"none"
+"GSM65840",48,2,1,"none"
+"GSM65841",64,NA,0,"none"
+"GSM65842",47,2.2,0,"none"
+"GSM65843",39,5,0,"none"
+"GSM65845",32,3,0,"none"
+"GSM65846",57,2.5,0,"none"
diff --git a/assets/exercises/coagulation.txt b/assets/exercises/coagulation.txt
new file mode 100644
index 0000000..c8f4553
--- /dev/null
+++ b/assets/exercises/coagulation.txt
@@ -0,0 +1,25 @@
+coag diet
+1 62 A
+2 60 A
+3 63 A
+4 59 A
+5 63 B
+6 67 B
+7 71 B
+8 64 B
+9 65 B
+10 66 B
+11 68 C
+12 66 C
+13 71 C
+14 67 C
+15 68 C
+16 68 C
+17 56 D
+18 62 D
+19 60 D
+20 61 D
+21 63 D
+22 64 D
+23 63 D
+24 59 D
diff --git a/assets/exercises/data.csv b/assets/exercises/data.csv
new file mode 100644
index 0000000..56438a8
--- /dev/null
+++ b/assets/exercises/data.csv
@@ -0,0 +1,101 @@
+data1,data2,data4
+9.8705708306,9.9105593894,8.8783203701
+10.0131579759,10.0090926752,9.0367537442
+9.8337534707,9.8851171558,8.8374113628
+10.2616236837,10.1807921826,9.3128323513
+10.0388319281,10.0268343788,9.0652809363
+9.8364218589,9.8869611163,8.8403762987
+10.0666280326,10.0460425725,9.0961661231
+10.1107887799,10.0765593735,9.1452346151
+10.0821791333,10.0567889904,9.1134454743
+9.9270823281,9.9496110411,8.9411121961
+10.2469267124,10.1706360015,9.296502052
+10.0494517184,10.0341730686,9.0770809425
+9.8714884238,9.9111934821,8.8793399387
+9.5910198185,9.7173787227,8.5677018356
+10.1788362693,10.1235828462,9.22084447
+9.9729256,9.9812905323,8.9920501979
+9.9779847855,9.984786627,8.9976716291
+10.1469613543,10.1015560351,9.1854271795
+10.1253795905,10.0866421935,9.1614469557
+10.0853684727,10.0589929485,9.1169892566
+10.1425858902,10.0985324185,9.1805654542
+10.1185001642,10.0818882412,9.1538029937
+9.9939588347,9.9958253189,9.0154209326
+9.6306838957,9.7447881491,8.6117739262
+10.0899314934,10.062146174,9.1220593824
+9.9709551182,9.9799288524,8.9898607292
+9.9534125308,9.9678062394,8.9703685702
+9.721963808,9.8078661332,8.7131981076
+9.8966741314,9.9285977896,8.9073246257
+10.0543973719,10.0375907084,9.0825762246
+10.2199789285,10.1520140304,9.2665594628
+9.9627425575,9.9742536522,8.9807354768
+10.0490694855,10.0339089308,9.0766562307
+9.971364118,9.9802114872,8.9903151827
+9.7384549078,8.6029476687,8.7315219235
+9.9077902814,8.7199650249,8.919676154
+9.9114345495,8.7224833565,8.9237254229
+9.970394579,8.7632270394,8.9892378953
+10.1744525842,8.9042390901,9.21597361
+10.1151628718,8.8632675833,9.1500948158
+9.9518762787,8.7504301707,8.9686615888
+9.9362396739,8.7396246661,8.9512872311
+10.1035086727,8.8552140767,9.1371454432
+10.0788141012,8.8381491633,9.1097064739
+9.8596049262,8.6866670627,8.8661357847
+9.8563065483,8.6843877548,8.8624708461
+10.0450054207,8.8147860448,9.0721405116
+10.1161058012,8.8639191844,9.1511425364
+9.9610601456,8.7567765814,8.9788660923
+10.1359203629,8.8776118203,9.1731591625
+10.0509060462,8.8188636075,11.034429946
+9.8731102351,8.6959997585,10.8368750387
+10.04087577,8.8119322949,11.0232849687
+9.7820525577,8.6330753474,10.7356977899
+10.2330644212,8.9447421584,11.2368322448
+10.3294094222,9.0113203166,11.3438844168
+9.9161989373,8.7257757345,10.8847523454
+9.7970538256,8.6434418094,10.7523662034
+10.0811121946,8.8397372356,11.0679930137
+9.957063187,8.7540145269,10.930157988
+10.4035489912,9.0625536542,11.4262633862
+9.9739277454,8.7656685954,10.9488967662
+10.1022371568,8.8543354095,11.09146567
+9.9857632,8.7738473567,10.962047538
+9.8500091674,8.6800360186,10.8112066652
+10.0140642594,8.793404494,10.9934937972
+9.6631393629,8.5509016859,10.6035693386
+10.2387903089,11.3813278874,11.2431944713
+10.0078089613,11.2217107557,10.9865433251
+10.3632410785,11.4673282294,11.3814759083
+8.3044059958,11.2609072421,11.0495680334
+8.0957510409,11.1167185198,10.8177244933
+8.3282058343,11.27735386,11.0760128347
+8.056297649,11.0894546851,10.7738865021
+8.0000553898,11.0505890876,10.7113938358
+8.2720085728,11.2385193576,11.0135701668
+8.142685551,11.1491520992,10.8698750065
+8.2209049755,11.2032047761,10.9567872405
+8.2337954151,11.2121125734,10.9711102417
+8.1169474202,11.1313660456,10.8412765034
+8.1206176684,11.1339023304,10.8453546396
+8.1969173067,11.1866283602,10.9301337347
+8.4280683458,11.3463627554,11.1869734308
+7.9525437627,11.0177566978,10.6586020685
+8.325252317,11.2753128642,11.0727310822
+11.7995619211,11.2435675657,11.0216872678
+11.9280772848,11.3323767009,11.164485012
+11.6874183814,11.1660720002,10.8970808079
+11.8060864262,11.2480762535,11.0289368648
+11.787971226,11.2355579427,11.0088084565
+11.6454682699,11.1370828349,10.8504686277
+11.9535582432,11.3499850383,11.1927977622
+11.9452037809,11.3442117785,11.183514838
+11.8642048141,11.2882383292,11.0935141609
+12.0202608985,11.396079178,11.2669133266
+11.8392590645,11.2709998421,11.0657960993
+11.5162624603,11.0477965746,10.7069037058
+11.640056701,11.1333432294,10.8444556515
+11.5254115135,11.0541189277,10.7170695267
+11.6576341407,11.1454899268,10.8639865361
diff --git a/assets/exercises/data.xls b/assets/exercises/data.xls
new file mode 100644
index 0000000..4473cc4
Binary files /dev/null and b/assets/exercises/data.xls differ
diff --git a/assets/exercises/dataClustering.csv b/assets/exercises/dataClustering.csv
new file mode 100644
index 0000000..87b4272
--- /dev/null
+++ b/assets/exercises/dataClustering.csv
@@ -0,0 +1 @@
+Exp_Part,Genotype,Sex,Coord_X,Coord_Y
1,White,Male,1237.99,1525.897
1,White,Male,1215.481,1529.138
1,White,Male,1189.926,1526.479
1,White,Male,1263.882,1529
1,White,Male,1169.444,1531.463
1,White,Male,1286.599,1538.756
1,White,Male,1185.338,1540.752
1,White,Male,1306.546,1540.649
1,White,Male,1321.833,1547.652
1,White,Male,1334.688,1558.109
1,White,Male,1185.5,1559
1,White,Male,1204.025,1566.487
1,White,Male,1339.3,1569.338
1,White,Male,1306.115,1572.1
1,White,Male,1208.722,1581.743
1,White,Male,1376.133,1577.617
1,White,Male,1299.846,1583.241
1,White,Male,1316.118,1580.711
1,White,Male,1338.667,1589.917
1,White,Male,1184,1591.5
1,White,Male,1229.797,1590.297
1,White,Male,1328.551,1597.513
1,White,Male,1314.934,1603.234
1,White,Male,1387.628,1601.145
1,White,Male,1204.315,1599.115
1,White,Male,1241.333,1609.738
1,White,Male,1281.698,1606.315
1,White,Male,1208.176,1611.635
1,White,Male,1298.058,1616.318
1,White,Male,1274.795,1617
1,White,Male,1316.597,1617.361
1,White,Male,1253.543,1619.196
1,White,Male,1337,1626.5
1,White,Male,1311.007,1626.692
1,White,Male,1362.632,1635.882
1,White,Male,1272.827,1642.445
1,White,Male,1025.42,1667.06
1,White,Male,1144.917,1712.317
1,White,Male,1271.163,1716.343
1,White,Male,1110.197,1733.526
1,White,Male,1188.555,1774.427
1,White,Male,1125.736,1783.556
1,White,Male,1024.267,1798.938
1,White,Male,1084.658,1814.816
1,White,Male,1090.214,1867.857
1,White,Male,1311.955,1926.136
\ No newline at end of file
diff --git a/assets/exercises/easy_R_script.R b/assets/exercises/easy_R_script.R
new file mode 100644
index 0000000..97c533e
--- /dev/null
+++ b/assets/exercises/easy_R_script.R
@@ -0,0 +1,98 @@
+## Starting point in R
+
+## R is a calculator
+
+2*3
+log(4)
+exp(3)
+pi - 3
+
+## R can store variables
+
+x <- 2
+
+# equivalent to
+
+x = 2
+
+# then we can calculate
+1/x
+# and store it as a variable
+y <- 1/x
+
+# a vector is stored with the command c() separated by commas
+
+x <- c(1,10,3,0.4)
+
+# a vector with NA values
+
+x2 <- c(NA,10,NA,0.4)
+
+# one can use a vector variable to create a new one
+
+y <- c(x,x,1,3)
+
+# or do operation with variables
+y <- 2*x
+
+# generating number
+z <- 1:10
+z <- c(1,2,3,4,5,6,7,8,9,10)
+
+## lets see our first functions in R
+
+# To access the help of a function use help() or ?
+
+?mean
+mean(z)
+mean(x2) ## will show NA as there are NA values
+mean(x2,na.rm=T) ## na.rm is an argument that is boolean, i.e. either T or F
+ ## explaning what to do with the NAs in the data
+
+
+?seq
+x <- seq(from=1,to=5,length=17)
+
+#if we want to know which values of x are smaller than 4 we can use "<" which
+#is the boolean operator
+
+x < 4
+sum(x<4)
+
+# subselecting some vector entries
+
+x[1]
+x[2:5]
+x[c(2,5,8)]
+
+## working directory
+getwd()
+
+## always set your right environment
+setwd()
+
+## open files
+
+read.delim()
+read.csv()
+read.table()
+
+#if you have a matrix
+data <- matrix(c(1,2,3,5,6,7),nrow=2)
+
+# you can access the row 2 and the column 3
+data[2,3]
+
+# you can also have dataframes (mix of matrix with different types for the columns)
+
+x <- 1:10
+y <- seq(from=5,to=10,length=10)
+z <- c("A","B","B","A","A","A","B","A","B","B")
+df <- data.frame(d1=x, d2=y, fact=z)
+
+summary(df)
+df$fact
+df$fact == "B"
+!(df$fact == "B") ## changed all TRUE to FALSE
+df[ df$fact == "B", "d2" ]
+
diff --git a/assets/exercises/energy.txt b/assets/exercises/energy.txt
new file mode 100644
index 0000000..11c1452
--- /dev/null
+++ b/assets/exercises/energy.txt
@@ -0,0 +1,23 @@
+expend stature
+1 9.21 obese
+2 7.53 lean
+3 7.48 lean
+4 8.08 lean
+5 8.09 lean
+6 10.15 lean
+7 8.4 lean
+8 10.88 lean
+9 6.13 lean
+10 7.9 lean
+11 11.51 obese
+12 12.79 obese
+13 7.05 lean
+14 11.85 obese
+15 9.97 obese
+16 7.48 lean
+17 8.79 obese
+18 9.69 obese
+19 9.68 obese
+20 7.58 lean
+21 9.19 obese
+22 8.11 lean
diff --git a/assets/exercises/expression-esr1.csv b/assets/exercises/expression-esr1.csv
new file mode 100644
index 0000000..96667a1
--- /dev/null
+++ b/assets/exercises/expression-esr1.csv
@@ -0,0 +1,21 @@
+"205225_at","211233_x_at","211234_x_at","211235_s_at","211627_x_at","215551_at","215552_s_at","217163_at","217190_x_at"
+"GSM150950",12.3571742498790,8.46996071269517,8.02462836581408,7.577064748886,4.14714200650146,5.03939747937069,7.26807244334639,4.64531958997882,7.13791135724179
+"GSM150955",13.164704260469,8.38778949219765,8.35841461473612,7.75575827246701,4.10699515345128,5.47448562364915,7.02325064351626,4.46536967132533,6.9873798785624
+"GSM150974",12.3895913394781,8.15285259634139,8.02199371808726,7.56842989705325,3.88308811362737,4.9054207312716,6.89439580244258,4.67324880407382,6.56691274782556
+"GSM150983",12.5965679338727,8.74851460977183,8.65648698119176,8.0692229833615,3.83424494168996,4.97474838838328,7.40740092703157,4.73313056700564,7.5863367499701
+"GSM150991",11.7926218170375,8.13075259008447,7.87016292695444,6.95661129475535,3.75533183060809,5.14212004559955,6.70470692414931,5.10536387978774,6.5560694774261
+"GSM65344",12.4640524315812,8.4582235351869,8.74967195285669,8.24294172613875,3.92694304231933,5.30716139582474,7.27633143492929,4.8611496841756,7.12401853999784
+"GSM65820",11.6070756763825,8.10666369959694,7.79141674747542,7.32804527538038,3.85892533276077,5.61097822313998,6.64453708758291,5.12296380666294,6.50581022213556
+"GSM65824",10.1488889893484,7.41872046067941,7.64457327697709,6.65078648284138,3.82291470442349,5.23230458004506,6.32717444832673,5.01556177952366,6.0961325533743
+"GSM65829",10.9861680178309,7.68369457824608,7.56996242248564,6.8481052349678,3.72940290082538,5.43321853785388,6.45015435598432,4.91909428163075,6.25176692763167
+"GSM65831",12.6282795414062,8.25953194794953,7.89543486390348,7.27167190192228,3.99919317587807,6.04473434690383,7.06299141319,5.22027479785511,6.47379035843392
+"GSM65832",11.6510710041608,8.19044432478765,8.04064581110711,7.32830672313795,3.91811188345407,5.2680864562707,6.51939182645939,4.81143778694851,6.33997091478882
+"GSM65836",10.3036474093756,7.48622200659745,7.68914161808582,7.02361130582653,4.0603403712288,5.45789149756730,6.407821230848,5.13390762770396,6.26165335260773
+"GSM65837",12.7876836350697,7.78215516348191,7.67152887523163,7.10352668479596,3.83454291583119,5.42974930037508,6.59846868726013,4.85814484002441,6.36510967223587
+"GSM65839",6.20950513351441,7.11957834359541,7.20689519359714,6.7965497284016,4.0536887923026,5.32980590753623,6.0672715944634,5.06310472498755,5.99775034582861
+"GSM65840",11.0998916995623,7.9080426427301,7.69620931505016,7.32684516925234,3.9164625663726,5.26899121989562,6.48465673274091,4.97145354163137,6.14095263981722
+"GSM65841",6.85598539566562,7.48031077136202,7.4628842859321,6.3426979483585,3.85923667471031,5.63483704743563,6.28117265500013,5.1714950780374,6.15291823112941
+"GSM65842",6.95296839656613,7.76661729180591,7.59633506153331,6.82546220356722,4.04855622717427,5.53812463200046,6.2001498424244,5.05635554905139,6.36765666809165
+"GSM65843",6.80499268792559,7.28369097746461,7.56985683276939,6.42481989515769,3.87206872585923,5.19730892646577,6.14375543522062,5.00579612249063,6.15123750815564
+"GSM65845",6.51966627509893,7.50816151704136,7.48261537860856,6.41414451169152,3.92458500258908,5.4697124130758,6.33160723803717,5.10620953187439,6.06943687206858
+"GSM65846",8.55597036315534,7.69793134144074,7.55413442897403,6.46734190642474,3.85859647780291,5.62634123291366,6.36045144345213,5.04543345637295,6.26594418829111
diff --git a/assets/exercises/golub.sample.annot.csv b/assets/exercises/golub.sample.annot.csv
new file mode 100644
index 0000000..2fbeb2e
--- /dev/null
+++ b/assets/exercises/golub.sample.annot.csv
@@ -0,0 +1,39 @@
+"","x"
+"1","ALL"
+"2","ALL"
+"3","ALL"
+"4","ALL"
+"5","ALL"
+"6","ALL"
+"7","ALL"
+"8","ALL"
+"9","ALL"
+"10","ALL"
+"11","ALL"
+"12","ALL"
+"13","ALL"
+"14","ALL"
+"15","ALL"
+"16","ALL"
+"17","ALL"
+"18","ALL"
+"19","ALL"
+"20","ALL"
+"21","ALL"
+"22","ALL"
+"23","ALL"
+"24","ALL"
+"25","ALL"
+"26","ALL"
+"27","ALL"
+"28","AML"
+"29","AML"
+"30","AML"
+"31","AML"
+"32","AML"
+"33","AML"
+"34","AML"
+"35","AML"
+"36","AML"
+"37","AML"
+"38","AML"
diff --git a/assets/exercises/golub_expr.csv b/assets/exercises/golub_expr.csv
new file mode 100644
index 0000000..b1a1294
--- /dev/null
+++ b/assets/exercises/golub_expr.csv
@@ -0,0 +1,7130 @@
+,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,34,35,36,37,38,28,29,30,31,32,33
+AFFX-BioB-5_at,-214,-139,-76,-135,-106,-138,-72,-413,5,-88,-165,-67,-92,-113,-107,-117,-476,-81,-44,17,-144,-247,-74,-120,-81,-112,-273,-20,7,-213,-25,-72,-4,15,-318,-32,-124,-135
+AFFX-BioB-M_at,-153,-73,-49,-114,-125,-85,-144,-260,-127,-105,-155,-93,-119,-147,-72,-219,-213,-150,-51,-229,-199,-90,-321,-263,-150,-233,-327,-207,-100,-252,-20,-139,-116,-114,-192,-49,-79,-186
+AFFX-BioB-3_at,-58,-1,-307,265,-76,215,238,7,106,42,-71,84,-31,-118,-126,-50,-18,-119,100,79,-157,-168,-11,-114,-85,-78,-76,-50,-57,136,124,-1,-125,2,-95,49,-37,-70
+AFFX-BioC-5_at,88,283,309,12,168,71,55,-2,268,219,82,25,173,243,149,257,301,78,207,218,132,-24,-36,255,316,54,81,101,132,318,325,392,241,193,312,230,330,337
+AFFX-BioC-3_at,-295,-264,-376,-419,-230,-272,-399,-541,-210,-178,-163,-179,-233,-127,-205,-218,-403,-152,-146,-262,-151,-308,-317,-342,-418,-244,-439,-369,-377,-209,-396,-324,-191,-51,-139,-367,-188,-407
+AFFX-BioDn-5_at,-558,-400,-650,-585,-284,-558,-551,-790,-535,-246,-430,-323,-227,-398,-284,-402,-394,-340,-221,-404,-347,-571,-499,-396,-461,-275,-616,-529,-478,-557,-464,-510,-411,-155,-344,-508,-423,-566
+AFFX-BioDn-3_at,199,-330,33,158,4,67,131,-275,0,328,100,-135,-49,-249,-166,228,-42,-36,83,326,-118,-170,-138,-412,-66,-479,419,14,-351,40,-221,-350,-31,29,324,-349,-31,-141
+AFFX-CreX-5_at,-176,-168,-367,-253,-122,-186,-179,-463,-174,-148,-109,-127,-62,-228,-185,-147,-144,-141,-198,-201,-24,-224,-119,-153,-184,-108,-251,-365,-290,-243,-390,-202,-240,-105,-237,-194,-223,-315
+AFFX-CreX-3_at,252,101,206,49,70,87,126,70,24,177,56,-2,13,-37,1,65,98,96,34,6,126,124,115,184,164,136,165,153,283,119,-1,249,150,42,105,34,-82,206
+AFFX-BioB-5_st,206,74,-215,31,252,193,-20,-169,506,183,350,-66,230,113,-23,67,173,-55,-20,469,-201,-117,-17,-162,-5,-86,350,29,247,-131,358,561,24,524,167,-56,176,321
+AFFX-BioB-M_st,-41,19,19,363,155,325,-115,361,284,-143,204,208,2,188,205,-101,-133,-209,11,-127,-89,-14,265,100,46,-190,-40,255,146,45,-197,275,19,-70,-50,147,226,233
+AFFX-BioB-3_st,-831,-743,-1135,-934,-471,-631,-1003,-1001,-829,-684,-524,-472,-425,-625,-437,-547,-959,-362,-535,-539,-429,-731,-600,-477,-470,-308,-1250,-769,-752,-902,-852,-785,-669,-344,-820,-841,-1010,-946
+AFFX-BioC-5_st,-653,-239,-962,-577,-490,-625,-761,-520,-844,-468,-599,-163,-381,-413,-351,-277,-271,-427,-386,-95,-74,-546,-469,-498,-383,-497,-863,-615,-702,-306,-689,-326,-664,-285,-231,-657,-513,-909
+AFFX-BioC-3_st,-462,-83,-232,-214,-184,-177,-541,-163,-230,-51,-188,-192,-2,-229,-210,-22,-228,-4,-64,-114,-63,-209,-235,-210,-225,-106,-125,-199,-228,-258,-175,-47,-311,-53,-273,-240,-333,-507
+AFFX-BioDn-5_st,75,182,208,142,32,-94,109,-38,292,233,34,-80,62,0,39,196,-42,199,49,171,327,115,58,-71,85,80,270,232,48,465,-7,-96,297,38,208,-15,30,357
+AFFX-BioDn-3_st,381,164,432,271,213,222,435,281,172,310,221,89,243,175,67,306,232,290,13,99,96,111,81,217,83,246,312,222,180,298,-156,16,353,-142,99,227,177,180
+AFFX-CreX-5_st,-118,-141,84,-107,1,-1,-129,-137,-59,-79,-41,-106,-41,-99,-122,-68,100,1,-46,-102,61,-2,-64,52,-77,-7,-179,-172,-141,-93,-47,-140,-96,-125,-126,-166,-69,-92
+AFFX-CreX-3_st,-565,-423,-501,-101,-260,-140,-399,-247,-323,-443,-204,-251,-424,-142,-110,-362,-599,-350,-334,-541,-79,-264,-131,-145,-120,-194,-874,-287,-233,-516,-397,-367,-291,-118,-534,-453,-411,-867
+hum_alu_at,15091,11038,16692,15763,18128,34207,30801,25147,15272,21801,18167,27087,19324,14760,11631,16738,14030,23505,20225,6479,22143,24327,36417,14989,18343,12801,25673,16716,45492,23865,17359,19406,17878,26052,11983,23508,17996,19679
+AFFX-DapX-5_at,7,37,183,45,-28,65,43,338,29,-36,-8,-5,21,35,50,-22,95,41,-42,22,2,48,60,92,71,-17,172,-66,-26,-38,44,113,21,-67,-81,-126,20,18
+AFFX-DapX-M_at,311,134,378,268,118,154,80,269,188,-39,115,186,38,134,173,232,98,93,191,171,211,253,229,67,32,161,366,172,67,-14,286,227,218,121,114,61,371,238
+AFFX-DapX-3_at,-231,-161,-221,-27,-153,-49,-87,-116,-69,-142,-95,-18,-37,-33,-24,-156,-208,-147,-55,-129,-47,-73,-64,-52,-59,-76,-186,-80,-72,-191,-73,-9,-103,-69,-67,-35,-68,-144
+AFFX-LysX-5_at,21,-21,67,43,-8,-24,-8,46,74,10,14,-2,26,68,-10,-38,107,4,-29,-30,101,23,98,-32,23,4,67,18,7,7,-11,-13,52,6,32,45,6,-16
+AFFX-LysX-M_at,-107,-180,-203,-52,-111,-72,-250,-317,-217,-130,-54,-150,-118,-95,-71,-134,-237,-81,-174,-205,11,-181,-93,208,-268,-27,-97,-182,-86,-283,-272,-289,-242,-198,-162,-94,-134,-420
+AFFX-LysX-3_at,165,18,238,247,44,39,100,265,106,-1,91,79,153,71,37,139,84,76,-3,36,68,36,13,92,-113,100,6,169,76,27,118,-25,134,61,175,125,111,249
+AFFX-PheX-5_at,-78,-120,-124,-116,-88,-104,-73,-130,-159,-18,-81,-57,-86,-41,-80,-119,-241,-67,-123,-109,-79,20,-112,-82,-55,-50,-93,-66,-55,-131,-88,-141,-105,-93,-20,-125,-44,-149
+AFFX-PheX-M_at,-204,-65,-161,-208,-102,-40,-132,-212,-155,-70,-134,-116,-76,-77,-46,-114,-144,-46,-99,-101,-79,-75,-56,-152,-106,-140,-215,-243,-177,-190,-206,-114,-207,-190,-109,-171,-232,-134
+AFFX-PheX-3_at,29,97,36,22,32,40,-57,-233,-101,-2,22,-45,22,-93,43,13,-29,-55,-18,61,8,149,-93,-59,63,-7,7,-102,0,-32,-5,-16,-42,-18,31,66,-7,-7
+AFFX-ThrX-5_at,-61,15,-23,-10,5,46,-52,29,143,2,5,38,38,-13,-102,-63,22,1,-57,-5,31,-26,-49,-45,-10,-42,-37,-45,-79,9,-68,26,-59,-49,-23,-56,-144,-97
+AFFX-ThrX-M_at,-105,-49,-80,-74,-18,-78,-73,-28,-4,-9,-14,-79,-83,-31,10,-26,-91,19,-76,62,-24,-17,-75,-50,-83,-28,-61,-29,-125,-35,-60,-59,-39,-66,-21,-68,-56,-118
+AFFX-ThrX-3_at,-366,-330,-481,-240,-228,-273,-327,-599,-283,-264,-269,-165,-170,-237,-187,-339,-574,-267,-154,-192,-154,-145,-176,-146,-255,-247,-458,-419,-281,-370,-278,-383,-183,-117,-246,-217,-217,-340
+AFFX-TrpnX-5_at,-41,-41,-65,-33,53,-7,-28,73,47,71,42,15,17,53,2,39,76,-10,20,8,-36,-28,-26,32,-6,-123,-93,-12,122,-11,38,141,77,-38,-31,-48,17,7
+AFFX-TrpnX-M_at,-346,-772,-620,-560,-348,-618,-613,-604,-383,-500,-509,-432,-505,-383,-395,-645,-732,-414,-736,-992,-328,-461,-341,-457,-607,-586,-580,-686,-622,-517,-463,-588,-495,-262,-589,-775,-657,-806
+AFFX-TrpnX-3_at,-297,-259,-269,-261,-169,-355,-317,-226,-196,-283,-233,-231,-251,-163,-192,-356,-283,-133,-391,-296,-158,-173,-212,-272,-220,-278,-215,-310,-307,-194,-228,-188,-124,-106,-353,-235,-332,-261
+AFFX-HUMISGF3A/M97935_5_at,-109,-192,-136,-366,-156,-344,-220,-229,-106,-230,-275,-321,-306,-317,-43,-304,-283,-130,-423,-273,-222,-227,-153,-199,-300,-280,-253,-293,-221,-161,10,-74,-111,-133,-314,-266,-277,374
+AFFX-HUMISGF3A/M97935_MA_at,-13,-219,104,-148,-55,-327,-179,-163,-100,-109,-276,-224,-250,91,594,-221,-226,-23,-344,-97,-92,-95,-60,-168,-113,-113,-179,-66,-79,216,1287,207,51,-95,-435,-125,-36,2003
+AFFX-HUMISGF3A/M97935_MB_at,215,116,476,155,122,176,58,257,166,155,46,-17,202,185,776,114,265,78,126,448,73,-104,30,147,191,35,-62,182,45,227,810,260,132,-22,135,85,123,1735
+AFFX-HUMISGF3A/M97935_3_at,797,433,1474,415,483,412,383,580,752,606,266,152,778,1490,1680,629,809,524,370,2822,404,153,594,659,753,495,503,378,372,722,1378,720,647,202,423,295,532,3995
+AFFX-HUMRGE/M10098_5_at,14538,615,5669,4850,1284,4148,21573,3934,13005,-163,791,8299,-71,912,6800,-8,-96,832,-56,70,-103,16487,17655,-142,4958,29,7953,504,2171,580,2183,819,1065,442,45,9042,5199,1255
+AFFX-HUMRGE/M10098_M_at,9738,115,3272,2293,2731,2743,11031,1548,7272,-213,122,4204,-209,583,6946,-251,-397,933,-284,-233,-282,13380,17011,-346,2666,-148,4004,92,1752,130,1563,513,498,-54,-450,3852,1869,-94
+AFFX-HUMRGE/M10098_3_at,8529,1518,3668,2569,316,2404,26002,1299,13939,-241,1553,5351,-316,1916,2740,-186,-382,273,-414,-364,-259,10071,5885,-386,4297,-337,2584,114,904,-38,870,1938,2039,-14,-186,2857,1365,300
+AFFX-HUMGAPDH/M33197_5_at,15076,19448,27410,14920,14653,25771,11605,8184,19932,27919,25452,19281,11065,16323,17426,10815,16575,19482,12502,12701,188,13831,16743,11329,19430,6480,9805,17664,10695,26516,25634,21592,19351,14706,24678,20574,15496,23659
+AFFX-HUMGAPDH/M33197_M_at,11126,13568,16756,11439,15030,24420,12125,4175,15546,18782,17041,20863,10630,11676,14110,13017,13007,16429,14131,10592,-74,11270,19434,10299,15970,8380,7327,13861,7103,17621,15041,15033,12453,17479,14230,15646,12086,13617
+AFFX-HUMGAPDH/M33197_3_at,17782,18112,23006,17633,17384,30481,20356,10642,18316,23485,21746,25785,11898,18540,16658,17585,15992,20255,18930,15580,5325,17807,25224,16402,20346,16130,15100,19462,16358,23892,20251,21518,17844,19262,18329,20905,15191,19115
+AFFX-HSAC07/X00351_5_at,16287,17926,22626,15770,16386,32046,13576,16303,18288,20332,16870,11664,14587,17503,16292,14149,14998,18221,9670,10471,570,8588,17779,11295,8496,7579,12077,12695,9628,21865,16711,14663,15706,8446,16788,23829,19338,18075
+AFFX-HSAC07/X00351_M_at,18727,20668,24672,18773,19091,38467,14956,18006,18507,25078,20196,17705,18957,20079,20258,19710,19137,23994,13457,16259,-173,11071,22878,19613,12980,14928,19471,15550,13001,25106,18866,15226,18644,12482,20311,27914,23054,19527
+AFFX-HSAC07/X00351_3_at,15774,16959,18285,14245,18323,25364,18106,16885,15693,19625,16241,17558,17520,15493,15027,17843,16608,21275,13835,15428,17866,10551,17883,17002,15190,19025,20134,15535,18960,18111,14434,14254,14595,9529,16207,19257,16767,14859
+AFFX-HUMTFRR/M11507_5_at,264,513,609,183,291,245,171,487,371,43,264,237,184,159,173,134,490,304,163,294,71,285,340,249,326,172,151,342,432,269,807,1607,701,559,409,340,398,751
+AFFX-HUMTFRR/M11507_M_at,70,153,66,-54,78,-40,-25,-19,-41,-14,-4,14,-52,7,21,-58,166,78,20,147,52,-2,45,-21,220,-8,-161,6,257,86,723,1127,427,375,76,47,22,494
+AFFX-HUMTFRR/M11507_3_at,298,285,187,260,287,222,141,115,323,320,209,195,165,416,283,153,285,476,154,264,184,164,203,-78,610,158,201,367,331,292,1712,3031,723,812,435,341,322,1474
+AFFX-M27830_5_at,6750,2215,3325,3058,1130,3906,7761,4277,6114,-9,1531,4239,55,628,2773,124,12,2682,145,318,19,7518,7453,245,9085,322,4681,561,1733,718,1635,3946,1710,269,209,3879,2113,870
+AFFX-M27830_M_at,6559,3824,3349,2442,1056,4530,2532,4542,3916,532,3538,6599,892,1774,3588,1106,902,6134,986,912,1263,8237,10411,1070,9692,2367,3692,2244,3481,2371,4269,6727,2644,975,1969,5114,3076,1616
+AFFX-M27830_3_at,1164,655,927,527,448,277,735,1067,738,774,773,360,358,872,363,978,1380,735,808,832,740,632,370,871,1192,800,522,1127,1046,1007,1003,475,1174,277,405,429,941,1716
+AFFX-HSAC07/X00351_3_st,2982,3187,3097,1731,728,1644,4024,1077,7941,686,1651,1543,910,3948,2029,1558,2745,3497,1222,1865,607,1171,1812,155,1573,794,4329,1521,1637,1528,1282,1018,1138,310,1474,1633,1566,1693
+AFFX-HUMGAPDH/M33197_5_st,240,86,252,-171,28,71,-132,-134,235,-41,204,149,-184,67,97,28,-327,167,90,-120,-69,142,108,75,275,-55,-197,209,-55,160,385,469,319,-54,273,154,48,510
+AFFX-HUMGAPDH/M33197_M_st,132,301,524,-76,89,302,171,92,655,96,426,179,57,382,170,237,71,385,-23,247,152,385,203,104,412,25,-162,271,343,479,555,477,389,-31,394,153,224,907
+AFFX-HUMGAPDH/M33197_3_st,546,530,911,327,120,572,465,310,741,200,446,671,136,393,437,204,195,422,241,327,104,430,286,-3,879,194,303,596,351,487,417,735,461,38,268,307,307,437
+AFFX-HSAC07/X00351_5_st,-1,185,140,-91,-220,382,-196,-106,131,-173,-115,117,-179,17,-2,-216,-608,-133,-114,-437,-204,-88,41,-149,-9,-146,-3,-141,69,253,-2,-104,35,-266,181,244,96,27
+AFFX-HSAC07/X00351_M_st,336,418,761,511,65,705,448,1073,584,184,249,291,162,586,237,163,407,437,155,57,37,453,364,514,251,244,646,332,639,684,614,827,389,157,511,591,441,1013
+A28102_at,151,263,88,484,118,270,458,872,62,194,143,359,66,216,20,250,107,85,412,639,46,126,305,217,420,125,485,324,473,50,249,357,190,318,382,486,388,260
+AB000114_at,72,21,-27,61,16,85,-10,25,-38,65,-111,12,39,68,42,18,97,49,41,83,28,26,174,-34,154,45,87,36,0,-35,36,-17,39,1,1,-23,56,-27
+AB000115_at,281,250,358,118,197,71,168,296,198,113,164,185,111,165,174,148,183,197,225,2194,191,99,197,290,1559,110,178,205,341,74,328,74,214,103,239,221,405,1306
+AB000220_at,36,43,42,39,39,32,10,59,27,39,19,35,41,51,-24,50,13,13,59,40,-2,24,3,41,32,21,162,11,-7,39,12,51,71,-61,72,39,192,32
+AB000409_at,-299,-103,142,-11,237,-112,87,-520,148,-25,-125,130,-16,-48,146,46,125,30,73,11,79,-190,-113,343,70,76,-57,180,-163,436,-143,88,-52,39,377,-14,-31,-349
+AB000449_at,57,169,359,274,311,232,131,70,313,204,307,158,971,315,498,125,366,165,285,813,534,28,134,380,208,285,197,79,110,86,133,111,178,181,96,120,36,255
+AB000450_at,186,219,237,245,186,30,199,556,259,54,87,54,220,110,207,177,488,166,99,199,173,19,104,203,80,23,115,320,259,107,131,96,48,47,173,285,113,115
+AB000460_at,1647,2043,1997,2128,1608,1354,1784,2911,2117,1408,2117,1438,2256,1772,1770,1732,3172,1288,1514,2702,1405,1840,1424,2270,1404,1479,2325,2412,1632,1968,2044,1825,2175,976,1767,1939,1462,2818
+AB000462_at,137,188,91,-82,204,-112,52,-44,-2,49,29,306,377,130,209,47,-95,136,4,237,203,553,-37,448,134,85,161,131,33,244,162,73,340,62,367,34,72,232
+AB000464_at,803,756,2514,1489,322,750,409,1074,1495,246,706,629,964,666,548,668,1128,839,807,1258,209,748,902,1207,481,799,1125,813,654,584,867,280,799,379,843,1000,1320,1167
+AB000466_at,-894,-812,-1715,-969,-444,-1338,-1512,-1799,-823,-503,-570,-635,-528,-979,-721,-723,-1081,-397,-836,-851,-473,-627,-564,-502,-418,-403,-1693,-1157,-1106,-973,-1912,-1610,-807,-995,-1054,-1266,-732,-1168
+AB000467_at,-632,-700,-603,-909,-254,-640,-823,-913,-686,-618,-478,-423,-645,-451,-331,-566,-787,-619,-482,-580,-287,-438,-834,-366,-351,-450,-1871,-753,-716,-668,-946,-406,-1021,-321,-859,-1024,-951,-1461
+AB000468_at,378,249,362,266,554,110,312,238,896,229,2433,38,937,719,1289,357,491,712,553,857,863,1166,250,579,-112,278,-345,88,-199,572,270,542,436,518,-107,111,122,376
+AB000584_at,-26,-242,-31,-181,16,-208,134,13,-11,-422,-98,-58,-863,12,-85,-237,-392,-288,-318,-645,-207,134,36,2,106,-524,-190,-279,115,-56,1010,1885,-128,13,-188,-274,-174,74
+AB000895_at,-691,-369,-1385,-900,-58,-1077,-831,-554,-297,-359,-148,-737,-582,-363,-547,-352,10,172,-438,393,-292,3,-302,-236,-144,-13,-1157,-482,-601,-506,-292,-759,-758,-97,-570,-776,-301,-305
+AB000896_at,2,-14,-374,-237,-78,-190,-228,-331,-57,-99,-106,-99,35,-163,-136,-169,-106,55,-165,-224,-37,-197,-184,-258,-83,-175,-104,-202,-137,-74,-234,111,-57,-59,-185,-265,-152,-38
+AB000897_at,-156,-98,-213,-156,-95,-81,-55,-85,-41,-68,-62,-28,-50,-185,-65,-81,-73,-86,-48,-109,-196,-107,-39,-123,-92,-133,-181,-87,-139,-202,-141,-50,-146,-43,-159,-103,-148,-164
+AB000905_at,155,131,270,115,45,78,173,121,90,95,128,50,113,52,59,75,18,118,155,163,139,139,117,228,138,94,262,168,108,51,142,178,143,43,54,70,108,195
+AB001106_at,355,431,603,255,569,136,282,295,450,400,487,227,765,255,286,470,255,182,354,833,753,291,364,320,169,169,309,274,625,202,249,433,279,218,369,336,297,587
+AB001325_at,1149,941,1924,1078,501,1374,1357,1760,1897,792,1009,651,934,1100,359,828,796,605,952,920,502,810,807,833,847,646,1561,992,1187,955,1052,1336,1081,420,397,1003,1278,1968
+AB002314_at,-131,-95,94,-24,-15,-88,33,-152,34,0,-42,-41,55,-44,-56,3,14,46,85,41,4,-5,-106,-48,50,43,137,-89,-43,14,39,36,79,-25,47,-23,92,92
+AB002315_at,158,328,301,238,181,26,57,143,389,22,356,100,229,156,145,136,345,179,-9,326,172,-7,-20,140,145,114,20,134,60,327,149,255,239,254,660,69,330,168
+AB002318_at,1084,1215,1281,1316,296,841,1041,1253,1375,968,1567,494,757,990,631,965,1319,434,729,2048,838,584,438,1327,606,790,1891,1376,699,1432,747,1053,1625,67,1021,1013,1046,1342
+AB002365_at,87,53,128,112,-39,144,65,203,93,24,54,-1,-49,-12,90,-95,201,-30,27,260,51,71,49,102,-64,-53,208,57,7,91,41,-12,60,3,155,-61,23,8
+AB002366_at,125,-81,70,41,-1,64,-87,50,41,6,2,66,29,51,14,3,129,-17,-36,-14,93,-34,43,72,-39,-33,46,-17,38,-31,-12,-51,17,-7,0,-61,-37,-48
+AB002380_at,11,20,12,34,-2,-32,-95,11,-79,19,-89,-18,29,-6,32,9,80,73,15,367,458,150,7,-19,4,17,106,-52,-26,14,54,57,16,42,63,47,122,71
+AB002382_at,553,215,460,512,514,515,347,1031,392,300,550,337,560,457,539,251,535,365,263,997,277,821,178,903,430,350,414,782,529,664,590,1029,716,179,122,378,145,851
+AB002409_at,152,104,-3,-147,-29,88,-13,-109,35,-30,-22,27,-43,29,212,84,-38,0,-65,14,-99,-62,62,88,121,50,-172,88,12,-171,-40,-10,71,-29,30,-69,38,-118
+AB002559_at,759,1656,1130,1062,822,1020,1068,1455,1099,1164,662,753,728,918,943,644,2703,916,677,1251,138,1557,750,814,667,616,1187,1801,1024,3084,1974,1084,1090,908,2474,1635,1591,1323
+AB003102_at,551,739,885,654,756,769,467,1015,842,439,1368,304,881,704,925,480,1160,583,348,1236,326,541,530,791,388,366,627,697,372,806,1145,618,586,467,684,750,600,742
+AB003103_at,34,37,141,90,159,12,139,130,69,78,189,11,233,160,115,196,295,52,81,453,233,36,104,236,26,40,104,64,134,23,56,-40,68,43,110,95,23,131
+AB003177_at,588,781,1044,652,999,576,764,614,1321,493,1168,196,637,728,609,647,610,342,278,1296,442,500,412,1043,365,603,859,628,637,779,965,598,517,635,857,561,296,790
+AB003698_at,129,182,423,147,243,136,110,79,376,206,326,96,469,373,219,138,520,178,129,419,351,-3,180,416,61,118,150,121,218,173,152,43,105,67,122,62,81,28
+AB004884_at,1128,944,1019,904,1037,528,956,766,1058,905,1104,419,1364,972,851,485,1396,611,574,1882,475,1145,592,699,791,784,1297,1094,423,1245,953,962,1198,491,1019,646,783,1055
+AB006190_at,919,759,1019,614,691,410,658,1088,707,427,605,505,701,631,385,524,799,643,583,935,353,656,516,758,548,557,921,852,779,661,591,591,761,321,843,571,637,836
+AC000061_cds2_at,399,219,650,761,263,261,982,244,244,263,238,347,92,296,200,358,426,239,410,295,74,401,243,587,225,307,882,325,226,428,65,407,341,70,461,-1,299,685
+AC000061_cds3_at,-206,-87,-183,-254,-122,-174,-282,-116,-42,10,-88,-70,-68,-113,-90,-50,-133,-143,-136,-134,-107,-134,-36,-160,-107,-89,-190,-237,-189,-184,-152,26,-196,-86,-147,-44,-133,-192
+AC000062_at,20,13,-33,-9,-17,-42,6,34,-11,-2,-61,-31,-23,43,23,-2,-14,13,-22,15,-29,-34,-62,25,-10,24,42,-35,12,1,1,3,21,11,15,-19,-16,-44
+AC000064_cds1_at,271,595,457,414,397,145,499,530,307,305,199,353,296,603,386,299,357,289,228,452,272,320,341,897,252,200,874,596,774,359,513,606,454,321,536,565,519,596
+AC000064_cds2_at,78,142,205,142,85,135,176,283,187,60,149,54,166,136,165,134,59,98,88,202,126,94,250,101,93,68,175,102,305,180,152,43,205,129,103,154,172,266
+AC000066_at,32,42,2,-26,-23,-69,-10,14,-10,-7,24,15,3,2,31,4,-33,-76,-1,44,89,20,11,-45,-21,-31,-23,-24,-86,-63,1,-4,16,39,-41,-15,-16,-15
+AC000099_at,245,125,124,99,89,92,238,46,17,154,169,64,107,65,59,128,171,97,94,169,16,-9,131,130,33,60,336,152,110,123,163,174,117,130,-56,-160,223,218
+AC000115_cds1_at,-98,-19,86,-57,-199,26,110,59,45,-80,32,-28,-128,-195,-17,70,-61,-121,-54,-63,-154,-206,93,-113,-167,-86,81,-150,-79,-225,-108,-39,97,-78,-128,-14,49,-266
+AC002045_xpt1_at,70,180,92,150,149,136,52,172,137,73,272,90,115,102,55,53,340,-13,66,343,62,160,317,271,167,108,145,220,43,97,197,109,51,119,159,124,206,97
+AC002073_cds1_at,146,224,15,-87,169,85,-3,101,75,-62,233,41,121,-15,109,15,306,124,21,102,-42,138,-93,278,253,78,-62,166,189,258,262,-20,634,-1,132,-189,252,412
+AC002077_at,-260,-638,-402,-862,-254,-88,-635,-1365,-452,-247,-239,-321,-488,-525,-250,-74,-616,-229,-6,19,-52,71,-321,-280,-157,-109,-162,-238,-406,-552,-477,-290,-322,-233,-391,-508,-484,-287
+AC002086_at,117,0,-12,-34,65,40,-90,-86,-11,30,122,8,65,28,8,19,76,11,36,74,68,35,36,123,59,-4,0,79,-64,38,42,54,79,-5,-42,68,64,40
+AC002115_cds1_at,2236,5198,4263,3083,3569,2832,2478,2905,4693,3191,3621,3397,2711,3055,4572,3307,5055,2585,2288,7634,1310,2063,2538,3440,3634,3334,2960,3766,2269,4232,3275,3247,3001,3392,5942,2919,1734,2320
+AC002115_cds3_at,729,533,960,675,425,686,910,779,850,777,727,586,555,439,474,728,801,404,528,443,441,648,854,850,527,437,884,789,776,1007,931,916,881,380,384,858,390,914
+AC002115_cds4_at,-1031,-1029,-1667,-942,-964,-647,-767,-1980,-1202,-1007,-1029,-199,-936,-1004,-324,-1025,-1790,-693,-731,-2070,-446,-952,-701,-564,-862,-775,-650,-1297,-913,-1524,-1490,-1356,-1266,-223,-1503,-1187,-137,-1493
+AC002115_rna2_at,362,387,646,294,580,430,307,281,662,326,417,353,653,442,614,439,416,374,217,1000,128,206,167,789,507,365,84,223,74,695,663,245,678,599,481,472,764,438
+AC002450_at,-28,36,2,-112,56,-115,-68,-11,-20,-60,-5,20,-51,-24,30,-80,87,17,-6,118,6,41,-9,-19,-37,-23,106,-12,-62,41,-26,119,-42,-34,-27,-6,-79,-59
+AC002464_at,-294,33,110,12,15,-67,-38,-221,-158,-99,-140,-80,115,-218,32,-100,-50,-93,-39,-310,-181,-153,-64,277,-66,59,98,-200,-197,-249,-205,52,-348,38,-201,-138,-295,-287
+AC002486_at,333,128,352,109,151,208,162,149,309,97,176,189,102,190,24,111,12,176,89,91,107,201,237,231,135,169,231,203,290,333,141,179,128,126,224,219,97,248
+AD000092_cds1_at,207,-10,109,520,-126,401,-220,188,180,136,203,505,110,125,90,-65,-202,-235,-51,-461,393,487,288,398,32,-222,92,333,538,67,529,-68,11,494,523,176,267,-56
+AD000092_cds2_at,-1305,-887,-1792,-2151,-152,-705,-1601,-1742,-667,-79,-579,-665,-884,-878,-573,-408,-960,-583,-102,-995,-643,-1137,-647,-540,-540,-639,-420,-1094,-697,-1292,-402,-919,-876,-352,-555,-1580,-1532,-1064
+AD000684_cds1_at,-214,88,-270,-203,40,21,-181,-32,-158,-59,-115,-165,-118,-96,-64,-38,-124,-26,25,-100,62,-36,-165,-178,-81,-75,-92,-89,-420,-88,10,-82,-128,30,7,-79,21,-151
+AD001527_cds1_at,141,199,226,108,224,144,220,31,177,172,109,150,57,152,186,137,126,112,98,220,39,31,201,97,100,52,247,67,91,177,215,165,226,105,273,79,184,189
+AF000177_at,-97,348,150,135,280,-176,176,-263,327,89,485,-57,349,92,199,47,192,110,-74,382,213,17,-1,463,82,46,275,142,-180,95,-106,98,131,155,-73,22,-13,98
+AF000231_at,169,71,92,88,196,-24,146,53,132,39,102,18,293,-27,105,256,80,15,162,704,203,51,18,245,17,150,9,23,-31,37,5,48,47,0,-51,43,131,-30
+AF000234_at,-135,-27,-320,-240,-183,-142,-455,-683,-86,-22,-158,-136,-46,-271,-218,-186,98,-93,-706,-668,-184,-370,-265,-212,-475,-288,-132,-17,-348,116,-1073,-768,-98,-257,308,-69,-202,-559
+AF000430_at,7,-5,5,3,112,-51,-1,92,-52,-71,-13,41,38,15,82,-44,4,-4,-37,27,1,15,-81,14,-64,-43,-9,-30,-4,34,73,9,0,50,84,-47,46,-30
+AF000545_at,-273,-71,-191,-269,-48,-243,-272,-337,-129,-152,-29,-17,-53,-237,79,154,-149,24,-347,-596,-138,-154,112,-213,7,-63,-344,-17,-120,-216,-350,-452,143,7,84,-651,-561,-669
+AF000560_at,457,-45,376,325,221,280,361,740,296,-150,127,-149,458,489,75,-2,-13,342,-77,164,-7,211,227,432,3,55,-65,200,281,656,-96,173,865,217,289,405,237,301
+AF000562_at,1002,1152,953,1012,885,901,920,1706,976,967,1008,807,603,811,716,1280,2046,817,811,2446,775,1016,875,431,1314,852,1034,1486,555,2016,1664,1416,1428,1028,1397,1018,1387,976
+AF000573_rna1_at,-62,-83,-91,-172,-40,-49,-36,-97,-45,8,-69,-122,-26,-61,-70,-86,-184,-43,-91,-8,37,26,-72,-77,-19,-7,-179,-76,-211,-71,-119,-116,-31,7,-138,-17,-150,-133
+AF000959_at,-468,-829,-496,-739,-55,-542,-566,-512,-451,-425,-235,-518,-254,89,-141,-417,-678,-22,-233,-629,-473,-426,-550,-279,-185,-334,-1026,-108,-355,-220,-699,-475,-406,-129,-309,-695,-663,-489
+AF001294_at,-154,-50,-177,193,-71,104,248,415,-217,62,31,79,-61,60,-97,124,232,30,88,-143,207,-224,184,96,-191,-124,159,29,-19,185,341,14,-166,43,441,311,469,37
+AF001620_at,-119,-12,-29,-29,-36,-42,10,43,-75,36,21,5,-97,-36,-46,6,-27,-103,-72,-52,-64,-22,56,-36,-7,-99,78,-158,-115,-86,-47,-80,-90,-13,46,-95,-16,-231
+AF002020_at,54,117,175,235,150,142,221,217,141,171,88,132,206,215,249,344,439,149,275,198,276,138,188,250,194,199,350,162,-9,146,356,250,107,98,106,3,47,159
+AF002224_at,180,372,491,528,162,446,527,893,480,421,259,334,111,81,509,211,857,391,11,110,406,443,632,542,144,142,650,668,365,572,181,372,638,231,216,582,435,717
+AF002700_at,373,480,856,506,213,414,772,836,449,128,152,363,201,277,140,135,1006,312,281,417,191,347,455,362,358,349,974,523,425,551,387,376,716,263,683,554,824,1069
+AF003743_at,484,485,-159,597,155,501,774,982,-341,59,72,505,102,313,303,338,-106,-78,-137,-545,357,-221,590,418,573,251,747,70,60,182,771,25,-279,-11,465,451,552,181
+AF005037_at,99,21,-6,33,110,76,70,76,98,9,-23,-73,116,80,97,47,132,23,56,207,-28,-166,-1,54,-17,-15,-37,-12,-91,49,-41,-102,21,27,-27,6,33,33
+AF005043_at,65,92,163,139,107,76,68,-40,98,62,25,21,151,68,62,89,110,95,57,176,196,-23,-41,51,24,60,29,42,2,-3,14,59,10,38,10,27,25,-24
+AF005361_at,-60,62,30,6,-16,-35,-13,56,-62,49,4,-48,28,32,33,14,-30,10,5,16,-39,-64,-13,68,-23,-4,18,-67,-19,-55,33,-35,7,17,-7,-45,-36,-46
+AF005775_at,451,647,842,531,514,487,403,671,492,422,351,352,458,510,424,525,567,1242,296,633,1036,459,469,696,328,410,791,751,598,1249,1157,455,504,772,782,1251,638,744
+AF005887_at,197,119,293,118,200,44,181,206,93,55,152,8,137,86,103,124,182,110,56,339,6,-66,-7,44,78,96,-103,152,-209,166,149,6,42,15,92,91,168,326
+AF006041_at,946,178,2011,515,478,553,1073,2126,743,629,686,181,1420,768,400,913,880,837,914,1449,427,564,70,1474,69,778,391,511,863,1152,685,512,741,504,601,1441,709,1263
+AF006084_at,1190,866,1408,948,1129,983,1287,566,813,765,460,1096,1029,953,1067,737,528,688,443,1089,258,126,431,1302,551,792,658,1299,887,2418,1173,156,1070,395,3219,1678,940,1198
+AF006087_at,370,1466,1334,552,711,227,530,527,1693,642,397,319,560,567,532,502,846,450,325,1277,194,421,480,848,168,363,496,443,394,522,453,3,202,351,1096,481,521,749
+AF006609_at,-300,17,-330,-141,173,-156,-628,-410,-451,-398,-132,-232,3,-189,-58,-377,-31,-117,-156,9,-201,-239,-357,-21,-39,-39,-311,109,-548,-235,-375,-341,-118,-195,-522,-260,-19,-253
+AF007111_at,330,43,428,449,122,245,144,178,169,61,182,7,273,165,158,230,177,209,235,487,103,375,321,299,118,36,75,109,456,192,9,101,87,87,40,142,161,184
+AF007551_at,141,21,-57,87,244,64,465,374,75,14,48,146,112,203,317,290,52,62,169,122,136,37,151,400,104,-39,1,375,206,82,262,296,279,89,69,45,240,42
+AF007875_at,260,362,400,361,389,156,283,203,310,265,309,201,544,282,461,373,258,269,264,1157,778,187,155,600,156,127,292,209,108,262,300,268,279,310,441,275,156,229
+AF008445_at,124,65,-102,-68,24,-16,-109,-55,-90,-10,-2,68,158,-21,84,-9,107,-86,5,1829,930,51,-62,215,247,62,-168,-158,9,198,1741,-9,9,494,-131,0,-1,1314
+AF008937_at,339,453,297,403,440,357,317,568,296,253,268,188,288,342,366,276,993,179,196,541,23,223,288,483,452,137,375,538,363,513,312,388,455,226,564,457,727,597
+AF009301_at,288,95,93,142,214,64,77,266,14,51,361,30,440,361,312,115,775,140,98,1007,-19,82,45,572,84,83,34,117,60,98,95,102,36,111,70,-39,290,133
+AF009368_at,1032,635,1175,1079,658,1365,1424,1520,1506,449,741,767,722,1118,633,1136,750,668,712,1299,805,907,1229,1192,925,620,1395,1561,884,603,759,1143,1161,476,647,1080,793,746
+AF009426_at,36,58,63,38,120,92,16,169,43,-18,26,-81,123,89,268,171,53,-5,86,267,206,-23,-87,135,-35,2,20,-105,-67,-43,-45,-42,-44,-21,-33,-41,9,-107
+AF009674_at,-66,-239,-328,307,212,314,-653,332,221,-106,-169,-446,-93,66,123,-60,-404,-146,143,331,573,-155,-288,463,90,129,-799,-6,-315,-207,-653,62,55,143,87,-579,-387,479
+AF010193_at,87,548,93,-31,159,101,119,589,245,451,91,484,458,158,128,225,555,288,97,1757,363,598,207,153,534,149,680,74,211,439,169,248,465,130,407,194,227,224
+AF012270_at,-12,139,237,104,29,-8,223,416,10,59,29,91,-14,105,37,106,485,134,109,104,144,158,106,78,95,110,34,-95,113,110,234,240,232,86,69,194,73,264
+AF014958_at,318,243,19,108,40,112,329,166,110,159,96,-71,139,112,-36,345,1057,176,268,180,382,15,197,32,306,110,424,81,259,418,159,340,17,174,197,478,444,565
+AF015910_at,1219,1055,1820,1074,822,394,1154,1763,1157,902,837,178,1077,171,316,1317,2041,1140,1053,1767,630,1212,281,1559,460,1196,843,914,240,1735,967,666,563,539,1934,315,741,1908
+AF015913_at,476,611,850,691,1304,346,653,550,826,472,439,239,1558,705,942,560,1366,369,584,2460,0,206,537,1205,337,385,536,424,300,412,270,253,425,346,352,474,493,410
+AF015950_at,-466,-49,-277,-670,-180,-453,-700,-191,-163,-183,-329,-431,-43,-296,-73,334,-436,105,-282,29,-176,-56,-142,221,-137,-211,-863,-852,-529,-646,-574,-525,-346,-344,-261,-497,-544,-602
+AJ000480_at,895,749,1049,1016,634,752,920,254,934,536,607,456,617,592,624,608,925,833,473,801,348,592,478,944,682,611,1391,924,524,2210,1525,983,2416,570,1827,1000,1456,2912
+AJ001047_at,-451,-108,-265,-378,-171,-257,-514,-250,-291,-218,-129,-137,-146,-128,-159,-223,-311,-256,-209,-415,-122,-252,-355,-325,-173,-333,-552,-341,-310,-467,-267,-263,-150,89,-72,-177,-253,-577
+AJ001421_at,687,829,914,982,1294,743,680,527,1352,675,383,616,1071,1004,1106,547,1790,574,660,1828,394,996,457,1366,486,141,342,588,613,1665,1164,533,1038,671,1821,644,630,792
+AJ001487_at,-591,-415,-653,-546,-264,-503,-875,-490,-778,-329,-391,-290,-275,-365,-370,-240,-235,-135,-403,-145,-181,-418,-507,-378,-362,-292,-242,-544,-824,-849,-539,-196,-716,-161,-220,-261,-395,-208
+D00017_at,-94,2072,1658,2209,5846,1189,2263,1015,7449,1483,2527,1352,1974,718,1727,2161,1707,299,-2,714,1833,627,664,1057,400,1063,2664,69,476,7883,3290,595,185,889,8752,3570,1441,3260
+D00591_at,172,87,323,261,536,-277,210,311,194,137,291,-114,144,18,263,274,-10,17,314,275,164,-31,89,178,117,239,158,279,-194,234,288,303,251,195,137,119,36,333
+D00596_at,1800,2629,3933,1438,2439,2046,742,277,6284,2216,3658,1033,4359,1290,2102,529,2196,1721,1171,1350,782,442,1518,2200,991,629,835,458,942,1753,1529,787,3107,1114,1091,1665,175,306
+D00632_at,194,287,695,544,104,330,588,827,177,283,285,80,87,254,117,151,248,172,293,137,163,523,205,261,105,190,89,178,290,255,696,677,258,163,510,410,462,894
+D00654_at,-77,94,-181,-142,37,-17,-196,-80,61,-84,-35,-24,-29,-112,58,-23,-31,-30,-15,114,-19,-1,-72,-45,20,-18,35,-185,-98,-168,-54,-19,-22,37,172,-104,-32,-130
+D00723_at,40,87,77,136,223,-23,42,-26,82,66,68,8,68,86,75,44,107,-9,41,544,697,6,81,208,-15,43,26,10,-9,-21,47,59,0,37,132,39,11,43
+D00726_at,274,432,640,283,201,208,445,802,451,338,279,83,257,296,61,307,360,349,566,1357,383,291,359,191,344,91,438,279,699,408,2883,2185,744,1165,698,358,392,1284
+D00760_at,746,593,1778,783,1147,540,779,398,1595,579,1187,517,610,770,1056,531,347,761,511,2159,1195,530,469,841,425,275,434,284,562,297,804,652,735,701,646,818,213,439
+D00761_at,649,1420,1167,893,1423,659,717,542,1432,1666,1516,731,1630,813,1520,867,587,894,628,2992,2313,400,1005,1575,447,707,500,661,1000,656,2171,1674,1474,2401,2111,1338,650,1417
+D00762_at,645,782,1119,770,1202,444,677,337,688,570,802,334,1097,685,857,622,455,654,471,1694,590,286,368,1072,242,240,574,419,331,521,741,543,630,677,676,570,479,964
+D00763_at,1324,2304,2677,1415,2076,953,1513,922,3039,1619,1113,632,3365,1781,1907,2398,1405,794,2089,6521,2912,500,972,2411,470,1509,1855,815,714,1104,673,546,814,1076,1361,1161,660,474
+D10202_at,42,82,-3,101,80,122,35,-37,-44,-1,23,45,32,73,-36,90,-66,73,-184,-181,-94,28,-22,166,80,93,37,-299,-153,748,309,50,-310,3,1008,145,-144,-393
+D10495_at,-208,334,-386,366,408,200,381,-215,-322,36,-163,448,-102,153,195,9,192,-182,-114,-52,-131,172,186,177,209,-156,-517,908,228,1087,1174,284,319,259,2131,676,264,507
+D10511_at,-66,58,150,370,709,119,152,62,255,166,156,316,509,243,311,135,149,199,266,382,218,78,83,497,180,269,194,224,60,361,174,29,200,151,403,283,89,-47
+D10522_at,397,515,343,36,29,53,-8,19,13,652,549,-7,1420,97,-20,312,438,408,20,18,217,286,550,7,48,13,42,54,24,2719,706,24,104,42,707,464,115,438
+D10523_at,415,641,1053,630,771,604,710,235,1097,420,585,290,550,1051,500,372,281,389,200,508,27,150,478,489,214,317,250,723,408,812,438,85,378,-10,602,752,494,368
+D10656_at,210,166,380,112,209,259,119,29,43,16,173,81,209,30,45,83,162,141,150,205,129,113,239,275,127,-53,350,151,132,129,247,160,197,99,10,364,13,547
+D10704_at,-252,95,-363,-300,177,-78,-349,-650,-425,68,-198,-142,-78,-79,261,-94,7,-77,-152,274,139,-137,-89,265,-101,127,-639,-142,-266,-300,212,-182,-258,143,43,-344,-206,-426
+D10923_at,-36,23,-21,-41,71,76,-70,-61,-14,10,-41,265,-20,75,-36,-42,-62,3,-60,-69,96,-18,-34,-64,196,182,-140,18,-137,1412,367,-40,5,50,205,82,4,72
+D10995_at,350,249,767,420,179,371,331,665,500,396,261,264,463,233,93,278,263,262,-34,220,102,130,317,479,65,266,511,398,334,757,473,83,601,151,469,654,682,413
+D11086_at,1497,3649,2853,1853,1507,3549,2772,2545,5269,1873,2998,2558,1319,4519,1826,1385,7260,833,898,3020,1982,676,1485,2367,1956,1813,891,2119,2224,1158,770,438,750,713,225,3693,1628,744
+D11094_at,-42,399,102,-3,504,23,-89,-101,305,51,1031,-47,248,395,391,273,407,109,94,1276,1043,132,132,189,43,68,-17,16,-48,198,80,261,248,424,22,54,141,42
+D11139_at,43,-155,-169,47,-67,-71,-144,-350,-68,15,-43,-60,-107,39,-1,-64,-340,-61,47,-167,-63,26,-246,-81,37,-108,-195,-104,129,-232,-38,-73,1,-143,-96,132,26,105
+D11151_at,96,75,93,95,52,53,13,92,80,38,42,45,22,8,51,62,89,45,111,73,62,74,132,128,-5,134,97,82,52,43,127,152,40,10,77,28,201,83
+D11428_at,-104,103,-347,-79,-111,-496,67,-442,95,-289,-134,-66,-346,-51,144,-48,-612,19,142,3634,-186,-185,-457,-271,-302,-165,-531,-83,-28,-282,87,219,191,-250,-143,190,-469,-28
+D12485_at,163,34,55,66,56,71,117,46,165,76,29,60,65,92,20,64,37,-68,65,20,107,-48,11,29,-127,-21,1,8,60,34,-27,26,80,43,23,-166,48,129
+D12625_at,5,-36,-110,-23,-33,28,63,-17,-39,-37,17,-8,-42,59,-32,-13,44,-9,5,-31,-21,-19,-28,-104,-37,-45,37,-44,-64,40,-21,-65,-43,-29,16,13,26,-25
+D12676_at,-8,-177,-39,-15,17,-69,-13,-22,-67,-51,-62,2,19,-30,-44,1,-64,-15,16,105,8,-2,-129,5,-42,-38,-9,-70,-64,-64,-19,22,33,-38,-57,-109,-25,0
+D12686_at,-1247,-1695,-1648,-1409,-435,-1168,-1357,-728,-2050,-1055,-901,-1245,-458,-452,-664,-810,-1849,-866,-733,-1650,-1055,-1111,-1413,-903,-1166,-788,-3062,-1011,-930,-1701,-1578,-819,-1931,-1118,-1099,-1328,-1491,-2763
+D12763_at,-189,-330,-298,-39,-278,-288,-21,31,-353,-8,-308,18,-66,-175,-202,-178,-391,-285,-31,-317,-26,-39,-277,-443,-259,-228,39,-464,-259,-395,-237,28,-94,-70,-226,-147,7,-258
+D13118_at,3245,2925,4093,3827,3814,3070,3540,3731,3821,2746,2481,2940,3016,3406,2834,2459,3480,1794,2806,5163,2516,3133,2564,3124,2271,2477,3683,3900,3772,4398,3449,3415,3685,1625,3103,3971,3198,3365
+D13168_at,37,22,-44,5,21,24,72,49,43,-2,-3,1,2,1,51,2,57,40,-12,-13,-16,44,70,-2,-19,-13,115,25,-7,33,-1,22,-4,-10,39,-14,1,-30
+D13264_at,21,21,-102,-21,-20,-71,-11,-76,-82,-21,-42,40,-29,1,4,6,-38,-34,2,11,-48,-19,26,-21,-35,-49,-34,-73,-98,11,-52,-24,-108,15,11,-111,-58,-54
+D13305_at,-185,-297,-282,-675,-392,-576,-134,-605,-187,-108,-128,-159,-476,-544,-160,-113,-362,-140,-305,-643,-13,-551,-94,-552,-225,-222,-214,-358,-108,-259,-152,-343,-227,-62,-222,-128,211,-79
+D13315_at,660,1004,1604,499,889,560,33,184,1939,933,960,482,1431,572,737,651,1156,827,710,1652,1080,402,638,619,367,475,120,640,228,323,517,227,1252,177,716,422,717,582
+D13370_at,2028,1732,2519,2650,3255,1666,1429,1430,3079,1349,2176,926,2566,2329,2288,1962,2755,1335,1665,5912,1569,1615,1130,3047,1061,1396,1699,1538,1322,781,1395,1090,1933,1475,2065,2256,1081,1399
+D13435_at,407,68,348,428,484,80,428,16,198,137,94,160,272,251,285,328,562,180,233,809,93,90,91,333,61,143,223,170,146,203,90,10,110,0,212,257,95,254
+D13540_at,169,90,254,201,126,167,231,248,190,28,72,110,46,96,35,44,143,80,56,48,44,171,241,128,73,18,145,114,153,158,200,170,185,17,143,183,266,236
+D13626_at,37,13,63,-22,-22,-106,-53,-92,-70,-59,-20,-70,720,-38,-22,60,29,27,285,102,-74,69,-93,-18,3,55,45,-11,-40,-64,-17,21,-45,-43,14,0,-4,-18
+D13627_at,600,977,1423,698,1839,720,620,388,1986,1166,1156,129,1797,989,1430,960,698,1145,903,4074,3191,222,328,1434,1620,843,1639,910,206,319,394,204,964,983,785,328,246,133
+D13628_at,129,113,302,187,153,5,325,-10,319,111,204,27,152,329,35,121,812,110,45,204,84,126,20,300,104,131,403,1165,351,160,45,139,344,114,219,567,569,438
+D13630_at,667,951,1119,596,786,295,589,533,1277,510,705,432,651,631,523,518,467,231,228,2299,1512,525,459,971,369,285,686,384,317,512,1013,240,493,470,759,625,453,775
+D13633_at,174,44,173,139,148,7,99,31,208,78,136,20,488,65,128,49,52,138,53,150,154,41,125,123,33,12,126,2,36,128,108,95,79,150,-26,87,12,-6
+D13634_at,126,86,245,153,145,128,178,151,94,115,192,106,236,129,141,51,122,55,54,176,111,162,153,278,101,106,164,131,245,105,108,93,146,97,164,119,158,143
+D13635_at,-147,12,-18,-46,-9,17,36,-80,114,10,-27,27,32,-77,22,-14,71,-1,28,276,-99,27,-28,-60,-2,-40,-92,-83,45,-71,-22,-98,-105,30,34,37,-49,-26
+D13636_at,-24,-134,-213,-60,257,5,336,-98,173,256,34,48,370,211,265,264,149,10,143,1066,313,-75,-121,357,-176,76,-3,-146,-120,-50,-269,-247,-230,45,-655,82,177,-119
+D13637_at,98,138,-276,134,51,-133,53,-70,-255,-100,-132,50,341,-153,275,-95,-26,-190,-68,185,49,-107,-74,127,56,-142,-278,-236,-127,29,-54,-87,-38,18,-175,3,-149,-108
+D13639_at,4707,3367,-44,101,1276,30,154,2326,1848,114,24,1531,4215,49,259,2418,7650,527,4246,4477,21,41,127,296,2295,5865,330,812,685,176,421,1543,2727,1234,-9,1518,1754,2889
+D13640_at,656,185,426,975,1196,503,764,380,916,2,321,1401,2099,157,1205,949,1312,292,959,1586,529,417,36,1076,895,1469,298,1778,810,1124,547,-5,452,239,456,963,2315,678
+D13641_at,307,1352,640,469,1454,510,608,625,1342,839,1292,765,1464,780,1211,593,1662,406,891,4643,1777,1637,621,1173,532,295,492,934,663,658,703,858,1206,960,1112,974,988,975
+D13642_at,100,372,-1,234,266,156,137,194,49,106,118,11,129,75,106,196,122,47,-4,127,163,142,153,332,170,112,42,68,52,124,-211,20,110,-93,148,124,165,336
+D13643_at,-741,-218,-196,-796,-384,-110,-339,-670,824,-224,-272,-211,-465,-91,-329,-559,-1570,-418,-217,-386,-238,-256,-258,-495,-278,-493,-1372,-1204,-444,-377,-418,-441,-336,-235,-434,-476,-616,-301
+D13644_at,60,-10,39,82,37,62,6,47,-24,15,34,56,93,24,83,-16,55,53,46,141,6,122,-7,96,17,58,17,-21,141,-2,11,-8,24,42,8,27,19,38
+D13645_at,-121,121,-353,18,284,-1,-80,-118,10,73,-19,-91,142,132,232,12,-27,-49,-12,724,-71,-145,-265,83,-78,-14,-46,-85,-158,-76,-155,-116,-80,7,-87,-37,1,-204
+D13748_at,2434,6886,6447,5181,8372,5203,5440,6361,8463,5838,4633,5084,5838,6653,7367,4250,9271,3178,5083,10555,328,4391,3852,7659,5630,4197,3229,9068,6369,10920,7311,5563,8202,4350,10903,9000,2831,7015
+D13789_at,-330,-803,-1311,-808,-447,-768,-836,-1362,-809,-673,-678,-619,-487,-741,-439,-623,-1141,-729,-450,-813,-614,-706,-611,-947,-605,-859,-1314,-826,-935,-1110,-1021,-432,-800,-410,-920,-791,-940,-1082
+D13897_rna2_at,557,346,669,450,207,394,477,626,587,409,445,373,294,410,337,340,215,252,205,356,492,457,398,518,271,318,234,226,632,622,478,423,445,183,122,570,582,615
+D13900_at,1634,1778,2122,2331,2452,1104,2117,1184,2562,1401,858,1197,2176,783,3532,1553,2193,2295,1517,4253,1414,1004,704,1603,1076,1950,1896,1784,1940,1969,1306,1250,1570,841,2141,2401,2140,1320
+D13969_at,-243,-145,-85,-206,-45,-147,-243,-344,-228,-111,-58,-61,-85,-150,91,-80,-452,-54,-196,-42,26,-90,-207,-58,131,-7,-242,-123,-298,-132,-344,-205,-385,-109,-220,-321,-147,-301
+D13988_at,1797,860,2072,2817,3556,1118,1670,818,2511,730,1532,725,1591,977,1815,919,1123,1251,1065,2610,206,1025,832,2208,676,361,882,1219,1466,1518,773,824,1566,699,1919,1156,756,1177
+D14043_at,1160,823,858,980,1761,151,1068,677,808,413,433,471,2219,1289,1570,891,1494,441,1504,7309,1163,491,284,1356,960,504,469,1612,610,594,572,313,920,394,386,821,3293,858
+D14134_at,-177,-56,-175,-165,-45,-119,-78,-209,-132,-62,-54,-50,-60,-168,-47,-242,-96,-61,-129,-110,-51,-150,-119,-95,-54,-128,-134,-176,-113,-135,-55,-73,-164,-87,-141,-105,-79,-108
+D14446_at,175,102,276,131,143,115,231,130,155,88,171,155,167,154,85,188,230,83,136,191,136,266,174,128,150,175,129,108,199,219,119,137,271,111,170,96,48,280
+D14497_at,55,87,39,-5,-1,12,15,-79,37,35,-5,44,26,1,8,-2,-32,48,-16,11,-53,3,-17,-56,-13,9,37,23,40,38,39,63,53,-7,24,-32,-11,85
+D14520_at,-86,-3,-53,103,5,160,67,0,-5,30,51,76,-8,-29,-67,68,1,121,-21,11,62,1,123,-2,-39,-2,82,-34,-100,13,90,43,-19,13,-28,-7,84,90
+D14530_at,16642,15527,19494,18849,20259,11800,19387,14498,18727,18364,18050,17432,17886,16647,17094,18770,18647,16456,20801,21417,26343,18051,11568,19439,15739,19919,20597,21372,17870,16587,18009,16184,19129,14753,19635,14925,15405,22571
+D14533_at,-89,-207,-320,-284,-205,-254,-337,-440,-231,-138,-192,-135,-167,-215,-25,-126,-252,-267,-23,62,317,-154,-131,-88,-110,-120,-594,-208,-396,-364,-344,-230,-259,-6,-369,-162,-123,-500
+D14657_at,885,1239,2864,1146,1530,1202,443,256,3794,2787,2400,686,2620,1765,1721,314,1184,1434,599,503,3023,782,1096,1661,806,485,453,651,1183,1568,2001,1030,3302,1593,1133,957,93,631
+D14658_at,1234,411,1131,952,1202,437,939,592,1699,477,547,283,1546,755,1377,1194,1298,461,1196,3110,1691,321,531,1267,303,786,766,338,327,541,391,166,476,258,275,737,389,363
+D14659_at,122,32,42,88,163,-16,80,8,17,39,8,34,148,131,78,8,147,68,9,127,127,-3,11,153,50,46,3,22,-62,3,60,5,7,34,25,9,38,24
+D14660_at,-5,-4,-19,-76,94,1,-55,-68,27,31,2,-14,50,11,-3,-2,13,46,-5,95,-27,27,-110,93,46,2,-37,-53,-69,-4,13,-72,-73,17,-44,-31,20,-36
+D14661_at,437,757,531,352,495,302,253,337,728,582,646,363,1008,215,371,492,243,147,430,1383,234,598,400,554,276,408,359,298,324,561,916,384,552,438,808,363,532,467
+D14662_at,492,1210,594,740,839,551,672,829,1259,787,621,691,1455,656,765,727,437,276,612,2303,1527,221,636,1520,413,602,638,633,709,590,544,451,683,466,1290,682,1034,507
+D14663_at,438,739,924,399,633,229,536,532,1076,365,837,334,714,585,726,405,992,419,362,1569,1605,610,387,726,264,301,586,482,211,618,1142,708,488,924,826,596,449,793
+D14664_at,21,82,-18,114,128,58,84,107,0,1,-1,99,31,71,46,-27,586,28,12,87,-28,19,47,151,-12,-20,-4,380,139,536,154,41,72,209,483,364,159,129
+D14678_at,-100,-25,68,17,100,-51,-235,-868,7,-28,-72,-204,125,-186,93,-168,-4,14,-49,90,79,-82,110,-125,47,-36,-151,-195,-339,-68,-35,-45,-58,-62,-191,-177,-101,-109
+D14686_at,310,294,453,345,16,273,601,806,271,178,56,-20,123,252,53,225,107,345,223,1018,72,368,231,323,462,58,517,705,565,398,443,639,395,69,113,387,599,442
+D14689_at,353,498,875,899,529,218,1255,139,271,-43,297,244,985,193,1112,301,1235,435,269,1542,530,210,188,862,949,763,178,665,704,1443,786,1432,434,464,494,872,423,512
+D14694_at,1573,1962,1329,2115,1894,1047,1880,1707,2450,1166,1462,915,2050,1974,2462,1385,7834,1685,1072,3837,3201,1354,1381,2137,1240,1732,1334,2043,1387,2078,1501,1223,1683,1124,1528,1290,1320,1868
+D14695_at,185,824,320,187,104,211,129,61,636,307,1477,70,324,134,164,-34,-157,939,44,398,864,206,140,202,338,88,-92,197,26,739,136,348,234,247,210,245,170,299
+D14710_at,3343,6088,6293,5603,7437,3903,4587,3656,9100,3494,5865,1557,5968,5759,7729,6312,10082,4801,3915,13742,10179,3221,4797,6125,2097,4167,4013,5276,3253,3844,3203,3378,3982,3810,5512,5585,1470,1563
+D14811_at,109,574,314,209,49,268,384,283,271,13,535,71,55,358,260,199,477,499,53,524,308,190,311,299,215,312,713,610,702,368,750,656,295,496,838,341,277,465
+D14812_at,2890,3286,2687,2051,3018,1394,2039,2087,3351,3110,2534,2374,5315,1582,2774,2979,4795,1844,2545,7252,3089,2004,1658,2403,2193,1675,1841,2478,1315,3234,2466,1230,3415,1270,3478,2162,2318,3297
+D14822_at,-75,7,-20,-2,12,-8,23,32,0,-13,3,-1,13,66,35,-5,27,51,23,13,23,2,51,-40,51,8,6,-9,-16,0,31,40,33,-13,28,69,-15,82
+D14823_at,-61,26,36,-71,-11,14,35,17,-49,3,94,120,-40,-62,6,-24,76,-32,-3,15,118,18,36,-4,23,40,29,110,2,-17,-9,71,24,2,5,-9,35,-13
+D14827_at,-69,-161,-140,-225,157,-8,47,-409,-380,-68,202,64,-224,165,-129,89,100,79,62,-194,-96,-78,41,33,-32,129,219,158,-214,-8,-39,-305,343,213,-203,168,408,-140
+D14838_at,-151,-52,-118,-143,-7,-55,-124,-155,-247,36,-22,-110,-57,487,110,142,-86,-33,-72,-73,930,132,-51,-80,-39,-190,76,16,-57,-99,25,-20,70,-3,-36,-3,-87,-81
+D14874_at,163,176,133,93,75,163,-8,94,204,149,152,304,61,141,62,22,100,100,72,128,54,56,170,134,327,105,170,225,252,770,365,205,440,195,297,194,274,511
+D14878_at,644,754,794,598,1458,456,478,443,508,289,595,165,659,527,653,583,725,401,384,1563,136,234,271,882,368,431,740,564,384,274,483,306,509,419,655,698,427,479
+D14889_at,663,601,848,526,341,334,379,497,528,461,381,461,321,424,204,385,452,324,331,487,158,452,313,308,313,407,491,597,367,630,553,430,587,313,461,561,549,818
+D15049_at,53,-33,114,-403,-105,0,43,50,74,163,94,-77,270,69,94,157,40,-114,194,-26,22,130,11,93,69,194,-569,183,139,-26,49,-48,345,1,-118,0,-32,10
+D15050_at,613,1487,810,453,1146,384,1560,842,794,516,829,799,1238,311,827,1243,534,394,2617,2237,1506,915,286,419,811,884,819,704,622,682,990,745,3392,362,726,418,610,1419
+D15057_at,338,425,759,805,3135,122,2470,203,826,632,603,339,1750,449,4655,839,716,1379,1124,3462,1649,70,9,2622,229,295,391,712,642,612,353,39,144,356,503,527,268,147
+D16181_at,14,45,84,20,52,23,26,104,89,0,0,84,11,-18,43,49,19,45,41,96,57,30,28,98,25,60,161,81,100,105,41,18,13,71,69,155,96,-39
+D16217_at,874,344,903,690,904,380,707,479,468,373,598,685,581,805,417,480,315,830,655,384,429,383,248,796,488,757,614,729,730,1584,1412,667,470,414,1534,956,478,1451
+D16227_at,-221,-32,-640,-82,80,-259,43,-524,-429,-155,-423,126,-238,-144,-105,-137,5,-45,100,355,-183,-422,-433,-2,27,-61,-187,-161,-199,-337,-308,-59,-281,125,-330,-270,-167,-443
+D16294_at,362,503,383,252,687,206,273,-44,663,213,289,211,747,372,535,296,286,286,89,647,553,88,-9,378,123,125,153,199,375,307,409,103,214,205,520,122,-64,256
+D16350_at,-53,14,-29,-61,39,-23,-31,-70,99,79,34,-68,62,-13,-10,-22,47,-29,18,34,56,3,-79,53,43,-10,-71,92,209,4,-47,71,31,6,-65,41,-69,63
+D16469_at,906,708,388,521,690,300,942,305,764,279,365,797,2261,331,471,457,1261,251,727,1731,469,238,286,946,437,505,-46,1613,928,1945,909,482,716,1062,2199,1318,1250,1032
+D16532_at,92,-63,23,224,69,-69,835,73,-44,-13,-12,-5,1,-22,49,-17,-17,60,24,101,122,30,28,524,-17,-5,6,56,-60,41,50,58,20,34,94,64,33,61
+D16562_at,2452,3874,3827,3429,3758,3289,2809,3037,4866,2847,3456,2914,3928,3485,3333,3205,5436,1911,1913,7819,8736,1812,2127,3533,2432,1435,2617,2487,1885,2601,1968,887,2003,3371,3794,3882,2425,1644
+D16581_at,952,2426,1660,1274,1192,1452,1095,1196,1568,734,811,1063,1061,766,1285,862,1483,489,728,1428,645,863,748,1048,757,1023,1236,721,533,1414,972,1654,1275,899,756,1283,872,1009
+D16583_at,-977,-771,-959,-608,-333,-837,-566,104,-677,-779,-594,-666,-614,-426,-505,-753,-755,-540,-439,-541,-141,-742,-813,-461,-748,-380,-760,-1092,-863,-794,-330,-278,-350,-59,-616,-308,-510,-479
+D16593_at,204,573,281,769,40,419,561,479,878,163,567,250,55,441,483,213,821,304,244,286,72,336,634,122,219,143,818,171,500,276,732,139,249,-118,618,800,846,361
+D16626_at,-136,-174,-180,-167,70,-26,-247,-190,-225,-131,-148,-99,-131,-28,-65,-158,14,-62,-77,-112,-104,-77,-161,-169,-42,-91,-139,-83,-163,197,-53,59,-199,-75,-65,-198,-112,-157
+D16815_at,88,-30,145,136,-29,8,70,245,72,88,40,96,102,132,79,-5,178,65,3,104,18,78,98,97,-8,62,165,162,-413,138,22,56,150,-34,43,102,108,90
+D17357_at,134,56,207,19,6,0,18,179,92,31,27,11,3,32,9,-602,61,46,-34,-6,17,24,159,-2,38,68,225,-13,12,59,151,64,96,9,-56,61,-17,152
+D17390_at,-1129,-1172,-1406,-1960,-696,-1362,-1732,-1743,-1173,-672,-965,-1166,-649,-1240,-902,-1063,-1342,-627,-866,-699,-552,-1177,-1274,-821,-1084,-482,-2373,-856,-959,-1275,-1495,-859,-942,-756,-1425,-1492,-1001,-1563
+D17391_at,-117,-82,-125,-116,-67,30,-58,-74,-89,-44,-101,-50,-23,-12,-77,-48,-84,-176,-89,-70,-77,-31,-64,-10,-47,-56,-129,10,-7,-28,37,54,-100,-86,-32,-138,-77,-87
+D17400_at,-165,76,-263,-9,42,-254,-218,-223,-185,26,-67,8,147,0,256,99,152,-22,95,379,443,-10,-150,100,134,-5,-114,91,50,-1,-23,45,121,43,68,0,9,12
+D17461_at,-594,-268,-630,-21,-81,-307,-243,-925,-271,-298,-428,-135,-258,-373,-204,-349,-252,-254,-145,221,-188,-150,-535,-402,-283,-382,-699,-120,-341,-243,-17,-397,-130,106,-270,-455,-573,-85
+D17516_at,-41,-13,-144,-240,26,19,-87,137,295,45,-4,10,106,59,62,0,27,72,1,186,131,66,83,141,48,28,-75,130,127,-75,21,210,-11,213,58,141,117,-92
+D17525_at,148,331,1069,750,617,725,1124,890,901,548,469,60,382,424,557,636,329,490,147,-107,353,589,469,854,407,573,262,966,738,884,286,174,747,408,-196,850,232,279
+D17716_at,557,512,1085,643,382,264,507,565,425,409,645,314,539,466,341,608,672,502,351,489,22,698,309,786,421,482,776,652,132,1055,395,325,467,209,383,481,398,779
+D21063_at,1121,1656,2358,849,769,1228,934,298,2394,1932,460,206,1798,755,730,304,2498,1599,339,859,101,377,408,1116,274,375,866,82,454,75,341,58,962,797,167,954,-141,467
+D21089_at,959,310,1210,914,697,689,1356,890,815,467,540,501,728,713,603,402,1033,662,564,899,436,483,364,756,343,417,600,861,675,896,642,473,715,350,461,886,511,1071
+D21090_at,171,224,371,76,340,151,194,26,299,163,176,120,332,290,133,318,527,87,177,649,353,85,113,289,76,139,242,147,134,194,223,184,151,51,194,194,123,273
+D21163_at,25,-1,58,310,61,-277,245,149,-222,66,-16,-5,174,-55,-52,99,161,179,109,365,158,-90,-125,185,82,82,-175,280,139,-25,-538,114,5,14,-98,74,-106,59
+D21205_at,-601,-722,-806,-646,-371,-453,-551,-940,-655,-466,-551,-412,-537,-606,-351,-611,-533,-507,-488,-951,-408,-631,-416,-490,-614,-632,-1046,-493,-651,-5,204,-605,-644,-242,-720,-406,-418,-452
+D21239_at,-90,-70,-135,-224,-130,-133,-258,-86,-160,-45,-170,-94,-24,-142,-47,-120,-220,-81,91,46,-43,-102,-119,-97,-186,0,-167,-80,-259,-34,1,-109,-87,22,-24,-139,-68,-186
+D21255_at,-125,-83,-151,-52,618,-40,-68,88,-65,-19,-14,-57,-34,-34,578,-40,-98,-73,-53,497,-29,-22,-93,-155,-2,-104,-75,-2,-74,-58,-74,-14,-84,-19,-23,-23,-49,-95
+D21260_at,1400,616,833,1402,1501,286,1529,4601,2108,413,1391,265,2428,1044,1709,2065,1200,1254,1670,15646,970,358,248,1577,207,1422,1669,916,730,1002,1832,887,899,897,1021,566,420,853
+D21261_at,7819,10357,12527,7693,10766,6572,7216,10210,17588,14289,9554,7264,5249,7918,4418,5187,8462,4258,3385,7334,1779,4889,4153,7131,3951,5371,6020,13146,6658,13773,11107,6177,12227,6300,15470,16603,12922,11422
+D21262_at,122,227,272,46,449,51,124,52,539,186,329,58,544,339,281,216,145,-1,187,1398,553,-7,150,298,29,41,267,87,156,11,78,40,3,-59,94,34,-21,-20
+D21267_at,50,-13,107,-20,17,48,26,160,69,27,81,-21,4,0,21,17,72,91,10,23,69,-19,30,40,59,73,39,62,-16,83,7,87,23,-11,11,37,62,164
+D21337_at,73,85,0,-17,-24,-16,-26,85,-37,4,12,-10,79,28,-18,100,-3,116,13,58,-78,-15,-47,129,27,-1,198,-41,-86,21,75,73,-27,33,205,-7,0,189
+D21851_at,99,77,84,174,127,145,169,241,159,27,93,47,101,125,144,157,239,108,128,224,111,39,132,140,99,92,139,105,9,76,77,25,59,38,48,103,84,103
+D21852_at,304,705,569,372,507,528,441,577,741,346,657,237,631,446,541,487,1051,309,305,1528,1882,266,288,638,198,356,441,381,259,229,221,147,297,183,341,503,489,64
+D21853_at,554,663,670,752,1007,718,789,836,999,739,927,505,883,732,847,446,1923,570,475,1132,887,600,1575,696,665,613,826,469,464,845,877,664,949,596,1036,767,570,1051
+D21878_at,-109,-33,-102,-152,-119,-67,-208,-229,-86,-95,-83,-34,-76,-130,-95,-191,-68,-153,-94,-171,-178,-149,-165,-122,-208,-104,-236,-98,-110,235,-135,-250,-88,-35,183,-87,-161,-122
+D23660_at,10477,18420,11507,17843,19284,12474,10328,10468,17887,16525,18265,14053,14446,18704,17603,18122,16798,15542,15496,23144,15370,11729,13888,17535,14790,12742,15657,18584,10637,10079,18802,17933,15351,14179,17480,16850,14550,10044
+D23662_at,1743,2941,2610,1974,2380,1872,1240,1863,3288,1914,1856,1300,3091,1451,1996,1676,3238,1221,1027,4157,1611,791,1322,1661,1438,1500,721,1963,1411,2041,1426,1101,1553,1269,1760,2134,1493,1084
+D23673_at,3617,2103,2419,2573,1983,1925,2407,2743,2037,1490,1545,1523,3525,1638,2487,1458,3099,1347,1582,2966,2318,1785,1607,2634,2501,3545,2465,2249,1714,1449,1391,1761,1823,796,1136,1619,1510,1796
+D25215_at,-26,-144,-38,-95,-69,-67,0,-226,-154,-192,-82,-64,142,-135,24,-367,-107,7,-27,-81,-86,-128,-51,-23,-31,-145,-336,-198,-60,-68,-99,-78,24,-51,-1,-133,-36,-59
+D25216_at,1023,714,1296,1648,655,1397,1187,1542,765,710,767,1268,830,456,946,1276,2359,647,999,2117,2050,268,1196,1286,637,881,1646,1393,952,1494,1907,1459,748,833,614,1539,1138,1463
+D25217_at,288,436,736,320,1409,-94,730,634,307,265,230,270,214,592,822,1165,703,399,468,262,58,452,229,835,393,252,-3,949,565,428,1537,411,1174,587,-253,555,862,1367
+D25218_at,327,239,169,619,643,392,315,230,589,381,189,280,227,599,604,327,305,332,377,1097,329,428,378,456,256,435,26,403,221,534,290,309,465,346,268,431,577,645
+D25248_at,460,285,492,375,278,231,457,323,309,315,296,109,270,277,236,364,546,402,213,596,274,360,303,547,286,404,650,485,425,595,268,367,405,163,247,393,512,551
+D25274_at,1148,507,1002,1312,1538,622,835,428,1901,274,1288,426,1249,558,1505,759,1010,268,802,2709,1987,732,782,1616,294,665,427,416,452,1108,1119,699,350,849,1689,1411,1066,1200
+D25278_at,469,321,601,537,395,211,653,514,431,479,274,140,573,375,331,369,885,435,526,1038,358,388,419,666,361,440,602,580,593,616,378,270,477,266,380,338,312,611
+D25303_at,132,209,77,207,134,26,58,250,411,-64,280,242,80,221,310,73,188,30,184,271,102,81,326,333,299,366,398,69,45,68,392,304,286,162,207,315,246,55
+D25328_at,-146,377,153,224,1714,190,184,-101,1172,-13,655,-33,189,920,525,268,481,302,147,924,39,-81,269,380,206,-21,-143,-26,223,-73,13,27,64,118,302,-1,-118,-99
+D25538_at,61,247,238,160,355,74,403,97,277,125,169,142,433,849,297,168,424,124,92,392,116,-22,121,711,161,213,43,262,218,355,83,22,203,105,252,111,265,13
+D25539_at,519,15,144,458,29,279,250,52,83,83,127,-84,4,-14,-16,148,-20,21,3,-27,269,53,41,288,28,5,79,-50,302,92,17,34,43,186,-129,465,121,166
+D25547_at,797,768,1057,505,584,391,742,685,678,426,893,311,494,720,506,124,557,295,189,427,787,133,271,777,498,422,896,700,533,1014,1167,590,501,624,1141,409,276,1247
+D26018_at,-63,-14,-75,-10,226,158,-35,-140,73,-65,64,-86,195,-11,231,92,110,86,135,216,113,-87,-89,230,-40,28,-97,-158,-50,-53,-252,-41,-43,54,24,-83,-125,-232
+D26067_at,461,171,208,241,218,151,373,161,206,175,98,148,508,207,190,340,334,281,102,445,166,143,89,274,100,99,370,86,31,195,151,309,196,70,20,201,77,371
+D26068_at,3355,3872,3932,2423,3716,1744,3103,2257,5136,2823,5321,2085,3968,3051,3162,3231,3340,2861,3105,8467,7855,4116,2260,4436,2227,2563,2417,3171,1779,4968,4985,3634,4165,2255,5332,3385,2149,4992
+D26069_at,295,258,312,266,231,140,258,211,431,82,234,107,666,278,361,375,308,92,249,550,206,273,197,466,106,183,186,231,141,270,198,187,239,150,117,179,149,156
+D26129_at,-31,-8,-20,-104,78,192,-43,-7,24,-154,-19,-94,-28,32,0,-6,33,47,149,-4,33,-35,66,-70,-21,66,-145,-125,-74,50,170,290,65,171,717,-91,-99,25
+D26135_at,-303,-165,-294,-244,-141,-174,-329,-262,-331,-140,-249,-264,-141,-165,-226,-262,-89,-175,-187,-207,-148,-283,-387,-233,-238,-197,-281,-115,-216,-114,-259,-256,-267,-175,-200,-270,-328,-360
+D26308_at,825,660,1145,824,811,456,1159,1380,955,721,373,776,813,550,339,742,714,718,1179,1290,213,580,587,742,1217,538,1012,1164,2664,1637,7615,8703,2510,2958,1496,971,1013,2794
+D26350_at,-116,-59,-133,-103,1,24,-63,-94,-24,-70,-35,-38,-74,-80,-58,-30,-22,-58,-39,-8,-39,-112,-49,-6,14,-80,-153,-34,-36,-76,38,-91,-145,-41,-39,-134,-51,-101
+D26361_at,-505,108,205,226,204,152,157,242,150,129,247,63,281,119,189,93,255,230,77,210,92,146,153,153,98,144,203,229,113,324,152,127,128,175,155,117,111,61
+D26362_at,924,726,886,595,682,821,386,1100,725,390,555,502,804,1031,939,499,962,399,381,1623,396,914,549,862,833,1058,430,758,699,745,433,648,554,519,778,534,921,625
+D26443_at,54,-51,20,-29,34,16,-33,53,53,-30,-8,10,-10,8,2,-18,52,-27,-28,-31,3,-27,-5,-39,56,29,-73,5,36,-23,52,-35,-18,-13,-41,-11,-84,40
+D26528_at,175,142,141,106,62,154,99,226,169,101,74,77,74,132,105,87,190,47,102,227,56,99,163,135,150,153,81,206,74,159,136,292,114,61,95,87,106,149
+D26561_cds1_at,-68,29,-15,-8,8,-1,6,38,33,62,9,-10,-31,2,-41,9,66,24,40,1,13,18,58,-28,10,8,23,2,21,21,-29,80,-35,-19,18,-3,49,25
+D26561_cds2_at,-49,-17,79,-47,-8,-103,-58,71,43,86,43,-35,48,107,-15,-1,105,55,6,-16,302,41,32,145,-36,111,-204,173,175,5,-23,101,136,37,2,-102,38,54
+D26561_cds3_at,-32,13,13,-7,-51,-71,15,77,35,-15,3,-7,-26,12,-15,-67,143,35,-14,-15,96,-73,-72,59,-28,32,6,-7,-19,-13,62,13,-14,15,-11,-1,11,-59
+D26579_at,233,486,234,62,212,135,139,232,349,193,159,456,533,374,452,188,121,233,129,393,529,311,245,106,275,383,337,1136,317,1159,1478,333,872,327,2474,308,354,589
+D26598_at,1226,2185,2636,2217,2273,1940,1483,1710,3019,2021,2282,1457,2670,1543,3037,2572,2263,1404,2421,4399,2090,1313,1459,1806,1374,2262,1924,1583,1103,2053,1751,1229,1215,1599,2053,2196,1348,1262
+D26599_at,1703,2474,4609,2396,2610,3255,1969,1812,4808,2385,3764,1740,1416,2555,2702,1561,3059,1555,1233,3004,1684,1115,2196,1977,1128,1705,1735,1638,1320,2543,1602,797,2447,1367,1993,3139,1293,1404
+D26600_at,1647,2361,2667,2162,2867,1484,1586,1368,3509,1239,2893,1406,1421,2277,3015,1484,1512,1845,1074,3505,1059,1305,1367,1466,1475,1446,1725,1242,827,1848,1656,1031,1937,1346,1783,1811,1763,964
+D28114_at,425,271,513,468,290,314,460,379,489,234,345,250,206,251,251,263,395,282,234,239,221,449,108,330,287,297,658,379,315,403,299,365,448,101,313,412,514,609
+D28118_at,225,490,390,387,347,218,411,235,379,206,384,188,569,412,796,212,394,165,194,1061,2102,672,218,572,178,390,278,512,278,295,672,287,203,466,547,190,407,511
+D28124_at,1169,1078,1337,1258,702,1017,959,1034,1151,555,711,773,653,710,689,808,1151,640,725,941,387,1008,729,511,789,472,1314,457,622,1123,1214,856,1400,348,1131,1025,981,1641
+D28137_at,538,572,830,768,1610,232,699,610,605,442,213,205,1030,386,1127,459,990,490,710,3732,87,125,518,817,1161,1054,327,804,807,1451,871,166,781,725,1580,1574,798,887
+D28364_at,122,149,217,224,751,174,154,80,498,148,102,139,109,74,212,89,168,130,199,101,37,51,132,192,139,114,275,115,64,577,99,39,98,22,718,113,178,338
+D28383_at,263,469,604,192,654,131,243,95,534,192,397,119,165,316,366,417,243,154,114,636,26,15,186,383,100,34,56,119,43,220,210,96,291,270,520,319,132,249
+D28416_at,2335,1967,3338,2233,2092,2076,2325,1581,3002,1381,1989,1250,1556,1278,1891,1453,2223,927,1051,2844,850,1313,1347,2226,1146,841,1707,1672,1380,1172,1604,877,2092,1398,1566,2269,1593,2205
+D28423_at,1640,2224,3525,1565,3979,1900,1535,1048,4215,2177,1586,1488,1728,1253,2968,1467,1625,945,1302,3600,-41,1109,930,2215,1098,811,829,750,348,1526,1543,1157,2034,1766,1828,1322,840,1508
+D28476_at,815,906,1007,759,1117,403,850,1049,988,385,569,350,872,736,803,718,1200,770,705,2881,612,795,362,799,414,563,383,942,372,825,1149,203,650,383,848,417,632,945
+D28483_at,361,387,434,196,161,163,265,340,355,157,324,176,133,140,88,198,175,172,86,304,179,133,134,389,189,205,497,306,161,261,389,62,262,102,356,292,187,419
+D28532_at,352,102,240,112,127,177,63,161,36,62,185,113,121,233,145,150,97,114,-12,104,148,235,102,193,153,153,228,259,315,182,205,179,175,-5,230,105,183,184
+D28588_at,427,349,563,298,352,222,483,296,506,303,375,68,610,370,342,395,324,229,277,648,206,248,132,611,155,322,530,436,365,438,464,419,330,243,189,210,269,497
+D28589_at,481,-192,443,516,1108,277,216,-22,1157,200,643,455,648,478,544,264,-106,24,152,1168,86,-70,336,837,77,102,-183,240,278,-38,77,-81,482,11,-31,417,216,-402
+D28915_at,491,821,1098,332,292,305,475,412,615,410,437,212,399,334,237,476,392,249,282,2654,352,204,398,467,1020,338,384,461,557,648,1345,1319,500,386,388,409,505,2490
+D29012_at,1944,1598,2837,2300,1766,2220,2349,2064,2472,1555,1590,1708,1775,1576,1657,1453,893,1024,1369,2461,980,1311,1759,1584,1240,1590,1511,1178,1356,1649,2193,1849,1674,1373,1562,2083,1731,1580
+D29013_at,566,524,682,559,342,348,614,1107,707,473,447,245,693,401,422,539,241,475,345,979,473,323,368,729,351,275,567,1067,829,462,404,744,1115,266,385,532,563,625
+D29641_at,253,112,237,154,314,140,174,208,212,35,184,71,216,309,287,220,439,138,133,744,152,-2,9,514,88,24,190,129,127,58,119,160,191,142,57,129,118,126
+D29642_at,438,658,269,807,823,158,467,250,431,-38,174,145,334,529,1346,819,1359,522,155,959,127,-13,-28,1060,220,279,-6,282,60,303,520,108,144,179,289,264,691,79
+D29643_at,633,998,895,928,1665,762,887,461,1980,737,1292,773,1286,1108,1389,1476,2772,926,768,2723,-54,375,524,1131,708,662,669,1413,625,2643,1581,881,1567,1574,3665,2766,1878,932
+D29677_at,101,479,145,169,340,227,62,110,49,-91,427,14,509,899,514,14,308,-48,171,911,433,-28,83,601,157,163,-294,169,64,232,141,58,-38,107,150,71,404,-94
+D29810_at,-19,-37,46,57,-14,62,57,100,17,76,85,44,60,83,-27,72,3,27,-36,-17,66,43,58,100,25,87,162,13,40,79,-2,-14,9,30,18,17,-11,62
+D29833_at,-53,44,88,-50,23,-81,-78,-20,44,73,20,-12,8,33,1,-196,-33,19,6,20,-43,-32,-51,-32,39,1,109,40,-28,65,-10,28,44,34,53,-9,17,-18
+D29954_at,1199,1002,1758,1398,855,1225,1193,2143,1366,969,918,925,1136,989,945,1282,2139,1017,1088,1374,779,1350,1157,1025,938,782,1851,1442,1274,1593,1431,1756,1238,737,1219,1321,906,1630
+D29956_at,155,183,86,179,142,144,139,308,84,78,93,110,100,188,147,354,374,86,120,398,188,122,83,207,124,131,87,128,86,195,180,218,66,49,99,64,52,186
+D29958_at,-215,18,-276,-125,69,-12,-199,-461,7,-123,26,-109,38,201,51,-104,-375,-1,-137,22,-23,-200,-134,0,-83,-95,-295,-337,-197,-160,-339,-175,-236,118,-326,-194,-393,-548
+D29963_at,967,1162,1456,1170,863,976,1014,1439,1201,734,965,682,884,956,795,1061,1145,758,737,1234,1153,982,704,1148,981,1266,1254,1323,1195,2519,1231,897,1298,860,2439,1021,1475,1763
+D30036_at,512,256,744,541,374,360,416,518,559,271,399,153,459,254,321,336,472,314,248,207,31,598,450,289,265,226,583,259,310,927,499,657,545,185,616,366,599,801
+D30037_at,181,91,167,144,306,33,152,116,57,36,144,76,214,136,303,80,204,79,94,192,-21,18,94,154,28,83,100,-30,-24,112,27,52,124,54,34,-34,97,78
+D30655_at,3025,6944,3739,3762,5734,2825,4392,2115,4837,4608,1799,2003,5290,3831,4018,3965,6768,2415,3437,12466,7738,3355,2447,5139,5412,2510,1154,4565,2142,3033,2444,2018,3499,1587,4474,1581,2308,2389
+D30742_at,236,413,604,658,16,560,530,266,741,61,511,143,141,415,233,102,117,347,73,-61,257,292,501,326,153,192,424,74,447,283,205,31,150,37,110,434,96,547
+D30755_at,295,437,17,46,577,-1,149,-68,371,22,540,93,361,464,497,59,-55,1052,406,944,414,99,-37,560,9,860,-236,262,-21,1389,856,1,272,291,1262,117,-206,1148
+D30756_at,49,197,189,136,125,120,1,76,299,160,87,63,87,292,83,135,33,76,69,412,109,94,176,135,49,108,-15,55,144,160,139,143,64,61,79,119,136,159
+D30758_at,1676,3390,3503,1607,1118,2493,1283,1118,3214,1700,1523,984,1610,2958,938,1447,1853,1704,951,1568,778,822,2378,1134,1170,1431,1159,2457,1959,1987,747,682,1462,872,1126,2163,1754,1595
+D31716_at,188,196,206,180,153,90,216,310,150,178,67,132,727,122,93,106,53,55,905,210,307,138,108,218,95,131,215,117,86,493,264,211,717,62,222,65,135,399
+D31762_at,166,-1,37,151,121,19,208,328,100,64,127,-169,350,110,73,182,92,250,160,117,183,401,41,59,-109,248,192,86,288,263,12,-11,124,10,330,120,35,154
+D31763_at,179,-32,66,28,61,24,-57,-34,-74,-62,34,0,228,185,75,121,112,7,-16,340,312,100,72,90,89,45,-78,-14,76,38,-22,-18,-79,3,-45,-61,20,35
+D31764_at,-719,-1723,-1808,-722,513,-1194,-1327,-1761,-572,-1126,-985,-1010,379,-843,491,366,-732,-157,327,1663,-252,-1561,-860,990,-579,661,-2655,-1306,-1108,-1849,-1109,-1319,-1452,-222,-1663,-1561,-651,-2898
+D31765_at,709,687,1337,974,567,725,994,994,944,740,646,646,393,549,505,925,510,440,635,906,730,736,892,581,636,480,1334,535,538,582,882,812,536,350,796,905,966,1374
+D31766_at,654,675,857,565,334,473,505,544,766,708,289,132,468,431,238,451,616,412,356,925,336,470,332,466,206,473,413,462,370,652,246,480,644,241,370,517,487,780
+D31767_at,3186,3686,4189,2505,3069,1779,2762,2697,4245,1867,4202,1951,3975,3032,3275,2821,2546,1411,2639,7299,7439,3566,2443,4330,1691,3037,1977,3150,1599,5819,6335,3442,2859,3948,4953,2855,4404,4259
+D31784_at,139,71,128,78,59,80,102,76,63,60,77,51,84,49,12,73,41,100,10,44,21,79,115,91,64,77,107,70,117,86,64,49,105,66,39,87,130,129
+D31797_at,508,318,1090,344,188,250,359,514,437,425,197,179,320,497,215,383,188,274,164,405,179,292,305,350,220,328,481,378,214,481,314,303,323,133,213,354,424,508
+D31815_at,-111,-59,-77,-21,13,44,-117,80,-40,-54,-69,20,-83,-123,20,-16,25,-109,-36,-7,-4,-47,163,77,-9,-83,-3,-52,-81,-3,20,-9,-126,-41,-36,197,3,-64
+D31846_at,2060,1604,2030,2386,890,2133,2760,2403,2235,1599,1644,1438,1098,1640,1307,1948,2450,1119,1222,1964,954,2267,1991,1097,1570,1117,2057,2587,2147,2273,2013,1799,2422,1169,1556,2566,2414,2695
+D31883_at,444,1085,1635,304,681,1194,120,223,4168,769,1025,834,900,1004,987,1934,802,218,1178,859,874,804,1284,654,1279,921,-9,490,274,41,515,707,956,619,175,299,3281,4
+D31884_at,716,1939,780,653,484,736,912,667,1265,800,1213,889,663,603,314,596,864,458,745,891,875,748,623,610,1101,739,960,836,675,1323,1174,1552,1566,783,1338,1153,1067,1852
+D31885_at,569,663,599,1243,1515,295,646,454,1065,888,717,254,2122,698,1479,854,1670,1132,724,2920,1399,591,438,728,494,654,560,676,346,2089,1676,1119,811,1509,1011,655,882,716
+D31886_at,-76,-219,-323,-69,-15,-90,-273,-88,-160,-275,-17,-176,431,-135,71,26,-36,-140,-59,229,-32,-137,-182,-155,-168,-93,-283,-339,-209,-185,-271,-236,-160,-41,-211,-287,-219,-389
+D31887_at,151,148,115,218,238,199,270,194,283,108,38,129,231,213,102,81,309,233,45,213,338,311,102,239,50,158,272,-63,264,25,190,234,113,-3,178,32,-52,26
+D31888_at,239,412,218,269,307,170,204,289,278,60,381,56,832,196,531,530,635,79,212,834,774,283,144,479,101,97,248,256,105,343,319,487,269,360,483,138,99,521
+D31890_at,653,2753,1408,1786,2318,1669,964,1782,2330,1558,2400,1245,1236,2506,2225,1587,2326,1208,856,3789,1391,1114,1162,2339,1051,1571,1182,1642,1021,1493,1298,1119,1464,1081,1820,2033,1033,948
+D31891_at,874,551,986,1333,991,613,1120,1212,846,462,487,339,822,1252,1199,801,1638,513,433,1752,362,513,414,1383,607,563,877,854,567,597,536,298,521,191,446,537,587,680
+D31897_at,-87,316,-335,355,46,35,-62,232,116,258,-6,298,165,148,134,152,-149,-236,247,315,63,-108,-89,40,204,-48,-339,-128,211,92,279,291,359,167,273,-81,368,116
+D32001_at,1031,787,1343,669,591,949,761,587,684,830,410,396,698,821,410,458,1348,714,457,1014,149,859,657,728,413,696,1561,1114,512,1090,885,702,789,307,956,1068,1357,1210
+D32050_at,1530,536,1481,1431,1479,723,1063,974,1827,868,501,339,1337,885,1573,770,1765,1679,1055,1896,793,351,550,1362,880,1120,596,501,836,640,348,533,1028,376,553,296,554,-16
+D32202_at,331,86,509,361,239,213,247,215,420,36,175,27,211,209,95,193,237,242,130,296,97,367,203,196,156,144,403,231,286,186,281,335,385,18,17,172,130,266
+D37931_at,233,190,339,277,231,126,220,256,293,113,133,90,148,243,147,220,446,212,129,174,47,286,159,253,54,204,363,268,266,257,178,194,320,58,172,177,235,198
+D37965_at,-34,4,28,109,-17,-33,23,-8,-96,4,-8,18,-88,-12,-9,43,-26,-1,12,8,-31,57,-18,-64,20,20,84,28,-28,45,28,50,7,-43,22,-37,27,-15
+D38037_at,-109,337,-9,1,130,234,544,287,-110,21,175,-165,-32,171,166,101,-33,-111,-9,323,43,425,269,-178,-240,-178,345,4,-103,818,353,-67,-125,187,303,349,-31,131
+D38047_at,2111,2956,4463,2651,2908,2429,2488,1629,4301,2103,2840,2062,1801,2220,2463,1744,1887,1803,1305,3404,797,1677,1844,2465,1538,1436,1555,1733,1334,2410,3704,2002,1989,1475,2982,2877,1565,2160
+D38048_at,1053,1595,1606,1105,1523,901,900,578,2142,1483,1952,891,1351,1034,1309,1103,755,537,810,3055,2056,889,780,1115,642,760,744,825,781,657,1285,639,673,856,907,1072,388,598
+D38076_at,1279,1498,2355,1275,1735,1324,1356,1136,2683,2054,1006,1345,1148,1331,1798,834,833,712,977,2180,639,653,930,1410,976,604,956,206,541,1290,1786,815,941,506,931,1670,718,801
+D38128_at,36,-952,-762,-512,-897,-270,-1576,-1187,-895,-689,-975,-1115,-496,-1000,-267,-692,-452,70,-545,-1794,-492,-1568,-75,-342,-636,-419,-1034,-1190,-877,-1587,-2583,-1633,-1605,-1002,-1975,-1190,-1203,-2318
+D38145_at,346,370,603,400,238,270,408,403,382,421,368,241,267,309,108,353,312,319,231,367,289,402,330,370,275,278,553,226,310,431,385,328,390,107,285,198,330,683
+D38293_at,50,153,193,105,47,-170,36,-136,28,-3,58,-123,410,-70,38,133,-8,20,73,264,213,52,-49,149,59,256,-111,89,38,15,-99,-97,-26,-54,87,-78,-90,-392
+D38305_at,16,385,-79,-160,230,83,-117,26,161,51,56,610,50,-185,193,303,51,2,29,311,662,-81,34,513,402,802,175,207,-43,190,-56,235,120,126,449,-196,64,-23
+D38449_at,-73,-15,-180,24,63,-32,-38,13,-67,-14,-5,-61,14,-49,-54,-113,-85,-5,32,12,21,290,-100,55,3,74,-90,-167,38,-77,-158,-41,-28,1,-151,-27,-115,43
+D38462_at,-43,-26,38,-14,-32,-81,-55,-56,-12,-31,-18,-33,-22,-56,0,-43,-56,-26,-30,-35,-77,-90,-91,-42,-39,39,-54,-94,16,-67,-97,1,-27,-13,-55,-19,-29,-43
+D38491_at,75,174,258,140,192,80,67,271,273,120,124,43,122,193,151,157,130,83,68,537,59,133,79,194,77,134,223,206,144,137,112,182,165,153,117,189,184,162
+D38500_at,-261,-277,-230,-56,-321,-165,-376,-394,-130,-169,-244,-166,-176,-214,-114,-172,-514,-114,-129,-126,-67,-311,-43,-275,-97,-186,-230,-143,-79,-362,-397,13,-182,-277,-30,-49,-278,-206
+D38503_at,-9,-32,34,11,-16,-55,-58,-37,-5,44,12,5,2,17,17,52,42,-1,38,56,-29,43,0,-19,-44,55,75,-21,2,5,97,-28,-11,-29,28,5,48,59
+D38521_at,280,631,339,357,498,218,253,310,428,202,650,224,221,342,495,332,566,249,250,819,423,419,239,351,253,165,381,736,264,574,841,1666,741,684,458,379,453,592
+D38522_at,13,5,83,102,99,17,-6,65,33,21,6,-18,76,76,73,-43,-2,91,119,52,163,435,-13,28,104,50,86,-11,-28,-71,-18,-16,-25,-2,-25,-3,115,-26
+D38524_at,296,839,304,459,470,289,270,515,469,123,394,102,727,223,282,278,1332,83,188,921,570,232,210,867,238,183,140,131,290,123,157,180,136,37,219,109,96,180
+D38535_at,758,846,718,434,446,787,473,1266,970,577,503,431,329,744,384,710,691,872,465,726,603,821,482,847,589,708,1286,1241,896,739,961,1428,1137,143,469,613,353,1591
+D38548_at,824,459,467,666,1116,540,799,284,1123,885,872,1000,987,1591,729,1797,881,380,1003,868,146,1188,1157,575,996,844,683,589,579,485,560,810,407,194,303,406,353,458
+D38549_at,696,262,254,670,453,131,391,857,331,123,168,411,536,122,444,1330,465,368,317,971,4716,1224,264,678,175,394,1611,809,444,293,228,12,333,219,392,949,336,396
+D38550_at,287,555,498,439,540,184,421,370,430,269,542,219,1240,629,525,371,1800,260,480,815,533,287,340,585,248,551,447,703,466,438,425,216,432,387,558,456,462,527
+D38551_at,516,958,1017,688,856,510,527,395,1488,873,1699,183,1334,861,665,518,1718,551,423,2163,559,406,702,927,269,375,267,423,262,592,655,288,559,423,445,383,660,610
+D38552_at,170,102,180,328,257,133,184,149,81,152,305,103,359,370,479,272,413,140,327,889,735,272,138,149,128,97,109,261,163,134,144,163,52,106,113,52,103,30
+D38553_at,335,112,246,285,256,247,226,-19,378,235,376,156,382,52,249,111,215,349,207,52,186,185,402,194,70,155,150,125,120,300,270,173,304,129,115,107,193,162
+D38555_at,338,413,-157,387,504,288,146,74,253,201,607,-1,520,481,510,310,390,584,138,916,-143,41,165,455,106,478,-347,-18,50,287,268,561,-125,205,162,112,32,-131
+D38583_at,-105,337,-18,262,666,151,55,44,247,89,-42,34,-121,561,137,-125,150,11,81,-72,27,-62,39,277,-122,42,-112,-6,-48,603,356,59,17,-66,2194,168,332,579
+D38751_at,-509,-284,-169,-514,-439,30,-262,-650,-223,-109,55,-375,-238,-311,-174,-300,-398,-313,-179,-498,-261,-309,7,-320,-371,-281,-715,-538,-1058,-420,-319,-435,-433,-186,-650,-395,-581,-676
+D42038_at,-190,-112,-44,-110,-66,-220,-191,-194,-113,-24,-95,-63,5,-79,-125,0,13,-23,-67,-4,11,-68,-62,-84,-19,-32,-239,-99,-149,-243,39,-90,-199,-61,-6,-36,-27,-182
+D42039_at,250,-240,-266,-27,-52,33,55,-245,-143,-198,102,15,58,-111,-188,167,-83,-135,-114,-248,-194,132,66,144,-179,141,283,-380,-242,-395,-225,-207,-239,-245,-43,20,-78,-542
+D42041_at,824,536,986,789,1123,592,972,674,1356,609,684,517,828,526,590,641,1535,167,815,2409,309,440,492,1411,390,699,772,1174,1098,1308,1007,496,1041,468,1510,991,647,1046
+D42043_at,2170,2558,1286,1909,1718,686,1831,1057,1239,855,787,1554,2608,1075,1291,1969,1698,4297,2638,2985,4587,2785,885,2362,1411,2099,1242,932,692,1008,1150,1054,1242,646,981,1276,1464,1873
+D42044_at,-118,-63,77,-57,7,-168,23,-103,-74,-137,-94,-126,43,-107,7,-48,175,-22,21,4,-146,-43,7,33,-31,-57,-208,-76,-170,28,-93,-95,59,-54,-62,-52,0,-146
+D42045_at,-50,3,52,-34,-18,-126,-10,-74,24,-61,-8,1,-38,15,-53,-44,-42,-30,-80,-69,-41,51,11,-18,6,38,-184,-3,2,-69,-32,60,-4,21,-14,31,-22,41
+D42046_at,719,501,900,624,363,1004,925,815,778,365,548,448,442,460,297,457,537,390,421,417,414,618,613,565,434,380,804,661,769,669,661,643,611,239,666,612,492,890
+D42047_at,330,210,320,213,291,85,354,277,246,160,122,152,333,259,218,330,320,127,228,449,194,190,226,303,113,223,215,314,192,287,194,166,213,-9,214,222,168,155
+D42053_at,380,642,351,406,248,560,680,506,805,79,618,107,264,149,251,-31,518,2,-321,897,473,249,501,618,-283,58,-26,304,331,373,-64,-86,45,-34,224,119,244,-209
+D42054_at,192,16,172,207,247,190,304,127,347,101,185,77,414,85,338,201,463,401,230,1286,929,133,176,408,65,160,142,78,310,-33,77,171,155,241,136,104,69,199
+D42055_at,9,27,114,28,19,-48,25,-1,39,78,32,11,103,21,54,18,84,-15,-48,131,39,5,32,116,25,41,45,18,2,-25,-12,-27,97,-13,56,20,27,69
+D42063_at,104,227,166,6,192,44,120,92,199,143,373,34,258,100,91,45,180,19,121,527,328,92,72,209,48,107,93,139,84,117,142,166,207,127,193,70,115,204
+D42072_at,-18,-36,-79,-7,28,12,-30,-5,-28,14,-17,28,-1,31,-11,-47,85,-64,38,-42,-74,-27,-32,43,-23,31,34,-67,14,-7,27,33,-19,-10,-30,31,22,-27
+D42073_at,-147,-34,150,-23,110,88,42,-149,552,70,58,51,129,93,37,291,200,33,76,382,206,-87,85,77,8,1,-107,45,-4,136,-51,54,-84,5,207,150,-50,72
+D42084_at,330,837,473,530,687,200,257,193,481,373,575,117,962,816,705,358,1657,442,304,1418,822,154,429,817,253,338,496,535,127,250,216,474,364,229,329,272,406,207
+D42085_at,289,1028,1105,969,664,704,934,904,815,385,572,125,599,418,579,646,1104,508,736,1650,734,589,522,553,520,651,1035,1008,788,507,1127,1316,484,535,692,613,761,1105
+D42087_at,237,345,109,118,349,26,204,95,243,113,408,140,331,186,258,169,580,217,132,794,528,117,121,238,117,58,167,215,45,51,329,560,177,207,441,41,135,282
+D42108_at,-2,29,179,83,73,170,35,73,119,62,154,60,29,47,44,344,197,96,94,7,17,92,89,-44,20,76,59,48,38,20,146,195,64,-3,33,28,62,60
+D42123_at,1264,936,924,948,1364,974,944,1233,1173,940,680,717,881,850,705,1017,783,932,617,1186,455,1112,742,1302,959,1194,871,950,932,1417,696,981,1128,454,1507,869,703,1270
+D42138_at,213,236,474,213,128,88,137,359,135,170,155,127,60,229,143,178,227,133,130,229,469,163,203,205,209,120,359,379,331,300,154,301,95,18,141,95,69,232
+D43636_at,125,548,185,-17,163,83,-72,247,267,112,159,112,484,705,256,238,1030,-11,397,2001,402,423,364,-3,92,397,29,68,24,293,145,72,967,270,218,44,353,257
+D43638_at,168,142,198,106,138,120,95,157,70,91,119,79,143,106,122,13,368,84,23,423,23,7,55,151,130,146,386,189,31,147,185,-11,251,22,107,14,184,305
+D43642_at,2637,1486,2570,2724,1998,1561,2512,1731,2012,1748,1302,990,2061,1821,1708,1503,3735,1410,1590,4352,709,1353,1234,1993,1609,1844,2721,2098,1772,2074,2028,2065,1816,1008,1493,1727,1999,3012
+D43767_at,511,131,257,236,128,99,248,109,223,152,177,172,123,215,121,113,247,1888,187,150,181,124,66,159,140,178,262,260,197,206,178,141,182,45,128,202,110,255
+D43768_at,-267,-104,-322,-47,-140,-56,-164,-133,-73,-135,-213,-96,-116,5,-58,-174,-205,-198,-95,-101,-71,-119,45,-214,-101,-67,-156,-218,-399,-208,-154,-122,-97,-97,-107,-94,-145,-254
+D43772_at,136,-634,112,-73,245,-23,-117,137,109,124,56,107,119,80,101,94,-20,64,115,186,21,142,191,326,82,211,-37,329,81,-26,-106,130,34,78,-9,-75,168,-452
+D43947_at,60,131,59,301,815,81,241,13,278,-78,138,140,428,180,526,109,360,112,10,1017,-163,-99,-11,402,-20,126,-103,202,-24,250,-8,35,-55,82,-17,408,225,-312
+D43948_at,318,465,562,546,778,380,277,134,699,169,605,146,808,427,541,314,448,458,375,903,336,257,336,479,184,157,527,229,238,347,172,232,238,154,116,190,112,316
+D43949_at,879,588,1439,896,558,1013,860,884,1152,733,774,465,955,807,502,775,610,806,697,1339,575,626,761,801,654,367,751,766,947,828,998,885,788,282,177,868,569,1153
+D43950_at,719,247,936,932,1708,711,922,293,1333,730,532,260,796,1084,1109,791,986,376,1013,2052,991,-1,419,916,174,748,566,539,295,534,222,158,224,186,500,419,70,-35
+D43951_at,632,300,606,361,674,220,620,512,816,333,994,206,1043,535,524,675,871,452,576,2410,1251,665,241,699,218,511,488,449,286,540,354,659,454,246,431,223,147,462
+D44466_at,179,-45,455,39,564,202,21,-40,720,71,457,-64,650,356,334,313,222,186,191,918,204,184,144,290,-9,265,62,69,-67,255,244,296,33,131,145,-85,-67,-2
+D45248_at,2148,1837,3259,1030,2755,1611,1398,503,2044,2356,935,1185,2913,2146,3404,2241,1534,1276,2314,4371,1712,60,1082,2379,1634,3159,1314,1291,1175,2098,662,195,1065,570,2094,1663,489,478
+D45370_at,-193,171,-476,74,78,149,614,217,156,304,319,99,405,128,86,190,339,112,193,413,-104,289,457,-131,349,-105,586,-50,-324,-238,421,232,-391,221,219,151,405,-144
+D45371_at,591,521,680,482,323,385,591,590,605,576,360,373,401,576,68,349,305,307,327,458,319,363,554,653,278,218,966,616,728,639,599,465,526,270,886,529,406,596
+D45399_at,68,77,130,13,80,142,11,-25,42,44,74,57,92,64,17,15,-68,55,49,103,69,20,-11,87,116,81,142,84,288,91,141,18,136,47,121,73,10,159
+D45906_at,-80,31,-610,-626,190,-302,-283,-361,307,-329,6,-87,-173,3,173,11,-245,-181,216,334,3,-81,-125,121,464,-8,-95,30,-257,397,178,372,301,187,-40,-570,-269,-464
+D49357_at,-33,-300,-20,-425,236,-494,-556,-401,201,149,144,160,-272,228,103,127,-155,78,-29,-962,-243,-198,-452,-455,89,-35,-1139,220,-240,413,-45,-79,-130,-165,-449,-324,-93,-66
+D49387_at,142,118,128,58,132,28,183,146,125,171,11,137,230,8,96,178,187,209,13,298,31,146,68,212,38,182,48,246,26,-95,31,62,145,99,124,274,148,66
+D49394_at,-60,-202,-131,-109,-20,-106,-8,-379,-32,-54,-92,-125,-91,-138,40,-57,-430,194,-27,53,58,77,-34,-191,-42,-63,114,-132,-86,-14,-177,-93,42,-59,-397,-99,-109,-215
+D49396_at,81,204,307,220,535,149,196,77,286,84,109,142,651,205,304,202,414,374,139,485,247,34,186,293,98,35,114,88,74,360,96,-81,171,121,325,313,-1,98
+D49400_at,1174,1120,1767,954,1730,1198,843,950,1481,1038,926,967,1000,1220,1620,839,1723,934,675,2207,884,1383,619,1113,1187,672,685,1093,723,1940,2205,1515,1537,1078,2367,1271,1684,1792
+D49410_at,531,507,599,558,624,305,530,650,361,295,300,656,1129,298,446,337,881,542,323,1125,704,889,233,351,519,1560,1373,731,370,1459,519,582,745,243,609,809,712,1207
+D49488_at,74,111,101,94,66,101,129,67,102,59,108,61,88,110,97,80,15,60,0,83,24,94,28,106,82,66,295,-8,40,-4,100,74,85,79,180,56,72,99
+D49489_at,1020,1007,742,1205,2504,396,1114,721,1425,792,818,622,1949,561,2385,1615,1568,1281,1128,3663,2959,959,448,2254,932,891,801,1217,663,1557,777,1008,742,813,2283,1393,330,551
+D49490_at,21,671,1195,695,407,665,828,151,799,-51,834,481,322,84,316,500,49,540,390,739,572,691,915,116,571,458,1067,231,274,832,791,904,277,444,-96,133,91,1290
+D49493_at,-204,16,12,-148,33,-5,-57,-239,174,33,5,-1,19,-33,55,-91,-57,-61,62,-17,-48,18,-32,0,-89,52,6,-30,74,-148,5,-209,-111,53,-97,-154,-27,-233
+D49677_at,-540,-509,-1319,-798,-186,-750,-1107,-1389,-745,-735,-773,-573,-321,-556,-432,-463,-1246,-509,-713,-404,-705,-583,-927,-790,-295,-381,-1336,-1061,-1046,-1121,-784,-543,-940,-388,-1189,-1188,-1022,-1208
+D49738_at,963,1676,1226,927,1899,1017,1660,491,2262,1362,1364,711,1372,1399,1912,813,1139,395,501,2497,787,559,1090,1842,573,1160,505,1357,954,1152,637,437,608,669,1030,961,1176,421
+D49742_at,-946,-298,-572,-425,-430,-323,-210,-409,-405,-274,-278,-208,-748,-338,-385,-250,-379,-534,-495,-578,-146,-409,-710,-742,-231,-924,-445,-456,-420,-433,-233,-444,-378,46,-315,-384,-410,-512
+D49817_at,-193,410,505,106,127,261,499,115,395,381,-66,524,73,172,533,259,-8,-83,375,-636,198,125,275,377,-350,-144,181,593,516,3120,1422,-12,1098,331,354,341,392,2153
+D49818_at,-509,394,-585,110,56,236,499,-433,592,338,-198,0,57,-278,549,170,358,15,-114,-122,-92,-184,205,1,254,-157,810,-406,-117,270,681,-120,-200,55,279,371,451,1074
+D49950_at,75,129,44,218,110,33,115,32,9,54,38,7,103,72,158,28,117,99,101,22,48,74,43,168,9,117,12,355,295,283,311,70,297,190,326,197,259,100
+D49958_at,88,95,141,44,67,60,107,26,115,25,167,56,84,43,46,67,71,26,38,68,141,52,66,180,121,126,112,81,125,29,87,24,91,45,110,40,87,86
+D50063_at,1291,1213,1521,1014,1191,1091,1112,748,1921,781,1544,651,1231,1203,1386,929,1353,847,853,1792,1105,635,636,1095,522,746,1035,887,757,721,772,682,912,550,435,774,588,1242
+D50310_at,4031,6862,5528,4058,3835,3819,3147,3151,8151,3072,6096,3052,5117,3989,4212,2207,4480,2680,2337,7101,3705,5147,3792,4282,2613,3218,2215,5948,4135,6840,7800,6545,6049,4098,7810,6927,5645,9122
+D50312_at,-243,-233,-319,-321,-132,-348,-243,-223,-289,-276,-262,-186,-143,-218,-151,-229,-194,-217,-159,-265,-101,-180,-117,-209,-172,-168,-325,-313,-230,-329,-78,-178,-257,-113,-112,-120,-175,-410
+D50370_at,149,0,236,22,106,120,65,94,139,76,66,-17,80,129,52,99,21,28,60,88,92,-10,106,121,44,43,131,33,74,117,51,81,51,-15,67,111,115,174
+D50402_at,-36,-79,-469,-358,-26,-186,-331,-362,-278,-404,-128,-35,-155,-195,-39,-50,-220,-187,-242,-174,-96,-218,-96,-9,-133,-38,-403,-573,-536,386,-249,-142,-439,-81,-199,-251,-259,-451
+D50487_at,-23,4,-62,-67,1,-110,171,202,12,-118,187,43,19,258,65,52,-52,-14,-58,190,22,17,136,-81,-35,-33,82,-281,-192,129,152,-33,-150,101,88,136,-17,-14
+D50495_at,-3,-87,271,-492,107,-341,-512,-632,0,202,16,-146,251,-68,124,121,3,319,-88,167,186,-73,-142,31,176,228,1461,39,-408,137,-652,-28,60,195,239,345,108,-322
+D50525_at,588,316,1352,469,693,542,603,437,622,334,352,224,931,313,731,454,224,300,380,1344,171,387,330,718,317,188,305,555,452,409,94,482,382,195,132,116,441,648
+D50532_at,128,-7,118,-21,83,272,47,-274,-99,-91,102,298,112,136,264,56,-114,-146,-106,-68,-92,-126,-79,-213,282,155,-43,-13,-139,-109,221,-170,-114,165,-108,-74,319,105
+D50582_at,-206,-115,-207,77,-79,-26,21,-82,-32,37,-67,-40,-38,-66,37,1,-32,-115,24,-27,-109,-75,51,-137,41,-38,106,-53,-238,-239,56,-33,-166,22,-131,-5,-11,10
+D50640_at,35,176,159,242,53,81,137,220,83,39,71,27,101,113,159,74,50,60,77,452,46,-26,98,156,23,82,59,46,88,31,65,76,96,129,66,113,33,78
+D50645_at,80,24,-50,-15,238,-26,-30,-199,46,-88,122,-38,186,88,95,-10,220,-29,-62,345,-32,-130,-119,208,65,-20,-6,-84,-223,56,-40,71,65,222,-61,-201,-22,30
+D50663_at,180,687,160,573,692,26,715,127,124,141,163,801,759,119,1089,327,798,355,760,1205,789,470,174,554,504,139,322,147,336,408,533,340,873,1072,269,78,637,801
+D50678_at,-61,-105,-276,-185,63,-163,-151,-403,-128,-93,-14,-31,-66,-3,-31,-85,-88,-153,-97,-169,-62,-190,-117,-36,-122,-137,-62,-209,-117,25,-59,-78,-227,19,1,-94,-202,-94
+D50683_at,139,396,-28,634,449,108,336,860,133,45,774,28,391,247,935,417,283,-10,100,3038,3346,612,93,840,9,120,560,91,-125,384,131,86,65,177,283,-134,37,42
+D50692_at,161,-28,6,188,464,-16,-10,-77,73,-37,-122,-43,286,357,537,214,990,353,99,396,108,-183,-112,370,51,198,206,141,428,246,-91,18,-13,178,138,328,-228,-384
+D50810_at,-38,-148,122,21,287,-42,-62,-43,-62,-65,-66,-122,38,-45,164,122,112,116,-32,222,-8,-13,-127,-181,106,94,-168,-37,-254,56,-69,-76,-72,57,-80,-61,-105,-121
+D50840_at,22,319,-28,228,153,307,-65,398,-49,336,46,350,636,132,303,428,204,1516,237,934,660,137,15,176,484,521,54,-115,76,564,980,217,88,451,477,-9,495,36
+D50857_at,69,146,337,191,115,220,248,533,253,106,121,139,123,196,187,437,451,181,68,660,123,240,265,315,180,162,269,312,254,401,63,174,270,110,257,405,375,158
+D50863_at,-6,-43,281,-150,-102,-216,-42,568,-39,1,-113,-192,376,201,-57,74,-2,406,-51,-16,366,-57,-203,681,-105,489,-104,-107,-153,560,-240,-258,-82,75,-160,-107,-87,55
+D50911_at,791,1012,748,851,959,755,986,1200,790,428,585,435,799,789,847,843,1285,530,274,2347,605,700,666,986,586,1089,697,714,706,736,576,842,636,364,689,799,889,1009
+D50912_at,299,256,414,362,348,382,504,452,517,279,418,303,551,334,593,338,475,251,276,678,138,265,448,508,393,600,165,327,242,433,222,147,295,57,247,370,346,122
+D50913_at,423,7,748,815,421,497,-354,184,900,223,225,313,878,661,157,792,306,533,556,1844,287,-664,-136,226,549,605,746,-16,-1320,143,1244,1291,157,427,359,-166,-264,62
+D50914_at,88,290,271,239,680,268,265,40,297,204,139,-21,540,396,404,134,498,34,302,916,-346,-262,132,269,263,355,-62,-31,158,-55,333,0,134,34,217,139,126,-159
+D50915_at,55,21,-10,2297,1509,76,1127,20,179,27,27,-14,1058,313,441,-59,242,281,22,82,43,-77,30,1830,120,31,6,961,353,206,124,0,2460,154,-37,595,4593,637
+D50916_at,233,30,7,94,463,108,226,10,172,-57,167,-84,260,433,340,94,391,226,0,1313,201,-24,-205,221,98,-47,-92,-126,-100,224,105,33,62,61,34,28,69,-31
+D50917_at,271,1151,319,197,355,263,404,467,472,299,411,116,297,322,456,307,843,226,295,1068,1099,411,723,466,196,273,109,474,238,769,648,382,811,519,613,706,471,196
+D50918_at,1048,1550,1521,369,554,841,561,403,1753,791,986,257,886,837,528,675,1416,368,956,1343,1064,249,412,554,401,382,422,503,870,-105,-81,-156,404,167,-59,184,660,372
+D50919_at,63,15,302,130,163,69,5,58,232,-12,4,-4,42,208,140,65,203,70,99,109,-63,-30,100,157,90,100,23,-61,79,73,104,-3,38,14,-57,105,46,30
+D50920_at,159,409,336,359,351,272,-1,121,434,231,447,186,621,305,321,136,622,144,307,1061,348,198,132,289,308,455,-292,167,180,430,389,482,242,201,-16,235,298,46
+D50922_at,269,146,317,88,336,-26,331,-41,325,103,174,-34,303,502,350,219,308,159,93,366,22,115,72,424,152,210,270,204,266,257,169,209,267,143,164,-17,224,293
+D50923_at,-234,217,-482,-196,17,-83,-100,-197,-204,-120,-115,-71,165,-115,-39,-581,-257,-143,67,48,-9,-104,-159,-103,-97,-155,-456,-234,-117,-185,-527,-442,-92,-215,-515,-864,-256,-555
+D50924_at,192,101,226,206,113,163,129,245,139,173,121,45,183,160,154,197,89,152,147,240,38,102,165,262,72,161,209,75,129,277,136,143,151,110,133,128,166,192
+D50925_at,202,236,455,297,238,232,162,481,280,253,170,258,258,301,225,200,175,541,219,104,0,180,216,241,243,416,386,162,33,470,229,404,370,69,341,192,181,158
+D50926_at,326,234,237,378,309,44,204,232,207,164,307,455,868,413,242,313,297,201,230,847,214,91,134,463,413,219,173,299,187,372,422,682,234,282,395,122,201,370
+D50927_at,244,555,309,278,371,216,152,139,282,144,252,130,787,299,269,324,290,416,369,773,650,109,129,454,118,170,89,123,271,101,106,187,148,273,100,151,410,122
+D50928_at,37,334,393,414,100,357,561,236,22,258,17,99,174,17,308,356,477,295,234,578,202,122,560,131,150,252,287,197,100,830,439,263,149,74,559,504,116,492
+D50930_at,512,666,1161,1025,785,577,1075,862,1132,580,554,273,1829,614,2064,460,213,288,936,1422,202,1653,433,1952,614,570,330,291,331,923,374,503,556,127,359,557,597,497
+D50931_at,-477,-88,-850,185,-96,-176,-199,-211,-153,-233,-161,-125,-297,33,88,-78,26,-391,0,258,352,-126,256,-137,55,-370,289,-111,-81,-903,207,280,-259,329,-66,-64,-339,-227
+D55638_at,-152,-197,-434,-139,-55,24,36,-340,-197,59,-119,53,-166,-92,7,-93,-317,-146,-47,-231,-227,-109,-197,-107,-128,-214,-411,-355,-62,-459,-279,-171,-57,42,-255,147,-161,-180
+D55640_at,793,525,848,817,255,709,833,710,372,568,276,4,452,584,387,729,678,482,465,525,122,278,51,467,289,549,927,957,286,298,96,409,432,-26,645,994,964,956
+D55654_at,1094,2133,2858,2107,3510,1742,1574,280,3828,1629,1983,870,1828,1909,2825,2268,3237,2502,1213,4867,2965,523,1662,2571,995,891,586,843,901,1462,849,788,1343,1266,1001,1531,872,133
+D55696_at,194,-921,254,112,125,202,112,79,111,-485,24,145,68,-55,233,-434,-1068,-27,-211,-315,242,168,22,2,-89,-243,-165,-749,96,-652,-958,-337,-956,269,-664,107,-792,-255
+D55716_at,1176,1107,3080,1592,1781,2741,1075,1122,3483,1539,1770,583,2037,1341,2760,717,1577,1144,783,2064,88,778,1742,1566,1120,1292,938,677,1493,1262,992,1108,1730,1292,604,1225,549,1099
+D56495_at,656,299,464,310,230,291,383,574,577,314,272,192,257,264,206,425,709,359,260,394,258,321,311,402,301,410,707,366,271,578,397,684,572,219,355,379,363,551
+D59253_at,7,32,2,261,342,206,72,-61,110,114,51,-30,115,111,326,178,143,112,63,191,62,66,77,118,60,-24,-145,69,-50,11,16,117,153,70,-92,124,69,12
+D61380_at,966,1401,2432,1973,3876,1637,803,718,3601,3453,2000,1595,2939,2898,3823,3764,4369,2966,2974,6806,2276,306,1331,2189,1560,2582,668,1873,1435,1605,1877,631,1598,1911,3734,3110,1691,141
+D61391_at,-75,-65,-371,-268,281,-222,-342,355,76,-74,-176,-171,611,53,238,6,-70,-102,459,771,94,-95,-197,15,-172,35,-372,3,7,-323,-472,-50,-179,-17,-332,-287,-264,109
+D63134_at,-417,-353,-614,-386,-282,-368,-492,-403,-486,-364,-312,-303,-307,-332,-420,-293,-693,-330,-246,-496,-338,-465,-381,-470,-360,-499,-760,-524,-586,-517,-451,-604,-433,-150,-465,-452,-485,-804
+D63135_at,178,234,363,179,33,-28,238,383,171,138,84,169,158,311,176,156,210,201,255,169,87,160,235,185,226,270,419,263,163,5,117,222,322,115,123,239,139,458
+D63160_at,427,25,546,347,226,215,693,485,555,184,70,221,246,299,166,326,288,155,104,167,-11,574,429,329,315,299,-18,424,541,218,413,381,632,78,308,235,418,680
+D63390_at,8,102,516,-82,68,124,33,194,127,106,107,21,-16,263,57,107,197,-28,49,164,78,108,146,-122,92,84,76,110,153,14,174,109,128,162,146,196,-43,145
+D63391_at,238,-622,443,-238,111,330,-186,-478,778,274,532,-33,205,-3,403,246,-35,5,-46,241,76,-321,305,401,-69,210,-291,-337,-288,-264,-531,-279,-497,-147,-568,66,-150,-925
+D63412_at,39,59,43,51,47,-32,30,74,-21,41,-14,-17,23,36,12,24,54,52,44,37,29,20,106,-11,51,40,172,57,132,20,-12,50,11,59,-19,10,78,136
+D63475_at,984,1709,1504,862,1990,739,1046,601,3278,1068,660,456,1451,1323,1513,1235,1669,490,851,4003,1977,137,590,1188,678,1168,-65,959,605,1517,1528,1135,931,1125,1858,1686,1078,633
+D63476_at,1396,1932,1365,718,916,830,861,1012,1153,579,1501,1044,899,518,819,1389,1204,518,970,5938,1029,1765,550,1111,549,883,965,589,555,682,818,882,686,524,619,537,636,1050
+D63477_at,240,109,208,297,309,56,280,85,175,111,98,38,459,198,380,265,265,99,219,306,268,134,81,373,-18,79,23,41,98,75,143,-29,27,33,14,187,64,126
+D63478_at,760,738,1480,954,942,643,452,1025,1225,510,1418,520,776,1045,940,859,691,619,846,1243,768,1038,634,1160,608,488,1125,886,771,977,1036,1286,1147,568,1120,340,991,1181
+D63480_at,164,151,144,252,224,83,287,170,271,77,38,57,336,306,151,273,335,96,110,555,277,-22,115,323,72,96,129,152,223,79,29,71,133,37,142,151,219,44
+D63481_at,931,515,1041,401,665,535,505,922,845,206,430,205,985,682,677,331,199,439,554,777,633,629,797,1050,674,612,373,485,543,1018,778,784,858,191,501,378,1036,429
+D63482_at,370,428,348,419,319,193,273,169,166,111,180,176,348,242,210,322,240,191,312,383,267,338,203,560,200,248,-4,143,137,150,-21,163,204,246,152,215,233,3
+D63483_at,114,110,83,71,87,19,80,118,109,9,41,15,307,38,30,99,72,77,72,250,157,116,5,94,86,82,75,157,-177,63,20,41,76,43,42,13,84,82
+D63484_at,-516,-548,-1329,-711,-399,-432,-920,-1030,-590,-833,-594,-646,-577,-666,-456,-451,-197,-347,-102,-517,-284,-614,-522,-655,-430,-347,-999,-573,-449,-982,-489,-725,-554,-494,-943,-381,-273,-650
+D63485_at,941,794,1308,727,546,743,1151,1359,1077,775,746,599,785,1090,395,847,585,736,629,841,650,717,623,715,608,811,951,1034,1154,1215,919,1188,1059,358,654,711,936,1335
+D63486_at,571,453,843,872,666,764,1246,952,886,131,440,208,595,708,801,389,2109,213,144,1173,323,244,636,765,388,388,1063,244,485,-58,241,428,355,147,162,593,238,463
+D63487_at,212,724,425,851,697,490,640,544,500,-31,179,372,473,864,492,736,418,130,679,228,269,95,625,355,552,613,384,135,16,390,985,426,469,658,-83,-95,747,557
+D63506_at,441,524,322,451,566,211,431,481,289,194,220,126,646,438,351,396,2335,250,287,1177,553,133,189,596,178,211,395,255,132,280,317,245,329,321,391,238,395,359
+D63813_at,127,71,253,128,74,64,184,43,177,117,89,35,89,124,1001,173,74,130,24,118,42,61,146,88,84,89,297,126,91,243,121,86,96,-25,181,168,213,182
+D63851_at,549,367,486,441,363,456,475,415,549,396,282,327,385,321,170,349,995,397,212,611,328,457,699,388,271,499,904,561,579,476,411,464,520,249,557,357,492,559
+D63874_at,4157,11557,12125,8484,9575,5315,6270,4566,10061,7194,7021,4036,12920,6555,11506,11089,13775,4845,8499,13830,16492,9604,5479,12848,5613,10573,4578,5817,5407,4490,3763,6604,6978,4206,4642,3998,2793,2823
+D63875_at,252,300,312,379,487,179,198,392,324,148,368,142,379,588,324,217,913,277,176,1239,421,99,201,522,122,197,223,215,185,229,204,271,271,238,233,171,96,214
+D63876_at,540,831,1374,781,466,761,662,1086,938,140,592,333,1028,767,975,612,2094,342,837,1911,1186,483,509,1033,304,571,840,647,682,862,509,1181,585,527,957,814,498,625
+D63877_at,748,480,1059,380,304,158,302,427,494,358,368,73,381,452,328,380,1022,402,313,559,78,619,322,510,389,443,680,488,834,434,330,350,677,213,456,320,518,695
+D63878_at,1027,1701,1764,1406,1401,1033,798,1187,2699,1019,602,556,1313,1754,1907,1183,3686,1794,1423,4621,1006,1281,404,1528,818,1260,633,979,1108,2577,983,726,1241,1066,1135,1413,2279,2274
+D63879_at,266,169,272,205,308,179,240,62,158,111,212,209,372,268,288,137,165,302,156,755,236,68,315,511,105,285,164,74,137,245,181,101,134,143,79,56,238,199
+D63880_at,556,476,498,1211,820,485,734,223,686,721,551,198,550,694,1287,475,883,1281,256,568,454,43,613,298,231,306,433,226,-4,410,185,118,279,277,136,321,283,151
+D63881_at,645,1000,961,629,1156,241,352,143,1136,357,1259,172,1231,904,735,264,1086,522,417,1633,1479,757,319,896,346,549,250,596,440,519,592,677,793,876,484,249,374,407
+D63998_at,290,251,685,262,204,360,250,89,177,149,686,93,92,434,137,79,123,119,2,185,159,179,214,270,118,78,-6,192,230,365,499,414,249,174,448,99,168,456
+D64109_at,156,234,-62,158,98,-92,-26,8,-1,-9,89,97,62,123,285,30,-158,100,-33,114,362,290,-72,234,221,1937,-9,248,-76,-92,36,-88,87,342,-52,-6,194,-52
+D64110_at,310,1359,1060,458,488,693,878,419,1137,1526,1766,423,80,475,465,270,718,627,123,967,2115,1352,1244,1084,138,119,300,1504,704,1413,1647,1153,1604,512,798,820,176,1217
+D64142_at,5152,16420,7840,5802,4690,7461,5713,3230,11441,15331,2499,6116,5451,1950,7612,4009,5493,1689,3219,13311,4391,15272,7426,6179,10032,7253,5454,10726,2205,18826,13481,19451,13765,6027,12386,7110,5820,11794
+D64154_at,686,1096,1050,981,574,967,1024,671,1052,801,852,656,397,598,906,909,1230,509,696,1028,371,609,606,919,534,486,718,1048,973,898,1110,618,609,424,714,935,832,909
+D64158_at,440,220,447,426,431,348,435,232,489,236,276,112,318,313,320,264,708,404,139,314,167,181,193,319,128,184,560,171,156,232,380,264,237,162,428,268,270,418
+D64159_at,27,70,-28,99,129,103,11,-31,-83,-65,80,0,8,108,192,-15,-55,-27,-27,97,143,-9,15,52,-62,26,-100,72,-93,34,33,68,-1,89,5,0,-9,-59
+D67029_at,140,416,123,182,339,76,193,199,223,41,429,149,410,92,302,140,369,498,688,342,241,295,-49,373,-16,134,57,78,88,267,345,248,985,158,229,37,122,310
+D70830_at,-675,-855,-1221,-626,-473,-638,-683,-1151,-692,-515,-496,-500,-509,-633,-510,-654,-656,-488,-593,-731,-518,-500,-501,-556,-582,-291,-1040,-557,-372,-1145,-1024,-743,-747,-348,-1026,-810,-785,-1229
+D76435_at,23,0,55,65,1,42,89,56,80,13,20,-7,28,89,10,132,41,41,-6,90,74,19,-85,-47,19,36,167,65,26,43,29,112,33,-3,81,9,44,106
+D76444_at,24,562,83,111,103,64,206,137,74,125,277,64,282,43,195,17,150,-19,147,305,483,197,150,202,210,60,-23,86,98,191,176,517,-5,173,129,40,213,259
+D78011_at,-131,-60,-253,14,-31,-122,-47,-37,-19,-153,-95,-97,-62,-74,-56,-11,-120,-61,-28,-89,-119,-13,-85,-85,31,-162,-51,-23,-72,-2,-52,8,12,-51,39,-58,-136,21
+D78012_at,2697,350,1218,590,125,631,1574,466,241,436,37,411,445,189,407,420,319,211,421,603,139,1748,379,476,254,537,1229,942,812,339,809,623,282,222,488,548,1569,643
+D78014_at,222,91,299,93,3,167,211,262,77,119,112,140,26,153,1,33,45,128,142,80,212,156,163,321,32,209,212,216,197,164,310,291,282,18,156,211,390,104
+D78129_at,105,322,794,277,371,289,297,646,930,472,449,145,451,451,216,373,828,964,51,500,202,380,393,348,337,274,481,147,254,521,394,329,280,202,572,421,593,839
+D78134_at,1559,4021,2049,1085,1344,2107,1512,1535,2507,1758,2093,1171,1675,1400,1564,1302,2818,522,1659,7392,3118,1677,1983,1674,2207,1980,544,1530,1387,2224,2479,2610,2431,3595,2716,3460,4519,1988
+D78151_at,1554,1479,1827,1470,2038,1607,1614,1589,2408,1068,1258,1090,1856,1486,1653,1899,1864,1308,1207,2228,1273,1468,1590,1619,1222,1530,1455,1647,1163,2264,2199,2441,1723,1611,2280,2152,1965,1492
+D78156_at,211,249,279,233,192,158,322,179,110,39,93,148,175,175,73,86,-70,55,40,231,72,197,146,226,96,89,-43,59,81,93,142,199,205,115,134,232,268,191
+D78261_at,-16,2,-25,-13,-10,3,80,64,9,53,18,-45,-11,71,33,10,71,28,-14,31,6,-11,-64,-25,-30,-9,123,-28,-14,-68,-3,-3,-22,6,-14,61,43,-9
+D78275_at,329,450,343,475,993,128,369,197,450,314,548,172,1279,566,904,695,692,283,323,1696,1274,269,222,651,269,200,140,360,98,255,225,488,213,387,217,170,165,203
+D78333_at,-8,-7,-6,66,16,49,18,55,52,15,16,11,-17,-5,14,-16,-53,-52,-38,76,137,39,30,-82,-10,-62,-23,-86,-52,1,38,39,-2,66,-29,9,10,6
+D78334_at,80,-16,109,86,-46,-33,119,-38,49,3,-44,-40,-15,-37,20,14,3,59,-1,-9,86,15,43,-9,23,89,-18,17,-9,16,49,-37,-283,59,6,30,-6,-7
+D78335_at,-133,8,910,378,260,225,332,133,228,91,218,-5,-142,-42,287,127,124,-35,151,68,-227,-64,39,272,-29,-92,-120,-17,-120,-2,-140,-54,54,109,53,52,-87,116
+D78361_at,9881,17544,13086,14466,13686,10375,12736,8118,14541,9909,5481,9020,12192,8270,15261,10835,16373,11519,9622,15842,6872,8747,5855,12299,10798,11200,2248,12607,9125,22286,15062,10941,8870,9018,16498,15374,15081,8790
+D78367_at,140,153,404,310,175,97,339,259,136,158,215,125,232,154,125,216,459,282,182,287,104,258,98,212,180,96,348,302,134,196,327,209,232,46,219,150,394,550
+D78514_at,-2,7,15,17,196,35,-42,-55,74,-83,132,-11,41,36,93,5,57,71,12,88,-36,120,-22,126,-59,-94,-164,-84,187,-9,-93,18,-51,43,-35,-95,-50,-162
+D78586_at,295,359,294,314,612,108,315,88,446,85,291,-25,400,344,385,27,924,-27,47,497,36,-52,-1,715,-20,297,286,358,343,213,-128,104,218,93,124,-108,373,180
+D78611_at,332,52,862,125,211,92,26,-64,2321,971,590,682,35,84,44,59,4628,39,56,1211,88,19,-51,135,370,88,129,513,1579,-23,69,218,968,273,93,2007,559,386
+D79205_at,25071,23095,21525,21279,23776,11926,15712,13118,21772,21632,20849,19699,27485,21720,17418,22417,25027,22807,22763,21305,33548,21028,9459,25322,19921,28168,24997,25152,26279,22090,19284,16835,21655,12864,23132,15086,16980,21470
+D79983_at,133,220,314,206,147,124,114,41,242,64,61,102,62,49,103,39,435,62,81,73,43,141,-22,35,32,15,-23,111,139,82,59,-20,132,119,82,107,53,-56
+D79985_at,-1450,-1684,-2317,-1377,-1014,-1408,-1503,-1500,-1797,-1521,-1200,-1118,-1016,-1223,-1116,-661,-1603,-928,-992,-1214,-237,-1386,-1326,-559,-1096,-789,-2897,-1385,-1546,-2181,-2433,-854,-1633,-1049,-2258,-1819,-1404,-2508
+D79986_at,1232,2236,1912,1093,1710,867,947,1034,2262,1317,3271,753,2163,1345,1425,1461,1996,488,1586,4088,2817,2314,1143,2044,850,641,952,1701,1043,1608,1907,1747,2242,1249,1365,1569,1106,1851
+D79987_at,-265,-366,-42,-31,-237,-238,-378,-682,-209,-9,23,-135,-87,-268,-82,-342,-245,-319,-372,-251,-352,-316,-528,-437,-279,-296,-561,-399,-822,-161,-252,-298,-142,-290,-445,-508,-327,-328
+D79988_at,401,150,85,144,256,352,8,-28,246,148,180,205,263,94,244,79,507,212,66,251,263,-19,20,117,168,68,-164,125,-163,106,-44,-99,164,5,86,-27,-45,-132
+D79989_at,14,105,181,26,86,165,-154,-95,135,25,141,-37,136,45,103,105,90,-7,81,123,49,-44,-7,134,58,22,-236,9,76,53,65,-88,75,45,16,-79,112,164
+D79990_at,733,264,-11,335,646,8,253,134,54,61,7,113,1041,402,865,967,320,328,325,834,1071,1115,53,830,152,905,353,161,161,911,458,206,409,175,475,197,382,585
+D79991_at,977,660,1360,786,738,730,858,884,1163,519,581,441,847,831,679,569,616,465,585,1073,632,787,672,960,539,654,837,880,945,864,845,1076,666,322,658,860,660,1043
+D79992_at,468,437,678,379,335,405,480,409,461,396,289,155,784,436,297,258,339,277,288,702,319,285,246,452,201,264,369,327,331,304,281,409,373,186,101,327,424,645
+D79993_at,474,158,469,434,463,14,455,355,350,293,385,340,668,425,421,358,755,365,605,1355,768,486,123,556,223,141,162,994,319,584,432,520,198,259,454,380,454,515
+D79994_at,135,161,236,350,261,96,1139,233,197,152,97,93,228,190,128,77,141,125,355,98,184,572,239,654,132,207,197,185,180,214,216,237,123,97,115,160,151,233
+D79995_at,212,37,358,106,112,65,398,349,331,112,260,-4,130,195,46,58,99,180,-4,142,204,235,170,228,158,161,408,218,74,292,212,306,97,34,100,99,284,365
+D79996_at,696,1197,210,721,1090,343,734,571,656,303,1260,431,1157,771,899,1001,2022,560,657,2841,1577,1037,467,1159,671,651,334,1184,437,959,1133,923,932,957,1742,725,820,901
+D79997_at,1,3,45,8,76,-23,-3,-109,147,43,58,27,384,-33,98,-27,4,247,-55,114,177,-175,79,128,-1,40,126,-46,-36,-43,-90,-60,14,35,58,0,-11,-54
+D79998_at,-541,-404,-111,-391,-48,-440,-236,-488,-97,-289,-307,-221,-161,-367,-236,-351,-252,-318,-337,-259,-176,-121,-423,-29,-209,-363,-633,-557,-401,-360,-640,-452,-330,-227,-264,-613,-516,-582
+D79999_at,1162,767,1301,1327,1078,867,1720,640,1226,497,505,445,910,1088,1064,1333,2143,589,707,2106,383,612,649,1045,664,626,865,1287,1211,1177,1068,945,519,531,780,1103,1212,1204
+D80001_at,109,33,90,135,225,-99,107,1,110,6,55,-44,907,220,403,167,176,148,206,613,286,56,3,160,-18,260,14,51,-69,49,-78,-37,34,-1,-25,2,18,-20
+D80002_at,1692,1536,2039,1842,1527,1531,2481,2191,975,1006,1645,1201,1627,1798,1618,1370,2747,1370,1274,2490,1243,1778,1307,2205,1165,1696,2210,1995,1526,2260,1673,2369,1859,688,1305,2581,1782,1845
+D80003_at,251,248,155,121,278,90,198,145,353,-14,387,33,311,122,255,174,152,57,119,808,272,96,96,301,67,136,70,93,72,70,26,-129,87,245,79,91,74,87
+D80004_at,318,807,498,552,591,501,292,92,621,265,176,185,354,713,238,303,1526,391,287,1042,500,508,554,824,188,508,389,670,704,615,313,398,740,336,389,362,261,258
+D80005_at,400,492,969,866,1178,638,621,487,1372,128,698,252,747,1124,1041,609,1948,241,582,2286,764,92,246,1105,299,465,230,454,382,796,227,72,92,287,614,504,503,170
+D80006_at,575,1169,545,716,1211,444,258,593,790,243,1112,296,1481,623,1366,644,1558,524,861,3117,1188,513,465,1058,397,461,230,437,401,304,256,203,268,438,394,19,640,461
+D80007_at,454,286,310,374,436,240,250,299,303,216,420,91,425,378,252,162,315,146,321,832,147,414,153,339,224,163,76,656,336,268,332,166,545,114,186,218,378,739
+D80008_at,234,225,247,223,285,163,129,37,380,225,172,119,612,215,310,146,576,277,187,350,187,88,131,208,133,151,308,177,151,113,110,91,217,59,111,112,185,262
+D80009_at,186,229,226,-67,504,-16,47,-182,46,142,382,-47,500,182,291,279,458,119,142,925,578,219,-3,413,62,340,-31,542,259,119,-177,18,155,87,-32,17,56,-79
+D80010_at,-5,308,157,125,165,-5,203,-16,50,-55,1,162,183,292,182,80,150,257,344,307,643,26,30,168,99,157,-62,107,72,-39,34,2,257,-43,-32,-17,123,33
+D80011_at,-230,-268,-352,-311,-125,-277,-154,-271,-299,-150,-260,-127,-105,-170,-93,-193,-201,-226,-147,-141,-181,-223,-262,-257,-203,-158,-287,-281,-286,-364,-281,-213,-251,-90,-119,-277,-392,-270
+D80012_at,497,698,750,387,1299,147,507,415,896,189,949,241,1090,794,1192,600,1783,650,662,1458,941,576,138,985,303,762,635,612,591,649,263,188,601,334,438,105,453,760
+D82060_at,60,62,90,108,77,60,63,110,101,25,99,14,95,83,23,56,-51,78,13,299,51,149,136,20,4,64,56,82,-74,59,-53,57,96,0,101,70,-21,64
+D82061_at,363,538,372,-285,297,339,295,274,420,462,296,239,703,512,233,253,677,242,268,545,723,213,163,307,291,280,189,112,375,328,435,282,454,175,311,435,189,1149
+D82070_at,395,299,675,479,202,85,594,607,730,236,418,547,343,530,232,353,169,372,391,93,371,372,514,412,385,138,463,572,601,584,645,436,654,181,370,617,273,945
+D82326_at,-144,8,171,290,181,186,-70,-86,37,-2,19,188,-14,1,61,45,-52,97,115,297,77,73,182,46,209,127,43,112,-113,17,412,144,-42,315,4,170,115,88
+D82343_at,-162,119,39,-73,-7,-48,-100,-46,-111,-86,-38,-27,-14,-181,-6,-65,-111,-86,-67,108,0,-78,-5,4,-30,25,-45,-108,-266,-75,-52,-99,-3,25,-61,-19,-16,-182
+D82344_at,132,49,192,140,118,140,-21,125,76,15,43,74,178,115,43,204,121,97,128,349,73,166,66,258,126,246,226,157,100,189,142,156,161,13,62,17,139,222
+D82345_at,19,96,1951,218,271,725,30,34,2026,905,774,73,1490,138,76,225,38,118,-11,384,1577,188,925,324,72,82,86,158,-31,195,50,171,225,57,251,221,77,326
+D82346_at,118,-21,94,37,66,-94,124,49,179,-89,-106,-21,123,-74,38,79,38,-8,71,140,113,214,28,-1,19,147,-170,160,55,150,353,399,148,147,-119,-211,553,168
+D82348_at,540,957,1703,839,1239,1196,715,160,2105,1717,817,47,492,1959,830,777,674,1142,563,2674,614,-136,1044,1123,270,958,614,1050,762,474,404,263,1004,282,734,1060,317,-58
+D83004_at,500,633,929,690,865,222,534,218,917,481,888,284,727,539,707,475,372,503,433,1090,402,453,406,959,199,259,392,314,173,815,548,667,594,245,840,435,493,459
+D83018_at,425,457,621,384,290,389,512,560,502,380,379,373,296,400,210,470,705,393,335,522,294,448,440,485,368,420,790,516,697,566,459,479,564,245,671,507,624,826
+D83032_at,329,233,329,394,572,179,235,266,303,83,56,-17,758,513,516,561,1156,192,189,1721,909,105,125,661,154,490,262,270,334,31,57,44,133,50,32,87,188,115
+D83195_at,-1172,-1225,-1676,-1562,-802,-1189,-1520,-1827,-1358,-944,-970,-1046,-855,-874,-692,-1106,-1486,-855,-869,-1140,-728,-993,-1250,-694,-1084,-1027,-2193,-1225,-985,-1471,-1576,-1279,-792,-595,-1122,-1531,-1523,-1604
+D83243_at,578,146,502,509,270,296,396,347,329,281,263,217,527,377,363,489,565,382,327,744,4,283,207,383,204,266,400,318,233,146,296,259,308,219,200,187,342,414
+D83407_at,110,85,240,132,75,327,53,91,98,113,79,56,70,112,71,146,442,150,66,156,71,78,113,103,84,67,388,169,28,55,109,97,210,19,182,192,115,170
+D83542_at,1225,804,971,1309,616,723,1186,979,1395,346,915,557,928,824,642,802,521,951,617,1411,623,973,1139,1111,962,869,1309,1388,1168,666,818,1800,1337,527,265,1356,389,1930
+D83597_at,243,119,152,300,224,188,122,311,156,130,85,-1,176,109,325,139,572,242,158,762,59,200,66,405,140,191,283,151,209,309,257,2,172,23,498,142,220,355
+D83657_at,-196,98,-241,-158,152,-138,-349,-353,-146,-78,-37,175,-96,63,-113,-190,-330,-161,-133,-259,-138,-232,-112,-205,-245,-244,-245,-244,-204,1974,112,-279,-72,-106,7,-52,-107,208
+D83699_at,450,38,-76,180,-15,154,136,401,67,159,-117,132,-39,-15,38,-63,246,161,-10,-43,101,-39,77,227,106,3,510,-5,16,-63,-120,118,-53,-2,268,190,24,-10
+D83702_at,116,321,87,94,58,113,72,40,201,61,215,37,68,168,110,59,160,70,57,246,217,133,193,135,18,27,147,48,48,43,67,41,81,-6,70,44,146,116
+D83703_at,239,276,610,139,456,206,218,265,263,111,116,142,205,88,268,201,604,62,314,394,128,171,108,151,99,140,372,481,343,275,96,96,55,-21,311,196,455,220
+D83735_at,-99,1102,782,-592,-74,81,84,-1127,1229,103,205,1001,-143,2946,371,-352,-476,2638,-141,-244,868,-430,-668,18,1511,46,-436,1115,699,315,7,321,741,1662,-190,3579,3087,737
+D83767_at,-44,-13,-57,12,132,-30,48,-70,27,-43,19,-48,46,72,78,-79,-10,2,73,73,94,-5,56,269,2,112,4,16,50,-1,-21,-43,84,65,11,-51,-8,7
+D83776_at,417,401,358,391,428,138,204,101,306,96,440,93,621,564,527,380,913,490,300,1311,916,197,134,502,157,210,300,611,324,89,106,60,80,71,77,153,123,157
+D83777_at,-214,808,148,-265,-227,-14,-357,-358,-286,-153,-279,-337,-295,-310,-221,-234,-199,146,-255,-591,-162,-204,226,-300,-204,-385,-212,27,-288,-182,-366,-235,395,-117,-56,103,231,179
+D83778_at,602,577,880,695,839,627,823,337,838,623,608,268,754,426,553,657,286,693,520,1265,333,966,393,977,635,599,819,1099,519,927,660,797,977,327,899,517,675,985
+D83779_at,3121,2988,2611,2078,1527,1945,3612,1988,2294,2145,1625,1427,1592,1417,1927,2066,2454,1319,1525,2217,842,3043,1257,1730,1435,1935,3126,2211,1173,2647,2492,1976,2072,1358,1385,2134,1697,1659
+D83780_at,507,253,980,393,344,-112,221,-113,98,394,40,2,304,307,320,300,452,249,365,282,-127,209,142,-165,198,534,12,163,-69,808,406,196,232,-107,-62,31,230,450
+D83781_at,-45,49,31,-103,176,-64,-5,-155,49,12,68,5,74,35,81,29,13,-5,-20,266,28,-60,-18,56,-47,-83,-54,-41,-100,-52,23,-12,-84,49,-83,-23,-32,-86
+D83782_at,-590,-20,-205,-272,281,-238,-411,-803,55,-416,-250,-475,387,-86,329,-96,73,-294,-80,287,-423,-510,-127,243,-169,4,-1012,-309,-603,-421,-1098,-442,-432,-363,-699,-278,-104,-1042
+D83783_at,403,208,268,381,467,394,569,64,373,105,167,319,1273,500,601,335,596,77,311,893,343,-2,182,639,132,128,-425,76,403,51,108,-2,130,18,-143,230,101,-33
+D83784_at,453,286,449,184,233,426,574,184,399,57,423,146,95,120,165,160,363,182,18,216,49,244,-72,206,130,131,372,67,603,379,402,459,454,-14,158,392,68,621
+D83785_at,587,142,429,412,475,414,596,809,566,19,640,165,695,1008,460,524,549,178,485,931,817,122,-43,823,244,444,3,180,238,321,381,168,139,187,-21,28,265,156
+D83920_at,-126,2267,205,-156,203,1536,-252,-346,451,660,20,-10,-89,1367,131,-54,-147,-78,-173,-26,-72,-111,163,-29,-122,-27,-117,64,40,5852,2046,-228,-321,143,1111,425,2268,4962
+D84110_at,330,350,575,231,226,209,344,262,198,258,276,215,297,257,183,334,195,188,193,449,34,270,151,442,255,316,212,340,151,467,263,290,429,17,316,111,634,581
+D84145_at,186,369,83,86,103,71,50,-67,117,173,233,97,122,157,60,40,75,-14,57,357,303,197,115,114,5,-42,68,210,110,124,273,247,288,237,224,-2,88,452
+D84239_at,168,87,208,610,71,597,216,524,168,99,230,123,42,253,32,10,27,59,41,178,334,109,153,601,119,76,-17,160,86,134,28,133,156,59,15,53,86,143
+D84276_at,222,194,331,249,309,28,122,317,157,25,170,37,29,51,346,339,20,121,49,633,248,64,129,208,28,83,109,-21,96,149,0,-45,68,37,90,86,-99,52
+D84294_at,487,588,552,334,898,252,362,481,1041,254,880,1225,2138,570,826,469,2115,624,616,2216,2274,449,416,795,1187,504,261,480,524,244,293,156,283,271,183,469,775,223
+D84307_at,540,252,363,290,309,382,572,896,655,115,368,250,397,411,368,286,351,308,251,441,291,406,294,498,500,269,132,267,413,572,507,296,503,123,367,351,484,635
+D84361_at,118,-139,155,111,345,-83,-194,-2415,-113,-372,193,4,186,-43,177,331,-1290,290,-506,-655,-417,141,104,-133,-640,305,71,-641,-995,225,-2755,-2561,51,-705,-1083,-134,120,-159
+D84424_at,207,165,-47,54,-43,-145,15,-152,172,-76,86,-67,-71,98,-65,-31,281,193,-28,62,41,88,-102,6,108,15,342,0,151,-203,31,94,80,41,147,-91,-241,272
+D84454_at,-228,-15,-496,-223,125,-250,-384,-307,-276,-318,-63,74,481,91,147,-286,597,-114,-147,-4,-51,-175,-129,282,335,-3,-126,-365,-151,-103,-158,-20,95,14,352,-541,-193,-460
+D84557_at,770,1162,2020,785,939,1749,680,1054,1888,1380,1302,628,1216,1734,1144,872,2837,1144,899,1378,1484,550,872,1084,983,1057,1017,856,613,1084,1013,1036,1167,773,636,889,448,879
+D85181_at,110,285,-17,23,62,145,137,301,263,108,18,125,77,47,14,22,154,96,248,233,176,22,11,73,163,67,156,37,81,-50,137,165,245,139,82,45,36,60
+D85245_at,500,675,866,392,529,222,463,725,596,218,328,294,403,497,362,684,751,529,439,652,584,553,400,517,853,586,999,849,622,655,440,706,1001,161,660,325,921,1225
+D85376_at,180,243,82,132,133,71,141,241,161,136,50,68,105,79,132,72,231,95,107,151,19,57,127,129,120,115,251,161,161,75,148,94,54,42,161,81,79,172
+D85418_at,-51,-25,-315,-164,166,-156,-389,-226,-162,-329,-175,-48,238,-214,119,-35,560,-150,-234,390,137,13,-15,160,-41,-122,-297,-250,-485,-227,-121,80,-220,-29,-394,-230,-135,-390
+D85423_at,-254,57,3,-254,10,-216,-208,-190,-145,-138,-46,-166,-123,83,69,-39,-70,-35,-74,-75,3,-119,-9,43,53,-25,-178,11,-38,-32,66,-8,-42,-2,105,2,35,-185
+D85429_at,833,1365,712,386,417,487,114,-71,1008,5083,680,347,1161,510,606,328,459,97,623,1492,1455,836,617,490,8035,1134,333,262,81,632,207,287,620,362,2563,155,834,252
+D85433_at,220,253,334,76,315,257,38,89,88,183,130,129,127,255,188,53,120,212,188,447,144,132,172,240,240,65,35,123,79,4,246,156,141,75,106,160,109,27
+D85527_at,584,596,823,314,455,547,514,487,679,657,562,228,524,415,248,505,588,541,309,780,349,580,492,667,746,503,564,796,617,1072,438,382,647,166,613,546,685,885
+D85758_at,848,1489,2449,914,1973,1159,430,887,2524,1841,1198,629,3108,1561,1634,1799,2771,991,1516,4229,1557,796,630,1408,640,574,1315,634,788,1034,897,499,1009,1029,797,1126,812,916
+D85815_at,1073,587,1060,1169,690,967,1458,1043,992,287,625,116,55,732,899,375,428,309,246,411,167,882,1592,196,674,385,1207,328,550,941,988,682,981,932,327,1225,1009,1199
+D85939_at,-268,-320,54,-362,-118,197,319,125,219,101,-534,-344,-206,-620,-286,-99,167,36,-3,387,2,-119,-22,222,-475,-245,427,-285,72,364,388,68,213,-39,-325,419,-176,791
+D86096_cds3_at,108,-18,104,5,-70,42,73,34,61,-13,67,-10,-35,46,-5,-32,-35,39,-99,-15,14,73,64,-56,56,-24,31,25,64,-14,82,139,53,-25,12,27,23,33
+D86425_at,49,50,-49,84,-31,0,104,74,84,-12,-44,57,24,-32,-23,88,109,10,-22,-64,22,44,37,-79,-30,8,112,44,38,31,253,3,-64,47,137,196,-50,-78
+D86479_at,1381,1567,1421,2426,956,746,1347,2173,1852,951,1031,524,546,1000,2183,3340,294,406,1834,2179,514,1408,1470,1461,559,1258,1722,581,507,812,811,669,536,323,526,778,850,778
+D86519_at,247,127,475,157,182,167,401,302,384,67,143,125,114,145,63,272,224,159,99,164,196,177,355,197,185,239,378,93,310,189,169,180,287,166,109,261,209,264
+D86549_at,289,540,396,215,376,0,315,79,437,77,235,260,246,179,81,177,100,130,106,716,437,65,102,270,197,112,-323,46,170,184,23,165,188,166,183,245,159,152
+D86640_at,-49,35,141,72,5,120,-11,194,111,118,18,-31,111,-21,66,32,54,-4,22,255,33,102,131,-57,69,54,217,125,-129,17,-32,48,132,23,94,86,76,145
+D86956_at,223,183,273,229,650,-55,104,80,188,1020,85,-41,656,270,252,146,114,80,-9,620,573,158,-30,532,790,57,-126,-114,-144,198,16,-166,61,-51,742,-14,-97,-89
+D86957_at,-55,-10,128,-18,48,186,-28,94,-33,111,-49,-61,33,-178,-3,56,14,-1,120,197,218,-231,-112,-8,-36,77,17,-65,-21,7,-134,31,-48,1,-45,30,-7,-127
+D86959_at,107,370,101,40,78,65,129,79,107,161,182,53,229,175,48,117,234,80,49,273,131,48,-9,176,55,77,223,137,74,129,231,155,212,178,171,158,208,218
+D86960_at,181,94,125,136,104,71,164,232,-1,62,14,56,393,138,96,78,308,49,80,411,304,150,148,203,38,200,109,82,36,62,45,76,131,41,13,74,202,-10
+D86961_at,12,-42,-176,-163,-151,-72,-107,59,-228,-65,-86,-74,-183,-105,-3,-154,306,-67,-90,1057,-31,-10,-148,-188,-60,0,14,-143,-69,-255,-78,22,-154,-58,-110,-213,-158,-118
+D86962_at,655,197,367,241,714,227,411,745,359,235,250,199,637,207,462,382,759,331,360,672,940,393,397,563,321,423,608,704,310,325,345,419,414,163,228,224,467,456
+D86963_at,575,623,664,639,440,501,643,773,581,340,298,321,626,415,641,461,596,539,303,1091,429,538,402,837,454,455,563,498,339,706,611,1112,565,302,686,565,605,517
+D86964_at,494,643,473,295,329,540,225,296,822,403,612,241,419,968,543,386,2003,415,369,605,629,91,514,465,233,420,242,290,257,693,200,153,282,205,501,769,535,238
+D86965_at,729,1502,919,1084,1167,1483,1737,1332,827,1264,961,675,530,1275,1140,1264,2293,1097,1040,2000,619,697,1229,1290,1555,1143,1974,1092,1161,953,2381,1731,1932,915,1405,1194,1858,2236
+D86966_at,754,850,1024,1285,850,745,856,1602,1127,798,1051,561,789,896,786,787,1130,733,1458,1863,418,1285,866,1486,1233,961,560,1685,1555,1371,619,1672,1219,655,1446,935,681,1309
+D86967_at,4346,2554,1855,912,1019,1184,873,2118,3045,2118,2520,970,4856,571,927,3013,2592,1641,5276,5344,2076,1741,1341,932,2274,3045,793,1276,634,1023,724,868,450,383,982,1321,518,685
+D86968_at,-149,-588,-874,-225,-288,-257,-399,-1284,-329,-160,-330,-179,-170,-348,101,-256,-597,-256,-298,-38,318,-312,-364,-420,-130,-275,-1347,-771,-428,-1181,-277,-413,-254,19,-1075,-515,-469,-988
+D86969_at,52,-9,185,33,80,26,11,125,69,48,10,27,231,-29,52,-32,72,352,98,549,194,79,20,96,23,82,39,7,50,-9,-5,105,29,-166,11,-61,41,24
+D86970_at,773,594,423,483,849,318,630,425,573,135,242,367,4371,253,2080,631,924,159,864,4185,179,398,235,1590,722,1516,974,870,141,162,4,139,275,170,81,347,820,-25
+D86971_at,-226,385,-198,228,342,94,33,-380,-50,-66,-189,-183,849,206,552,201,1182,261,40,1165,-319,100,-203,287,-225,-31,-90,-6,194,-202,29,-33,-59,-58,324,-190,33,-101
+D86972_at,268,584,493,288,495,177,349,127,750,361,536,103,463,499,460,317,425,330,243,1052,438,286,444,414,258,400,276,234,334,372,359,448,347,444,341,200,335,280
+D86973_at,141,1108,164,-153,553,508,43,-22,926,56,554,80,490,889,826,879,547,625,369,1746,324,40,41,986,176,159,369,72,336,632,-127,864,460,359,-218,154,453,-120
+D86975_at,-66,-68,-95,-122,-85,-32,85,2,-61,-61,-127,-70,-66,11,126,126,53,-60,-32,52,7,17,55,-167,-90,-8,-162,-35,45,-189,47,19,-93,163,5,98,32,66
+D86976_at,1380,1214,1889,1138,1721,997,1508,634,2506,615,840,567,1755,2071,2075,1388,1573,775,807,2616,254,197,818,1789,988,2194,602,1508,726,2200,328,355,573,411,1421,681,909,370
+D86977_at,601,566,675,495,710,590,660,461,527,880,641,380,911,642,728,695,730,574,688,1076,436,635,543,621,302,526,869,764,519,669,735,743,589,488,933,538,489,733
+D86978_at,742,398,627,313,703,416,480,392,1024,393,416,135,1148,578,626,534,854,475,680,404,447,268,277,552,252,305,265,326,348,221,292,379,283,242,167,279,135,422
+D86979_at,1149,534,992,857,737,478,638,1077,914,323,393,432,883,465,717,763,887,722,736,1500,537,1799,518,908,611,777,402,532,605,606,652,474,570,378,466,647,846,847
+D86980_at,-31,18,35,-12,7,-5,-28,-5,34,-9,68,-18,24,43,-48,21,-25,61,15,53,33,-24,20,11,37,-13,-42,-7,-72,34,66,37,-32,9,17,-39,16,-39
+D86981_at,111,62,-7,25,79,21,55,136,29,26,-16,-27,174,92,11,122,178,79,49,233,21,-31,5,64,-25,27,92,-15,67,-32,-23,34,-44,46,-51,-7,37,65
+D86982_at,265,155,239,276,255,96,278,215,238,89,155,41,359,99,264,210,297,114,176,374,257,100,189,359,59,200,120,173,156,251,176,438,242,118,133,107,188,177
+D86983_at,3330,208,2147,1016,693,1436,463,3829,1504,263,192,1215,1511,1382,828,833,216,192,758,1049,1798,2644,1029,308,711,590,660,354,230,343,658,596,556,166,411,421,603,517
+D86984_at,-170,-152,-258,-270,-55,-126,-164,-248,-288,-190,-158,-165,-159,-113,-52,-308,-124,-102,-173,-87,-29,-230,-98,-164,-111,-200,-251,-242,-91,-220,-225,-186,-109,-70,-97,-227,-139,-369
+D86985_at,33,197,-156,36,197,88,15,110,139,49,504,-40,664,126,200,203,220,76,349,503,218,54,-22,229,-86,62,-90,-50,-137,26,252,179,53,211,312,-94,-59,-56
+D87009_cds3_at,-18,-108,-116,-204,24,-138,-181,-218,-58,-66,-95,-4,-52,-12,48,-27,-75,-17,-47,17,-27,-87,-77,-150,-18,-85,-192,-149,-108,-85,-118,-102,-100,17,-80,-136,-98,-86
+D87011_at,-116,-121,-122,-87,-147,-144,-68,-173,-76,-18,-115,-110,-82,-132,-133,-124,-301,-77,-80,-131,-154,-90,-102,-159,-129,-145,-79,-247,-211,-62,-120,-66,-101,-67,-157,-278,-180,-169
+D87012_at,-193,-352,-222,-236,-115,-384,-389,-410,-301,-247,-223,-308,-264,-374,-84,-230,-762,-277,-250,-387,-253,-111,-220,-128,-212,-91,-575,-620,-399,-337,-200,-216,-389,-209,-602,-355,-309,-396
+D87023_cds2_at,562,634,483,342,617,248,351,991,274,510,281,330,692,356,287,256,860,554,515,623,156,247,541,341,517,552,920,620,759,692,527,589,480,372,221,773,281,990
+D87024_at,400,214,684,266,689,208,389,604,360,344,435,196,405,264,193,184,259,556,223,450,460,326,245,438,500,571,583,460,418,642,148,482,431,143,377,457,266,496
+D87071_at,-328,1002,-66,-602,560,142,720,-460,508,97,215,27,604,903,220,120,2364,-128,704,-205,-173,-617,1,253,827,585,-408,1180,295,645,-568,-526,437,-107,-19,355,912,-458
+D87073_at,329,270,333,311,336,220,241,787,355,234,374,142,341,435,308,313,297,263,84,567,196,486,383,607,434,445,478,335,466,438,336,488,439,129,252,77,360,492
+D87074_at,46,207,76,42,217,-56,28,730,381,9,220,-38,101,12,95,375,56,194,263,4067,482,401,-5,169,64,200,131,83,-76,150,-143,59,72,-14,62,-132,141,120
+D87075_at,242,270,401,-22,274,-26,90,212,-5,24,348,1,180,63,225,184,551,320,240,446,149,121,-41,601,234,89,28,63,-4,341,37,327,167,150,98,-88,208,278
+D87076_at,234,197,687,639,385,640,578,1149,474,1,491,54,973,311,431,838,576,106,1390,1451,162,401,248,545,98,1411,704,-284,-211,634,-59,225,-82,-163,-30,-189,107,610
+D87077_at,-25,140,-99,-19,165,1,95,137,270,8,37,-11,430,135,176,85,556,70,56,458,142,-44,93,145,-50,168,64,-98,-16,137,16,47,-10,30,43,-1,31,37
+D87078_at,619,242,760,865,787,231,772,788,773,142,336,-66,1224,972,1217,712,2151,160,877,2658,356,146,182,1100,-186,342,28,65,60,204,-254,-89,231,359,-53,-176,48,120
+D87116_at,319,511,246,-25,779,200,60,160,224,451,198,415,726,641,579,712,695,211,708,2135,-13,2503,47,189,733,1717,-39,384,100,2749,2590,1613,1096,2025,3152,392,810,1351
+D87119_at,93,-45,891,28,948,177,77,205,1664,553,214,116,42,2348,627,654,183,64,194,469,592,1039,216,228,32,249,416,11,105,156,303,224,120,179,32,17,316,341
+D87120_at,-48,-68,-70,27,336,-48,-25,-55,-49,-70,-81,-54,85,55,86,189,-61,-79,22,180,1350,-9,-132,92,-38,-46,395,-153,-149,-81,-56,-12,-36,-31,5,-22,-9,-70
+D87127_at,254,117,85,95,218,72,179,206,124,108,58,33,470,164,207,234,367,171,265,572,149,100,32,266,95,74,112,29,72,80,175,72,146,135,93,107,129,304
+D87258_at,177,161,268,143,151,136,245,179,266,210,179,71,178,145,151,183,133,171,198,200,119,57,28,253,111,177,67,215,134,392,264,82,112,187,170,125,230,328
+D87292_at,719,195,132,745,813,76,993,476,-78,214,-100,182,556,-51,665,709,398,448,527,1647,319,485,34,519,357,673,1110,187,382,701,326,234,215,287,286,706,518,147
+D87328_at,-578,-550,-489,-462,-376,-505,-836,-556,-37,-155,-385,-488,-209,-408,-378,-105,-441,-74,-217,-569,-489,-903,-531,-222,-359,-158,-538,-580,-519,-481,-638,-345,-515,-222,-703,-470,-261,176
+D87432_at,-8,-50,127,89,93,179,52,23,111,-219,103,-66,104,200,29,264,184,7,83,-49,-88,-132,-178,116,-100,134,-305,-69,206,-31,-240,-114,-120,-106,-232,-9,-149,-170
+D87433_at,-748,-195,-418,-37,252,-97,-77,308,-238,-147,-112,2020,-10,-201,-44,-182,-216,98,-104,-532,38,57,-387,-19,3548,-107,14,2228,264,1487,688,-165,242,-17,4921,2562,237,83
+D87434_at,228,444,91,232,260,90,203,223,155,224,150,212,422,239,330,225,236,269,254,421,684,838,136,270,28,256,289,251,180,1110,1297,706,400,187,176,232,413,1002
+D87435_at,820,313,870,560,562,499,920,1004,723,315,605,-4,325,503,433,713,272,513,397,415,106,646,151,737,485,330,569,387,622,941,324,812,798,82,402,753,374,940
+D87436_at,153,104,109,313,237,32,243,242,146,93,19,10,193,204,243,256,283,116,342,659,321,109,62,176,87,157,-43,75,52,41,335,275,125,197,118,139,37,189
+D87437_at,814,1290,1269,988,674,842,1120,971,1119,954,1293,478,1291,1078,980,961,975,518,1063,2041,427,1628,955,909,463,542,577,648,1137,1214,1174,1325,767,639,1209,1030,947,924
+D87438_at,970,292,870,656,512,337,1448,262,356,316,358,250,1100,432,443,974,675,726,463,593,356,923,265,748,209,485,355,738,807,585,344,710,490,218,75,482,577,627
+D87440_at,0,73,-177,20,81,-26,-70,-133,-38,-20,221,-45,133,37,33,21,13,73,42,241,441,95,-45,105,-126,-104,-178,-142,-165,-164,6,48,-37,218,-164,-91,-69,-70
+D87442_at,1199,467,1088,1711,550,1123,1729,1245,1251,1004,374,924,971,432,562,792,493,903,492,766,148,918,834,1031,911,705,120,1321,1267,1877,775,1345,1291,479,839,1772,1353,555
+D87443_at,-139,-82,-383,-123,57,-23,204,214,-113,-48,-69,-10,-10,-25,-93,2,294,-36,-73,77,-83,-83,-41,-138,24,-188,-104,-158,-33,-188,43,-26,-145,37,204,168,66,-122
+D87444_at,-5,73,163,41,63,76,45,344,123,165,40,25,125,213,-5,86,-150,73,30,264,-12,112,79,-61,30,96,170,344,151,299,-241,34,30,30,278,136,49,358
+D87445_at,136,105,233,190,209,174,220,385,217,193,232,135,295,199,170,315,592,174,94,666,428,234,140,284,288,169,328,284,298,347,195,261,303,145,245,160,258,348
+D87446_at,305,307,143,282,389,48,201,314,248,82,164,37,492,392,367,236,689,281,191,903,617,36,106,579,163,164,209,144,165,166,88,56,19,113,133,173,216,12
+D87447_at,233,169,182,155,313,138,221,185,292,131,121,94,418,87,226,285,73,236,268,1286,857,273,180,160,283,397,137,204,161,158,197,436,165,213,180,143,303,88
+D87448_at,90,138,158,205,213,154,8,95,124,103,47,24,459,194,114,119,619,98,83,447,276,-57,70,293,76,76,-29,47,24,80,5,45,132,85,-204,-53,25,7
+D87449_at,244,269,168,344,171,32,341,347,165,-100,137,123,127,223,250,348,267,353,206,553,333,282,100,346,115,267,240,35,-16,185,252,336,236,109,50,-35,115,124
+D87450_at,120,252,261,306,464,87,216,169,279,78,416,53,564,316,421,313,841,257,240,1163,597,193,115,596,129,75,363,123,302,203,127,243,135,231,151,98,163,300
+D87451_at,1168,1833,1448,1234,1375,990,1508,2182,1991,1442,2609,672,1478,1696,992,1349,1653,1626,1494,3237,792,965,1005,884,1679,1346,588,2203,750,2437,3492,2666,2065,1076,1660,966,1822,2603
+D87452_at,220,273,1,391,635,346,504,463,359,298,700,-17,772,347,767,489,657,169,488,1730,272,408,260,848,197,678,312,446,206,148,461,527,219,829,182,-139,194,425
+D87453_at,336,252,321,606,827,229,457,227,899,373,509,84,441,466,525,500,624,545,607,1302,79,155,250,600,264,531,316,440,180,288,212,163,436,289,427,245,83,211
+D87454_at,-1896,-2222,-427,-3261,-1157,-2329,-2332,-2211,-2816,-2009,-1949,-1815,-1242,-2072,-1679,-1682,-3936,-1767,-1587,-2678,-1372,-2401,-2317,-1615,-1335,-1373,-3149,-2689,-2212,-2205,-2454,-1522,-2488,-899,-2862,-3508,-2872,-3892
+D87455_at,399,399,366,383,398,208,273,439,333,243,320,44,566,327,342,422,819,289,441,1512,83,75,132,436,131,263,378,397,254,207,228,205,238,150,200,274,196,329
+D87457_at,79,-34,70,26,160,-56,48,-89,65,-130,144,11,182,53,51,120,75,251,110,-83,1,-146,-49,36,-18,-20,-143,-90,-180,-40,-125,-122,70,-91,-142,132,176,-77
+D87458_at,-89,18,11,5,-20,-40,-95,-65,-36,-62,-16,-47,2,9,-66,67,-28,-42,24,12,7,35,-17,-39,-76,-81,-145,10,-62,-8,-8,-56,4,7,-38,-61,-56,-62
+D87459_at,230,10,85,314,78,55,87,118,70,67,37,1,393,27,293,62,697,-3,82,167,141,64,-75,185,-3,42,57,52,117,-8,-6,-18,34,38,-2,45,30,65
+D87460_at,1027,1359,1270,1112,742,606,1223,1458,887,772,509,625,605,454,241,1002,970,687,1894,2145,528,950,592,632,607,1279,812,1030,1019,884,624,387,1004,187,516,801,726,1496
+D87461_at,41,155,-30,14,111,-81,26,23,115,21,-11,18,107,-25,-33,-9,49,4,212,120,-44,-20,-47,-53,-2,6,1,55,33,7,53,62,117,77,22,92,-9,25
+D87462_at,729,1140,950,670,792,946,683,2060,809,822,612,1115,675,1146,691,551,591,552,1268,1298,444,530,1200,541,204,464,350,1955,1702,529,986,833,982,486,616,1178,864,683
+D87463_at,-121,-16,-132,-122,-149,-254,-33,37,-90,-86,-69,-127,-66,-92,-75,-65,-258,-72,12,-185,-93,-58,-87,-85,-73,-113,-143,-73,-67,-189,-84,-71,-66,-166,-156,-115,-81,-149
+D87464_at,86,135,578,156,226,144,104,335,424,71,92,-7,392,179,200,266,648,146,63,556,331,13,-24,392,166,141,87,324,175,389,-40,62,-10,103,83,134,33,3
+D87465_at,652,1100,351,50,165,72,-102,208,882,373,57,35,400,4797,198,1557,238,480,422,100,272,41,330,166,143,637,287,192,177,237,65,-22,170,82,120,-20,549,106
+D87466_at,420,176,286,348,270,231,216,292,305,159,292,109,610,298,212,409,452,206,276,633,287,130,180,441,168,171,195,227,372,212,179,251,181,150,31,258,267,111
+D87467_at,279,148,399,439,203,266,292,380,311,243,288,275,157,282,230,307,152,172,223,218,357,218,568,199,188,191,330,327,245,203,253,251,203,110,258,451,281,271
+D87468_at,287,-16,407,-220,-40,-37,-127,332,-62,-169,292,-255,-111,16,-81,29,-52,-74,73,100,258,380,-214,-107,121,-87,-53,-73,127,218,543,17,71,114,272,-13,-166,283
+D87469_at,233,357,293,363,160,81,677,769,466,155,230,208,197,259,189,32,166,193,234,285,434,330,246,414,281,121,264,282,637,315,207,281,97,27,378,241,148,182
+D87470_at,140,158,144,55,22,167,213,67,273,8,111,71,124,117,222,105,91,30,85,156,359,100,104,255,-18,60,122,20,108,50,106,67,99,7,38,149,208,124
+D87673_at,1001,870,786,1010,840,681,1275,1328,1188,696,353,806,65,648,826,560,1130,787,-57,1193,446,1127,1041,479,869,395,1333,814,536,893,1168,955,726,599,724,829,1283,1116
+D87682_at,24,-174,11,-138,-2,-87,77,-188,79,9,26,-132,-5,111,10,74,277,66,44,132,1,-18,-136,-6,-35,25,7,27,100,-279,-21,105,-117,10,-188,13,104,-93
+D87683_at,110,91,82,102,68,197,72,104,150,18,93,43,78,187,81,65,121,79,29,207,346,-14,136,104,83,19,78,69,86,0,48,118,107,17,-27,49,109,63
+D87684_at,503,789,579,283,656,256,238,388,629,314,1135,217,1009,777,677,493,1256,372,328,2221,1425,474,243,704,292,279,273,689,339,343,319,839,252,459,315,374,499,432
+D87685_at,86,124,163,140,140,35,57,55,112,93,227,68,319,199,88,129,469,93,40,336,298,113,37,230,92,106,62,33,-24,56,88,204,160,119,134,61,62,128
+D87735_at,6251,9740,6722,9620,11512,6271,6443,8965,9981,7923,8510,9858,8126,8726,10442,9351,7127,8475,8545,13644,13331,8317,7295,9803,10695,6992,7742,10096,7641,8076,10442,11720,9391,12366,9203,12368,8615,11235
+D87742_at,94,112,126,171,176,71,152,191,100,51,114,61,137,79,126,168,133,112,109,283,94,81,176,224,87,93,300,72,62,64,39,139,183,61,-99,48,59,28
+D87743_at,251,148,240,92,173,97,161,212,311,-4,201,87,523,176,164,81,309,51,163,264,187,120,94,220,70,159,194,208,64,317,191,212,125,167,195,215,109,136
+D87845_at,79,352,265,349,181,320,315,341,69,125,136,206,111,145,141,168,157,191,235,109,156,189,224,190,277,146,164,247,189,101,316,227,298,-1,222,241,223,260
+D87937_at,61,939,281,169,212,40,43,217,-2,39,321,-25,101,623,105,133,870,85,241,484,635,337,184,279,257,588,81,-53,125,579,897,934,30,619,1229,71,-1,55
+D87953_at,952,1490,1277,1358,1403,796,1308,1142,1281,1106,923,2662,1354,957,1080,1001,2108,570,960,1308,879,2520,636,1304,1582,1149,780,1643,1293,2883,1472,2198,1833,1101,2718,1412,920,3221
+D87957_at,-218,-171,-198,-350,-133,-161,-366,-413,-198,-96,-121,-188,-186,-246,-46,-181,-222,-182,-149,-69,-204,-309,-241,-177,-150,-188,-530,-423,-132,-160,-405,-396,-278,-97,-86,-381,-341,-234
+D87969_at,314,115,257,199,419,69,194,212,70,128,99,-17,488,301,285,269,739,108,235,1066,193,43,180,348,154,139,64,122,12,195,136,113,64,79,52,53,165,120
+D87989_at,690,757,749,792,904,346,628,395,863,506,495,423,972,439,910,731,598,387,602,1158,662,865,336,676,504,444,391,724,413,1109,1320,790,815,543,1450,851,516,1443
+D88146_at,-69,-70,-740,-35,-292,-556,-16,-259,-765,-150,-323,-340,-494,-408,-373,-282,-623,-328,-298,-762,-378,-623,-550,-189,-506,-591,-117,-828,-351,-14,-524,-159,-765,-146,-67,31,-56,-1093
+D88152_at,-30,-12,-85,-44,19,-126,-36,-61,-54,-72,-58,-27,2,3,13,-29,18,-35,-32,93,-6,-40,-17,-71,-64,-68,-137,-100,-100,-152,-22,-31,-48,-54,-55,-48,-72,-150
+D88213_at,351,383,701,263,306,218,455,236,519,293,268,183,293,250,179,404,579,280,237,410,281,379,330,449,246,361,650,380,415,527,450,264,370,190,360,244,311,621
+D88270_at,1965,198,579,4881,3383,3,1507,1248,41,365,39,712,7509,26,5394,3809,-68,19,67,1105,9453,4328,-11,4110,5119,7600,3780,114,33,21,130,-4,168,59,51,170,146,187
+D88378_at,266,173,241,79,185,-19,58,149,256,137,163,45,200,160,186,170,215,23,146,405,189,113,176,239,126,149,233,111,144,97,97,203,138,97,102,100,119,145
+D88422_at,161,588,207,82,337,200,55,121,127,272,37,306,44,328,128,133,71,-7,69,-9,126,43,77,177,17,78,137,728,853,7109,3844,1507,262,1567,9600,894,347,1013
+D88460_at,-280,-104,-181,-72,-93,-305,-231,-271,-78,-135,-57,-139,-205,-107,-70,-189,-150,-213,-278,-159,-172,-143,-134,-359,-197,-123,-136,-222,-252,-143,-102,-89,-206,-153,-37,-85,-230,-72
+D88532_at,106,-38,-60,44,17,-104,-119,-175,49,-166,-74,58,-73,15,-78,55,115,20,-33,-13,51,78,34,27,0,14,-178,-30,-7,136,235,-24,-3,-81,45,-137,151,159
+D88613_at,727,414,558,592,292,638,719,865,481,248,451,455,167,523,234,322,299,175,180,196,286,485,590,364,369,272,557,566,625,427,467,758,447,93,534,396,383,689
+D88667_at,-1651,-849,-2416,-1096,-493,-881,-1063,-1052,-783,-452,-1306,-731,-1071,-1412,-428,-1029,-488,-407,-572,-694,-773,-748,-818,-567,-1134,-911,-921,-1544,-654,-878,-902,-2099,-702,-163,-953,-731,-671,-956
+D88795_at,82,-21,175,-6,16,26,-5,100,71,9,7,102,6,-4,-46,63,-26,65,-22,58,69,115,134,142,-31,124,81,66,360,-4,31,6,85,22,105,73,40,-48
+D88797_at,108,117,218,152,125,101,146,56,92,111,126,83,107,107,71,26,91,116,86,76,-32,181,188,206,95,109,323,132,132,98,121,133,68,67,121,291,132,182
+D88799_at,121,-85,-72,142,74,136,102,376,-105,49,-108,153,-87,80,55,50,-372,-26,45,-81,2,120,201,34,177,-14,-46,-59,235,-144,133,34,12,55,89,183,180,118
+D89016_at,1069,1062,575,544,694,464,1240,1232,1075,568,829,548,538,762,817,1124,1505,714,769,1469,765,1109,170,508,739,517,1068,747,779,1590,1254,841,1046,535,1136,749,608,746
+D89050_at,-150,-121,-327,-139,-140,39,-245,-104,-135,-82,-74,-58,-130,-161,-84,-173,-492,-112,-74,-356,-63,-145,-224,-206,-257,-227,-306,-46,-117,-19,-172,-371,-218,-167,-121,-115,-181,5
+D89052_at,216,1657,93,970,1372,-103,811,599,1445,223,698,998,1863,281,1356,1343,1511,226,1009,4367,-44,1765,5,1249,470,1904,1032,1314,1137,3697,1812,2516,802,1208,2454,2268,1158,471
+D89077_at,67,430,725,447,449,535,265,85,626,212,289,169,238,2314,320,194,514,65,102,219,129,17,393,127,179,205,70,266,228,491,683,233,278,217,570,227,411,1142
+D89289_at,184,70,265,130,132,199,42,205,223,26,169,76,263,405,163,270,358,282,104,198,-61,92,142,146,106,119,103,115,199,86,70,157,156,91,-35,18,145,170
+D89501_at,41,-49,140,150,-10,216,208,209,49,118,-47,25,68,0,42,154,75,86,45,2,84,143,49,-101,73,147,158,150,295,118,-59,144,147,-3,163,65,-80,230
+D89667_at,1271,3622,1739,2252,3015,1257,1083,1628,3123,1723,2294,1704,1834,1969,2602,2337,1993,1553,1883,6774,3180,1755,1472,901,2533,2510,979,2987,1962,2769,3565,2994,2325,4013,3752,2397,2152,2004
+D89858_at,240,224,230,270,173,323,176,-50,481,190,134,270,315,322,127,189,158,174,327,167,111,228,180,272,108,239,143,228,129,301,389,357,328,191,53,370,340,258
+D89859_at,153,153,240,87,115,101,146,88,187,65,119,-1,148,168,145,88,223,52,25,174,17,128,157,48,37,81,206,102,76,77,-10,42,33,41,113,57,95,163
+D90064_at,-49,-43,-3,-33,-21,-40,-35,23,73,-43,39,91,-28,45,16,81,82,-16,-25,-44,49,-17,-11,-67,-36,31,86,-93,4,-2,-47,-10,75,2,-18,2,-20,124
+D90084_at,545,491,-190,686,626,391,512,418,963,429,309,682,774,724,568,374,902,438,337,1129,744,241,450,894,1397,534,478,920,492,640,610,252,831,382,875,572,924,722
+D90086_at,952,629,882,1056,1231,620,1376,863,759,516,504,353,1132,1248,1060,805,1284,872,517,2337,745,499,444,785,436,606,1101,972,449,791,717,661,511,326,601,638,961,682
+D90097_at,25,13,1,13,25,-12,-1,-22,34,39,49,-33,-32,61,59,90,-117,10,34,85,158,14,41,28,-12,7,-26,91,55,67,-49,98,82,-17,14,20,112,-18
+D90209_at,1095,5457,2736,1517,2939,2044,1639,1590,5409,3444,6134,1520,2058,1454,1838,1739,2190,1872,2184,7696,3054,2905,2205,2393,2153,3490,1239,3387,2101,4407,4597,2780,2629,2337,3504,2585,1750,3083
+D90224_at,-146,42,-180,-31,-17,-30,115,32,-91,-106,-67,-28,41,-141,9,42,115,134,617,1082,9,-69,-74,206,82,-52,-186,-172,-199,-111,-170,-75,-118,-46,52,-27,-136,-219
+D90276_at,812,512,983,475,589,270,593,490,842,504,370,221,517,374,322,561,707,615,293,840,241,379,484,895,577,786,884,764,620,769,375,432,925,289,684,587,589,1205
+D90282_at,112,17,78,66,29,-37,43,-71,12,78,-3,-14,86,55,39,36,-105,64,37,22,-28,30,0,114,-47,12,35,113,7,58,29,-4,59,-5,38,34,-34,100
+D90359_at,37,-21,67,-11,104,101,26,-127,58,-72,-33,83,228,-54,12,-77,404,16,72,150,-194,126,-203,130,147,25,342,-43,-9,111,77,118,-37,-50,102,-96,-66,225
+H46990_at,62,-20,53,-85,34,-10,-40,-23,-24,-57,-20,-20,-17,-37,-46,-30,-29,-28,11,-35,-32,41,-58,7,6,12,20,-60,-57,-25,-19,0,21,-22,-1,7,-29,27
+HG1019-HT1019_at,140,21,-288,-4,-65,-302,297,59,-774,-245,-290,-264,-23,250,-494,-214,333,-140,-73,202,71,78,-303,-96,143,179,139,-316,173,35,-530,-368,-398,-458,-147,-1,88,-600
+HG1071-HT1071_at,172,150,368,328,122,202,295,283,209,218,123,143,128,132,90,207,164,58,91,127,163,108,153,163,36,174,240,206,185,192,234,151,175,27,121,190,185,289
+HG1078-HT1078_at,2811,2138,3577,1932,928,1616,2885,2229,1536,1271,1637,1438,1999,2617,1468,2067,1428,1980,1101,4148,2569,2076,1698,1900,1270,2917,3531,2802,1851,1445,1339,1867,1160,203,1003,1238,1726,1702
+HG1098-HT1098_at,-278,-84,-217,-57,-86,-74,-243,-154,-102,-71,-102,-84,-116,-148,-68,-63,-136,-116,-135,-146,-14,-192,-148,-145,-63,-77,-114,-131,-144,-112,-165,-52,-140,-62,-108,-193,-166,-254
+HG1102-HT1102_at,353,526,557,379,524,96,383,278,698,178,674,291,303,277,712,442,108,247,169,285,219,210,398,662,282,314,244,648,242,778,1308,567,490,651,1532,414,661,760
+HG1103-HT1103_at,159,182,102,60,156,58,97,28,210,76,142,80,113,182,76,97,80,91,-15,271,82,57,74,271,81,84,-6,90,168,124,133,182,182,73,142,112,149,316
+HG1111-HT1111_at,-116,107,189,200,-46,142,265,35,65,164,77,50,122,224,-38,-45,167,136,100,89,-56,87,32,-70,9,-92,139,85,88,-34,59,102,104,23,234,153,264,264
+HG1112-HT1112_at,1495,1804,2927,2422,3339,1927,1560,1196,3430,1991,2636,1442,1789,2107,3859,2020,1979,1936,1778,3861,637,920,2262,2398,1367,1004,1741,1097,990,1746,1767,918,1754,1205,1623,1808,1223,1415
+HG1116-HT1116_at,520,541,739,696,568,618,559,580,459,422,593,515,430,715,554,665,840,467,407,775,402,384,465,718,476,415,827,519,288,476,639,626,726,189,293,715,603,578
+HG1139-HT4910_at,106,78,-19,-41,24,-12,-57,166,14,-55,100,11,43,68,-44,-72,-1,24,-28,28,51,43,0,98,56,42,-71,-119,-45,7,-19,112,-9,82,-151,-15,-19,73
+HG1148-HT1148_at,-301,-104,-277,-103,-133,-163,-220,-280,-280,-111,-173,-122,-147,-145,-93,-148,187,-74,-98,-284,-72,-213,-207,-217,-240,-200,-189,-275,-105,-328,-210,-381,-281,-213,-185,-269,-354,-294
+HG1153-HT1153_at,1016,3283,2304,3518,5323,1932,1712,988,4224,3252,2556,3138,3790,2767,4679,3639,4352,2817,2296,12559,8189,1213,2327,4387,2531,2226,2142,3465,2144,2341,2809,2370,3534,3144,4213,3789,2649,2285
+HG1155-HT4822_at,2180,1563,2438,1837,1113,1445,1802,2446,1761,1256,1196,1036,1299,1361,1134,1528,2002,1569,1241,2133,1070,1472,1440,1395,1667,1595,2561,2181,1724,2188,1911,2701,1790,892,1678,1933,2080,2791
+HG1205-HT1205_at,252,284,294,501,154,517,289,532,265,80,164,285,138,331,165,213,413,187,228,383,258,379,387,236,365,249,361,169,351,110,638,469,280,149,-21,213,353,868
+HG142-HT142_at,-160,-20,-388,-141,-88,-165,-285,-215,-224,-149,-187,-112,5,-310,49,-180,-370,-20,-90,-81,-263,-75,-265,-160,-126,-23,-272,-185,-319,-378,-169,-98,-188,-83,-210,-74,-67,-293
+HG1602-HT1602_at,928,606,1153,893,448,704,858,1352,948,455,574,444,482,621,549,362,1122,469,440,438,334,714,687,476,457,516,863,916,620,937,541,451,807,350,632,773,846,722
+HG1604-HT1604_at,-213,-146,-806,-805,-159,-160,-865,-970,-294,-234,-178,-477,-113,-224,-175,-148,-1196,-262,-311,-268,-179,-139,-585,-514,-244,-310,-1032,-843,-593,-633,-901,-128,-328,-314,-731,-313,-384,-829
+HG1612-HT1612_at,3767,2890,5996,2810,2206,3881,3723,4072,7439,4791,4406,1379,6964,2056,3688,2976,3182,2209,2580,10857,1535,4624,3710,5079,2302,2106,3307,624,680,1031,1687,1367,2194,460,1874,767,2856,2205
+HG1614-HT1614_at,1915,997,2794,3120,4072,1851,2120,325,5642,1491,1660,1210,2667,2627,3772,2977,1598,2345,1444,6029,1836,1579,1172,3479,651,3668,1195,1411,1007,2077,831,500,616,876,1994,2912,1143,-131
+HG1649-HT1652_at,2006,625,2253,3208,1337,1696,2663,2202,1089,2713,1202,1240,573,1673,1540,1829,2289,1396,2370,2643,388,1898,1945,445,1601,2391,3683,2131,1409,1152,1501,1441,1453,988,4111,2133,2288,1862
+HG172-HT3924_at,315,193,434,221,178,247,378,301,197,137,124,142,185,258,131,171,88,128,184,301,22,235,161,243,105,255,295,86,300,313,118,120,338,21,232,142,268,453
+HG1723-HT1729_at,777,456,1074,666,450,526,693,565,743,489,516,323,470,523,312,512,751,453,425,1011,289,483,471,514,411,524,719,471,581,592,620,412,635,287,544,511,664,847
+HG1733-HT1748_at,244,199,567,218,-32,128,134,119,241,207,-96,179,237,77,-73,173,391,-133,151,564,166,367,87,-158,316,262,204,-279,-67,29,180,391,-193,115,317,137,222,422
+HG174-HT174_at,-45,-36,-103,-15,-61,-88,-117,-8,15,-24,-27,-77,-49,-59,-4,29,-89,-219,30,-65,-33,-35,-32,-83,-86,-193,-125,-278,-9,135,60,166,-3,27,15,-88,-4,-49
+HG180-HT180_at,-246,-43,-169,-121,-58,-161,23,92,-249,-38,-74,-81,-60,-108,-78,-153,-41,-27,184,317,-16,193,-3,-108,311,35,100,72,165,-79,233,270,80,173,134,-122,130,261
+HG1800-HT1823_at,19655,20187,23344,18830,21111,19538,19851,15207,21542,16943,21123,19576,20687,20374,17932,18313,17420,18599,18796,22564,29755,21576,16783,20826,18764,18404,18001,22255,22944,19080,21926,21789,20247,18341,21226,17451,14393,22680
+HG1804-HT1829_at,1121,944,849,1253,775,753,816,307,1098,651,662,465,386,654,684,415,744,80,539,1083,77,409,444,180,894,391,586,645,762,952,1071,248,875,470,904,854,804,879
+HG1828-HT1857_at,276,117,293,284,236,76,80,11,61,158,122,205,149,201,173,117,271,198,188,236,137,138,72,158,186,203,122,163,211,258,328,79,153,121,220,228,387,295
+HG1862-HT1897_at,4788,2698,1809,2305,2739,844,1885,2097,3039,1948,920,1948,9740,2839,2579,4083,1726,1055,5441,11395,5299,3864,1746,2778,1854,3681,930,1023,435,2801,2101,903,1353,867,3166,3174,1678,1353
+HG1869-HT1904_at,883,1081,2011,771,764,1184,793,490,2011,1065,882,719,1256,1018,877,611,844,507,398,1322,1150,238,701,1178,571,757,264,460,560,785,635,368,564,279,692,745,705,250
+HG1872-HT1907_at,3144,1205,1601,1027,871,768,1213,1835,1040,911,771,1106,1606,1300,1053,987,964,2874,2433,2078,620,1789,1071,1411,1138,1252,2212,1927,1575,2619,3064,1166,1588,861,6951,3358,2166,2919
+HG1879-HT1919_at,400,528,414,379,324,216,438,298,388,285,462,329,348,298,203,189,203,421,176,449,231,289,260,502,254,249,258,474,399,592,817,427,489,283,952,534,392,928
+HG2028-HT2082_at,468,344,660,280,178,487,672,235,502,478,350,274,216,334,207,358,270,264,174,245,317,302,526,351,281,276,420,602,324,461,505,371,447,135,586,500,595,613
+HG2036-HT2090_at,258,269,643,294,170,270,315,97,433,149,202,245,205,410,194,137,80,188,53,-64,112,-6,241,295,92,88,48,135,55,262,77,21,117,-273,181,218,130,84
+HG2059-HT2114_at,1139,1419,1111,1013,1076,1077,967,746,1048,559,654,721,647,1390,971,578,2140,510,419,826,289,608,645,1540,616,486,616,543,848,2379,1060,505,1023,514,1741,837,1868,1369
+HG2152-HT2222_at,-593,-391,-522,-679,-288,-494,-841,-586,-577,-555,-366,-570,-346,-595,-282,-541,-1120,-337,-251,-368,-499,-350,-474,243,-617,-400,-1308,-462,-779,-1308,-539,-735,103,-474,-726,-676,-786,-543
+HG2161-HT2231_at,-1534,-2115,-1967,-1788,-540,-1196,-1851,-3093,-1417,-1689,-678,-1028,-800,-1679,-840,-1443,-3036,-768,-1927,-1305,-1165,-1127,-1343,-737,-1931,-1771,-4108,-728,-2132,-2383,-729,-1173,-596,-981,-2555,-2296,-675,-769
+HG2167-HT2237_at,456,683,531,451,419,227,258,977,469,293,439,617,375,426,353,262,366,277,300,1322,569,1809,7,591,506,624,189,562,430,602,701,760,1241,370,1430,141,745,756
+HG2188-HT2258_at,-165,-224,-207,-134,-138,-145,-388,-82,-384,-227,-129,-229,-173,-208,-131,-107,-284,-29,-260,-36,-127,-153,-186,-132,-108,-122,-248,-181,-146,-232,-604,-445,-344,-134,-375,-269,-347,-529
+HG2190-HT2260_at,-780,-997,-1669,-869,-446,-926,-777,-1868,-1508,-541,-395,-659,-789,-1006,-136,-248,-884,-496,-479,-1610,-431,-1067,-644,-428,-620,-531,-1522,-1163,-945,-1342,-856,-1485,-1340,-482,-923,-1339,-1142,-2016
+HG2191-HT2261_at,-356,-451,-336,-565,-188,-421,-687,-866,-46,-317,-169,-431,-347,-589,-366,-393,-595,-295,-333,-299,-258,-343,-503,58,-393,-122,-776,26,88,-597,-757,-893,-562,-352,-486,-631,-453,-811
+HG2228-HT2305_at,-1051,-1251,-1264,-1689,-648,-956,-1233,-1502,-1181,-753,-806,-702,-759,-754,-747,-888,-2123,-673,-302,-1597,-764,-392,-887,-618,-932,-945,-2342,-1137,-978,-954,-1373,-656,-1509,-642,-1252,-1127,-1427,-1608
+HG2229-HT2306_at,-384,-351,-463,-468,-221,-360,-361,-710,-368,-265,-329,-326,-186,-306,-284,-283,-222,-242,-288,-283,-203,-353,-404,-354,-303,-258,-486,-440,-428,-392,-513,-511,-326,-238,-336,-388,-483,-595
+HG2247-HT2332_at,211,-46,406,310,129,232,389,665,348,231,40,176,88,189,95,89,164,204,154,246,266,264,330,33,308,117,-1303,167,312,318,264,179,356,190,-46,273,235,504
+HG2261-HT2352_at,-242,-365,-141,-396,-257,-352,-248,-466,-441,13,-288,-491,-60,-416,-290,-298,103,-142,-230,-286,-258,-73,-189,-286,-223,-172,-301,81,-168,-220,-715,-451,-300,-187,-152,-321,-155,-454
+HG2264-HT2360_at,564,278,459,362,157,-90,225,406,494,310,185,205,183,159,139,255,650,298,195,187,188,426,406,192,304,275,685,519,608,448,134,238,468,127,412,517,417,402
+HG2274-HT2370_at,334,662,504,119,1006,376,173,97,975,699,433,296,475,474,1014,546,621,193,492,1438,670,257,450,724,692,601,64,28,305,28,431,383,347,313,457,476,87,-451
+HG2279-HT2375_at,3447,4511,5403,3116,5082,4694,3600,1566,7315,7941,4239,3092,5214,2997,4478,1564,4414,9245,1688,6323,989,1290,2350,2800,2232,2578,3044,4023,3032,8042,4441,1096,4004,3028,8242,6771,2093,2143
+HG2280-HT2376_at,1614,880,2100,1300,799,1065,1214,1127,1486,1118,900,747,821,923,591,1074,1782,929,877,1225,762,969,1136,1025,955,936,1714,1471,1255,1733,1302,819,1395,696,1170,1120,1371,2300
+HG2290-HT2386_at,675,397,671,584,341,563,584,311,620,629,506,298,239,396,213,410,395,313,288,334,76,540,480,296,338,268,859,705,521,488,835,312,618,189,356,455,538,294
+HG2309-HT2405_at,-103,-9,-52,-121,-70,-163,0,-89,-151,-64,36,-8,-21,-130,-46,-165,-167,-10,-54,-150,-82,-120,-132,-130,29,-78,-118,-189,38,15,-27,36,-33,-31,-9,-147,-78,-71
+HG2314-HT2410_at,-101,-275,366,74,26,106,383,71,373,-32,126,132,-247,51,-19,-269,-456,-142,-22,-440,-301,300,-117,-181,119,-256,132,-237,250,461,139,248,364,66,48,138,61,-181
+HG2320-HT2416_at,1267,602,1650,1010,536,266,678,709,1048,1000,814,376,636,867,431,773,994,751,671,1022,371,867,368,437,402,617,1093,722,759,745,610,543,1026,161,899,882,865,1409
+HG2325-HT2421_at,1068,898,1416,858,662,753,1053,964,963,545,724,550,903,739,618,955,972,761,634,929,226,805,636,883,842,846,1362,801,663,1188,773,792,1046,380,1168,697,837,1249
+HG2339-HT2435_at,-403,-504,-945,-364,-218,-403,-198,-166,-484,-281,-450,-257,-251,-171,-290,9,-543,-153,-244,-526,-268,-422,-416,-375,-181,-280,-230,-213,-480,-128,-674,-505,-485,-87,-330,-490,-406,-752
+HG2415-HT2511_at,154,452,464,232,421,645,99,460,747,408,466,343,241,567,350,152,357,162,200,635,432,223,526,486,162,131,26,227,214,452,516,528,465,287,430,285,134,459
+HG2416-HT2512_at,-110,39,-98,-6,-21,-39,-55,-139,-60,-43,-17,-30,-24,63,51,43,-45,0,101,61,111,-96,-49,-58,54,6,-240,-86,4,-87,-11,-32,-29,-13,-7,-53,-58,-86
+HG2417-HT2513_at,-168,68,5,61,-13,-128,-129,139,-28,42,24,-20,-102,-78,28,13,22,-106,72,158,-74,-34,119,-66,70,-59,-23,-14,-120,15,228,95,6,65,27,61,-20,123
+HG2442-HT2538_at,225,223,500,78,147,135,218,46,190,152,173,10,136,258,72,184,117,258,184,154,238,391,172,212,96,142,356,227,302,330,91,417,346,111,137,79,179,155
+HG2460-HT2556_at,-56,-9,22,19,0,-83,-6,140,-88,31,55,-27,-23,16,-40,-12,-96,23,-2,-6,-29,-15,89,-25,37,57,-1,-96,-57,-25,59,13,87,-57,10,-47,-16,182
+HG2463-HT2559_at,498,478,387,362,746,517,367,403,464,689,1229,1780,334,304,334,413,474,282,230,819,442,683,645,830,579,252,317,524,262,1802,779,799,709,699,541,779,731,1299
+HG2480-HT2576_at,345,442,355,282,332,268,341,358,485,282,229,162,164,356,163,224,628,378,320,647,396,342,222,443,277,364,605,106,259,382,281,402,496,118,576,333,593,380
+HG2492-HT2588_at,-641,-394,-1084,-972,-18,-915,-962,-1109,-545,-509,-294,-629,224,-352,-417,-212,-849,-301,25,-323,-578,-472,-782,-437,-274,-20,-921,-224,-593,-712,-787,-865,-165,-97,-652,-776,-551,-487
+HG2507-HT2603_at,-27,-93,-166,-95,5,21,193,-64,44,-60,-85,-68,-61,-29,-35,-194,-133,-152,-345,-201,102,-53,-96,-185,-19,-63,-131,-1,-115,-132,9,182,-139,-58,-50,-176,-95,85
+HG2525-HT2621_at,436,679,632,710,377,410,635,535,924,462,446,166,287,392,324,334,744,124,255,309,431,653,425,475,446,268,593,687,807,606,203,617,612,374,856,595,355,1011
+HG2530-HT2626_at,-127,-99,-222,-51,22,-44,-72,-77,-95,-32,-36,-2,-137,-77,3,-13,-15,-99,-86,-54,41,-71,24,-87,1,-43,-64,-134,-19,-210,-7,-44,-58,1,-335,-136,1,-67
+HG2538-HT2634_at,65,104,127,154,61,46,119,251,82,65,43,48,62,72,51,54,208,80,83,66,86,100,153,91,38,132,225,129,72,73,113,97,67,77,137,43,112,81
+HG2566-HT4867_at,2509,1769,3472,2740,1354,2144,3053,3689,3202,2154,1726,1813,1357,1654,1459,1370,1812,1493,1520,1972,853,2543,2241,1023,1370,1514,3166,2436,2594,2607,3080,2462,2418,1594,1628,3055,3028,3936
+HG2573-HT2669_at,170,188,54,167,113,99,104,-239,146,108,79,61,119,179,110,84,124,10,117,113,94,132,216,132,140,136,206,192,93,214,64,190,64,2,116,171,123,151
+HG25930-HT26386_at,-7,65,-30,-296,242,126,505,10,176,108,-461,-208,-178,68,-140,-78,70,-192,-32,-162,-204,-44,165,-380,-398,207,197,291,189,-444,-554,-304,-112,-230,27,143,-389,-441
+HG2602-HT2698_at,39,-91,290,128,83,144,124,631,288,2,6,133,-180,-18,93,174,-41,95,45,-34,-32,-92,32,61,106,5,799,223,300,19,338,112,97,70,48,146,92,328
+HG2604-HT2700_at,-256,-329,-305,-540,-131,-163,-443,-206,-308,-36,-32,-323,55,-268,-647,-262,-36,124,-116,3,54,-172,-298,218,-328,25,-336,-90,-331,-304,-699,-255,148,-6,-373,-397,240,-407
+HG2614-HT2710_at,251,345,477,349,270,46,289,293,266,338,240,140,319,220,263,387,73,244,178,412,181,265,360,196,227,310,395,525,43,415,149,190,264,131,196,408,510,542
+HG2662-HT2758_at,-987,-535,-1122,-1023,-318,-844,-1364,-859,-848,-873,-363,-386,-202,-590,-565,-745,-1857,-491,-622,-233,-97,-396,-328,-820,-338,-237,-873,-669,-1146,-989,-1000,-929,-755,-399,-1137,-1273,-1339,-1537
+HG2663-HT2759_at,98,91,213,20,75,21,126,121,123,44,84,-10,68,14,46,140,294,121,86,-16,-22,39,-81,7,12,147,37,105,26,117,3,-42,85,6,110,119,98,231
+HG2668-HT2764_at,608,469,1097,721,453,487,756,772,716,758,551,308,572,550,443,564,861,640,508,732,333,634,535,626,518,331,869,802,608,890,759,414,822,275,720,803,777,942
+HG2686-HT2782_at,-128,-187,-91,-121,71,-170,-144,-58,-178,-102,-56,-103,-46,-64,0,-121,-99,8,-92,-37,-37,-78,-144,-102,-31,-23,-71,-125,19,-195,-115,-43,-74,-75,-196,-179,-55,-79
+HG2689-HT2785_at,-162,-224,-200,-108,-60,-119,-48,-166,-267,-132,-145,-247,-151,-202,-143,-208,-94,-57,-213,-450,-137,-231,-231,-126,-186,-181,-239,-232,-79,-303,-364,-405,-211,-153,-340,-261,19,-328
+HG270-HT270_at,-275,-169,-302,-235,-103,-216,-152,-164,-259,-164,-180,-148,-129,-69,-84,-138,-83,-137,-107,-52,-66,-92,-174,-216,-197,-67,-217,-296,-226,-309,-367,-299,-256,-70,-210,-194,-178,-368
+HG2706-HT2802_at,-82,-62,-205,-118,-79,-46,-134,-100,-215,-147,-91,-112,-94,-138,-59,-59,-143,-28,-28,-58,-102,-73,-32,-179,-70,-77,28,-74,-192,-141,-175,-133,-184,-101,-118,-57,4,-281
+HG2707-HT2803_at,-349,-338,-547,-176,-236,-435,-341,-509,-247,-450,-156,-139,-56,-323,-161,-375,-500,-261,-239,-43,-172,-275,-233,-227,-178,-345,-874,-578,-812,-220,-708,-190,-498,-173,-322,-312,-246,-196
+HG2709-HT2805_at,124,256,336,186,242,366,312,412,333,121,53,51,134,347,299,183,54,129,38,365,189,81,-11,162,186,167,97,201,406,306,86,11,181,30,92,289,282,-15
+HG2714-HT2810_at,48,-65,15,86,55,-106,84,-13,31,70,39,-15,16,-79,47,87,-76,57,22,-54,57,122,-74,45,94,94,-136,-36,-64,26,126,101,86,65,-405,-98,-79,116
+HG2715-HT2811_at,1233,826,1307,960,386,938,873,941,1193,413,942,359,961,1080,341,469,715,698,662,1148,378,878,689,702,905,375,1140,777,1031,948,1462,1245,1252,287,804,633,1178,2130
+HG2723-HT2819_at,-23,-36,-261,-240,-68,-115,-149,-157,-142,-125,-152,-130,-37,-131,-11,-125,-190,-24,-37,-29,-68,-121,-34,-169,-108,4,23,-89,-108,-172,-318,-95,-186,-91,-131,-290,-187,-293
+HG2724-HT2820_at,-963,189,-720,-1019,-374,-364,-1090,-334,-778,677,-197,80,-259,-475,-130,-666,-916,-407,-442,-139,713,226,-77,-727,596,-71,-1076,150,-1091,456,766,2275,1186,432,1159,-247,-321,810
+HG2755-HT2862_at,-208,-155,-286,-153,-88,-177,-203,-38,-183,-129,-158,-146,-186,-174,-98,-108,-226,-152,-152,-254,-109,-194,-98,-122,-76,-46,-162,-181,-156,-179,-193,-165,-109,-54,-241,-163,-278,-370
+HG2788-HT2896_at,1215,2424,1253,1219,1390,947,697,655,4641,795,1350,1691,887,2764,969,787,1284,783,557,1002,518,447,522,972,769,1370,729,1822,1555,10319,3999,769,1595,1795,10452,2325,1548,2920
+HG2796-HT2904_at,316,-14,15,315,60,280,228,106,314,175,172,110,0,43,22,143,-10,0,75,39,121,69,269,-15,117,-14,563,426,329,28,-5,128,118,37,33,188,460,262
+HG2810-HT2921_at,293,205,245,476,150,183,846,188,141,175,168,93,187,181,159,188,574,186,129,70,131,122,134,1339,177,211,337,236,302,307,408,552,322,836,659,270,338,324
+HG2825-HT2949_at,366,296,84,606,423,167,608,328,121,119,21,87,241,302,256,108,942,80,80,444,-138,111,49,296,155,124,327,257,91,75,49,-247,140,2,8,439,355,-140
+HG2855-HT2995_at,1311,1696,1624,2585,3211,874,1308,727,3006,3219,2168,590,2607,1674,2249,2164,2083,688,1878,3497,2516,275,1405,2366,2009,1663,988,702,521,426,760,643,815,516,2510,570,494,385
+HG2873-HT3017_at,18100,23566,22382,23118,22720,18614,18842,22525,21840,20047,22786,22750,23136,22147,21947,21319,21486,20777,22334,19530,31569,24404,23216,23707,24663,20534,24656,23949,21088,20849,22603,21760,22073,26321,22318,24218,22886,24219
+HG2874-HT3018_at,371,731,577,528,505,521,589,539,1320,844,308,255,713,585,789,437,903,627,299,543,1113,307,573,526,166,554,485,580,266,651,404,469,460,261,340,567,592,543
+HG2936-HT3080_at,37,36,23,68,74,5,62,185,91,26,-11,83,55,60,79,26,96,91,44,66,-29,136,134,30,118,88,87,73,-14,37,79,36,133,-1,51,30,287,17
+HG2992-HT5186_at,18,729,-18,-151,323,220,-383,-757,580,223,388,67,77,288,262,191,562,277,99,818,342,213,476,51,706,332,510,407,252,579,130,193,99,151,401,-308,418,248
+HG3039-HT3200_at,1833,2334,2048,2246,1302,1207,2592,1388,1636,1171,838,1618,1990,807,876,1425,4133,1959,1701,1795,-53,1578,1584,1602,1689,1405,1403,2000,1305,2248,2013,1306,2228,22,2429,2273,2312,2714
+HG3063-HT3224_at,-387,-298,-280,-362,-282,-289,-319,-119,-222,-137,-200,-198,-152,-163,-158,-280,-281,-96,-226,-156,-208,-372,-237,-291,-150,-232,-417,-317,-271,-167,-265,-263,-285,-111,-230,-408,-204,-412
+HG3088-HT3263_at,81,378,148,110,267,65,226,229,174,99,183,117,177,146,195,142,201,14,125,904,72,37,138,200,238,60,-7,161,74,88,155,98,121,74,56,91,131,14
+HG3104-HT3280_at,-1289,-438,-1795,-2177,-683,-1285,-1952,-1652,-938,-980,-658,-1244,-816,-404,-837,-965,-1786,-572,-965,-246,-709,-1133,-1210,-887,-1156,-614,-2685,-1348,-1243,-1211,-2289,-509,-1452,-768,-2011,-1594,-1523,-1575
+HG311-HT311_at,7559,12458,9550,8056,12110,5729,5452,4497,14635,7447,6251,8181,5237,9273,10051,8534,5963,10393,6126,22543,12697,9304,6873,8861,10993,7501,8450,8285,6667,6750,11471,8285,10620,10430,10273,7238,6686,7610
+HG3111-HT3287_at,-21,27,-39,40,67,-7,-16,-20,-127,18,-19,-43,14,31,89,13,-47,-19,-7,12,54,-142,-45,-32,7,9,-15,-78,-57,-34,-13,-24,-58,-26,-98,-77,-36,-118
+HG3117-HT3293_at,-201,-114,-367,-238,-161,-156,-304,-190,-276,-309,-160,-179,-187,-156,-160,-263,-239,-171,-246,-261,-154,-311,-224,-102,-212,-220,-208,-338,-238,377,-90,-214,-250,-162,153,-252,-93,-200
+HG3123-HT3299_at,95,98,210,182,32,231,230,227,179,84,81,-31,143,-88,44,102,2,-34,63,164,136,196,70,-133,123,-50,-50,-180,-14,299,253,-9,153,-46,-102,325,154,402
+HG3132-HT3308_at,65,78,28,-138,94,-14,-10,-2,30,7,12,57,29,58,59,48,-9,71,79,17,1,-54,26,-31,6,15,-23,44,-2,58,59,89,55,33,-58,0,-1,64
+HG3137-HT3313_at,-68,-107,-119,-177,-51,-87,-122,-80,-45,-96,-72,-119,-38,-9,-63,-26,-51,32,-54,0,-54,-65,-41,-4,-75,-45,-120,-123,-151,-61,-101,-63,-69,-38,-98,-185,-58,-49
+HG315-HT315_at,420,124,247,319,114,250,482,268,340,193,189,232,87,232,131,248,83,264,126,107,34,342,241,170,66,78,132,285,295,406,326,65,214,-53,97,438,493,504
+HG3162-HT3339_at,741,497,1005,846,571,901,732,958,672,746,833,880,691,851,451,735,495,558,1013,835,499,827,778,464,293,476,1015,1286,976,727,1161,641,1022,508,930,1216,1493,1676
+HG3175-HT3352_at,347,351,343,650,205,391,547,223,305,392,11,267,209,208,83,364,70,116,263,107,188,238,378,354,236,237,966,111,187,596,161,78,347,61,553,468,562,168
+HG3214-HT3391_at,20707,20221,23830,20870,20273,25237,25070,17433,19280,22809,22984,22897,21275,21518,18258,21385,15782,20254,21606,15734,26210,26688,27307,24278,20606,20810,22897,21305,21463,22782,21281,23316,19216,18121,19628,22101,21521,20872
+HG3227-HT3404_at,254,263,213,355,313,176,139,473,223,164,101,451,177,49,-11,422,80,391,138,132,520,277,640,706,329,651,477,220,-24,452,2,-4,459,138,-9,134,320,601
+HG3231-HT3408_at,320,12,325,37,-32,85,228,194,247,175,89,-24,-30,228,-98,293,-5,105,239,-127,108,108,246,110,173,39,230,607,79,249,147,232,319,65,81,232,252,361
+HG3248-HT3425_at,57,50,123,133,30,-28,152,169,26,83,48,-12,52,58,25,80,80,65,48,-39,33,51,115,129,52,87,54,131,125,137,115,45,127,55,20,69,24,32
+HG3254-HT3431_at,263,210,318,184,234,120,173,232,271,178,136,130,187,197,180,336,514,180,150,260,176,151,176,239,135,219,353,329,139,267,380,349,370,206,391,294,383,439
+HG3255-HT3432_at,484,388,481,785,233,440,435,605,609,333,278,408,336,364,175,487,666,209,247,474,448,273,587,369,283,225,788,497,418,457,505,540,355,235,365,605,704,635
+HG3264-HT3441_at,118,-94,90,115,-174,181,144,-710,66,78,-42,2,-111,-54,-100,121,-44,-115,-392,-55,-402,-442,-250,-243,-234,-427,39,-319,-180,-286,-673,-201,80,-238,-21,66,62,-220
+HG3286-HT3463_at,-182,-142,-18,394,-129,-350,-275,1004,704,500,-521,-462,514,731,91,835,462,230,333,864,490,-340,-389,759,180,791,-372,788,709,262,236,746,377,709,-342,-877,-129,546
+HG3288-HT3465_at,170,46,145,201,83,42,112,223,104,73,112,94,60,151,32,86,146,46,123,171,-216,184,66,177,106,79,158,67,185,98,186,196,161,141,93,98,241,199
+HG3299-HT3476_at,-440,-476,-606,-660,-370,-371,-529,-605,-591,-258,-482,-277,-427,-529,-446,-286,-677,-482,-295,-475,-254,-464,-317,-412,-381,-362,-749,-640,-454,-555,-449,-311,-624,-267,-440,-591,-666,-867
+HG33-HT33_at,12801,15610,12642,13815,18906,8129,16562,12448,16869,14319,15791,20751,20684,15479,15934,13564,16902,13182,13508,16786,19284,12958,12805,15007,16465,14983,19145,18896,18412,14032,17149,14263,17246,17142,15318,16410,14178,17788
+HG331-HT331_at,-90,-117,-172,-133,-160,-172,-115,-20,-167,-222,-178,-76,-184,-117,-97,-83,-305,-143,-136,-131,-83,-200,-89,-133,-107,-130,-34,-122,-298,-238,-67,-99,-68,-111,-181,-180,-90,-201
+HG3313-HT3490_at,-231,-90,-212,-111,39,-181,-223,-260,-87,-62,-71,-90,-35,-144,-62,-19,-196,-182,-98,-36,-67,-234,-100,-88,-50,-77,-226,-127,-324,-39,-68,-74,-20,38,-58,-211,-92,-123
+HG3344-HT3521_at,381,404,238,439,309,293,359,106,355,-44,47,181,360,351,24,49,312,210,141,530,-32,171,429,35,112,94,463,461,-50,876,652,628,405,107,743,-83,172,448
+HG3345-HT3522_at,-62,-91,-36,-107,-24,-103,-129,-19,-49,-176,-69,-96,-87,-128,-140,-96,-265,-62,-92,-122,-71,-138,-127,-77,-81,-8,51,-160,-81,-201,-17,-73,-121,-87,-217,-175,-69,-286
+HG3355-HT3532_at,2307,1508,2488,2484,864,1331,2461,2081,1568,1333,847,732,1327,1249,646,2036,2293,1505,1242,2241,557,1794,1278,1499,766,1666,2883,2054,1825,2363,1290,1288,1827,488,945,2319,1790,3314
+HG3364-HT3541_at,19899,22408,23054,22312,22697,19133,19288,13009,20947,21263,22476,23700,20523,22500,20416,23722,16652,23999,25492,18327,30075,23281,22031,23648,20841,23139,22650,23187,25320,21628,23198,23869,21146,23424,19087,21469,20247,20561
+HG3369-HT3546_at,-84,49,-50,68,21,8,-104,77,-37,45,-2,12,-157,-47,-37,109,-122,-39,18,63,-143,13,3,-233,-23,-71,84,32,-271,-13,65,-16,-12,-2,56,15,-86,-111
+HG3400-HT3579_at,-785,-759,-1531,-923,-650,-857,-954,-845,-822,-870,-624,-684,-757,-676,-782,-768,-650,-689,-673,-876,-427,-859,-754,-500,-835,-634,-1292,-862,-687,-788,-1506,-1081,-833,-595,-1060,-998,-971,-1688
+HG3405-HT3586_at,110,79,27,74,46,-8,11,44,52,42,63,-37,31,28,22,113,40,79,31,93,-84,18,47,41,36,90,76,157,-4,62,67,126,76,83,41,22,187,155
+HG3415-HT3598_at,135,110,157,251,49,277,203,-61,239,101,178,50,79,136,-5,401,97,-23,46,-38,-81,154,100,172,98,1,112,22,76,45,103,242,39,47,128,319,174,69
+HG3432-HT3618_at,141,136,265,-37,192,-48,95,-175,428,157,-36,60,283,59,27,18,259,103,250,229,53,32,9,180,-26,-149,21,-51,0,170,237,62,67,-49,126,-102,112,167
+HG3432-HT3621_at,-23,32,138,11,68,48,-6,143,148,68,124,8,124,36,-33,81,131,32,27,113,66,58,26,142,60,60,367,14,28,109,-23,111,18,7,-85,-7,12,-4
+HG3454-HT3647_at,393,413,493,414,291,392,712,473,317,577,279,303,350,594,278,360,327,305,330,357,238,337,378,465,264,482,962,601,678,796,622,398,387,175,600,693,819,804
+HG3477-HT3670_at,-725,-451,-955,-937,-406,-124,-1332,-778,-1290,-556,-819,-316,-395,-537,-323,-433,-602,-491,-461,-363,-347,-529,-588,-664,-477,-491,-981,-829,-454,-410,-871,-651,-775,-542,-168,-296,-605,-1553
+HG3492-HT3686_at,2434,1846,2715,2161,1065,1557,2144,1856,1985,1712,1897,1438,1797,1770,1073,1821,2655,2061,1197,3375,2342,2057,1548,1927,2255,2355,3609,1976,630,2587,1644,1682,2011,760,2163,1856,1705,3094
+HG3494-HT3688_at,223,1074,148,-53,353,421,102,28,272,367,88,426,220,213,130,30,323,-38,102,1070,199,-171,117,-132,395,290,-39,80,149,2670,2327,460,2972,1017,3369,230,861,2236
+HG3495-HT3689_at,-123,-168,108,8,52,-60,-188,-139,-185,-159,-160,-81,-78,-114,-49,-186,-228,-46,181,355,33,-19,-205,-109,172,-83,-248,-179,-67,-81,232,641,-113,74,110,-138,-215,235
+HG3502-HT3696_at,-14,-11,253,13,20,-51,110,4,10,-8,52,99,4,24,9,24,-45,35,-31,5,31,-60,-49,-118,-36,65,61,-49,-108,62,140,-80,-7,1,-45,103,-12,53
+HG3510-HT3704_at,21,68,17,59,63,-48,28,118,139,12,-83,40,2,89,46,-24,313,29,-23,48,-31,-37,39,59,-12,77,244,-65,0,116,10,93,103,-6,144,-62,4,51
+HG3514-HT3708_at,4281,7832,5474,4225,5452,2950,2659,2635,8516,4536,5841,3509,5468,5232,4294,3221,10913,2338,3202,7814,2086,3771,1886,3467,3644,4558,2345,5637,3354,7061,5296,2487,4044,4436,7580,7093,6403,5319
+HG3517-HT3711_at,76,-28,200,170,41,165,168,244,133,-33,82,93,-17,87,-71,66,124,97,46,-295,44,57,-32,39,25,-21,219,59,192,359,28,148,194,-21,182,184,91,246
+HG3521-HT3715_at,830,1302,2098,1039,1607,832,488,1439,2343,1056,1175,479,827,1278,1109,970,2394,482,686,2535,228,625,545,945,895,350,597,847,343,1427,1412,627,1360,1198,2152,684,1224,1768
+HG3548-HT3749_at,44,207,61,154,252,334,-73,-446,988,239,147,127,-20,-138,338,142,731,30,101,537,633,85,68,293,208,68,-248,-72,122,336,44,-102,277,51,33,-7,368,173
+HG3549-HT3751_at,24223,21103,22425,21932,23271,18656,16142,17742,22447,24062,23786,26879,27162,21210,20978,22743,21766,21607,22198,22274,6578,25044,20805,21634,21851,24751,23303,21513,19688,20721,21692,20693,20803,20488,22054,21572,18664,21921
+HG3566-HT3769_at,2639,1081,3472,3414,1403,1708,2764,1836,2318,1410,1093,1320,1886,967,1473,1824,2925,1694,1369,2185,1705,1902,1472,2521,1544,2055,2627,2880,2702,3210,2099,1699,1833,1339,1765,2404,2162,3979
+HG3570-HT3773_at,-341,410,-20,-1107,-327,-1132,-1255,-647,265,-780,-721,-392,-457,-91,-350,-571,18,-27,-479,-681,324,-745,-252,-147,-165,-15,115,-419,-490,-1197,373,-205,193,-107,-169,-1383,-1177,453
+HG3578-HT3781_at,479,654,496,1138,249,787,620,629,499,649,333,561,459,820,846,567,928,399,347,640,592,655,995,354,506,400,805,362,331,703,888,517,304,275,226,497,841,1032
+HG358-HT358_at,622,606,747,580,267,609,867,857,636,350,383,294,360,505,306,358,876,383,509,716,278,493,607,396,429,395,943,626,978,545,843,719,603,512,689,756,681,1305
+HG3627-HT3836_at,363,229,574,429,72,483,299,200,561,83,391,237,143,215,105,-42,164,131,147,229,152,545,144,-75,-7,44,264,-45,452,634,56,-228,411,-25,314,277,535,-20
+HG363-HT363_at,853,380,1750,661,569,839,514,787,607,118,467,494,173,828,206,379,300,364,563,775,84,737,279,501,726,585,973,829,543,1045,1007,965,523,39,760,855,1138,957
+HG37-HT37_at,179,189,286,215,252,200,102,49,140,148,295,24,138,195,207,153,191,26,62,95,211,238,77,153,72,1,97,190,62,138,26,42,13,70,224,181,146,112
+HG3733-HT4003_at,-198,-77,-372,-102,-103,-211,-119,-149,-92,-60,-156,-30,-200,-298,-146,-112,-155,-186,-32,-13,-358,-74,-87,-243,-283,-200,-103,-325,-663,-89,-144,-72,-1,-143,-79,-291,-151,-270
+HG3740-HT4010_at,449,594,735,707,309,602,472,434,407,118,221,125,101,542,239,320,483,542,94,237,62,139,438,366,406,329,690,568,108,723,501,417,398,93,389,359,395,985
+HG3748-HT4018_at,32,130,234,302,527,270,134,-44,160,182,-22,15,195,548,320,-5,267,77,214,466,-122,51,212,921,146,23,25,-156,-100,-150,-167,270,61,-39,40,238,126,-123
+HG3790-HT4060_at,-40,-124,-164,-177,-102,-124,-349,-113,-49,-148,-35,-107,-125,-110,-68,-93,-45,-67,-73,-148,-168,-94,-165,-94,-55,-128,-317,-150,-98,-152,-328,-152,-70,-51,-186,-147,-174,-191
+HG384-HT384_at,9070,10080,8602,10631,10013,7576,7952,3054,10075,7915,10758,8073,9504,10811,5935,10336,6060,10144,10014,12858,15248,9141,8705,11627,7298,9225,8950,11390,9551,7417,10724,11413,10045,6015,10342,8469,10522,10228
+HG3872-HT4142_at,-131,-97,-224,-183,-1,-115,-373,35,-112,-182,-170,-125,-185,-194,-100,-106,-126,-39,-82,-117,-17,-196,-125,-23,-135,-185,-150,-206,-93,-324,-78,-129,6,-107,-192,-206,-283,-111
+HG3884-HT4154_at,83,184,-4,-29,0,-149,-317,-22,186,-114,227,40,10,10,-188,34,293,39,-58,281,186,-36,-186,-18,-81,66,173,-413,-351,268,-237,76,-4,29,-526,-198,-261,134
+HG3893-HT4163_at,25,109,11,-102,5,19,70,277,76,194,53,109,32,134,11,111,252,73,-4,110,-9,-65,53,58,131,96,-12,59,57,32,178,116,98,-26,201,204,182,-112
+HG3897-HT4167_at,146,-21,75,10,-59,28,-100,127,11,112,-57,-51,37,3,-35,299,-55,28,7,233,-29,-56,-41,-30,28,58,29,11,-45,-75,86,148,2,57,-8,-36,11,83
+HG3930-HT4200_at,165,123,133,-151,52,67,25,83,250,12,56,21,-33,-63,-70,44,95,-78,20,6,-148,-19,178,-7,18,42,203,-7,38,-26,135,118,-133,-49,88,82,-25,-17
+HG3934-HT4204_at,26,454,122,582,18,554,154,440,379,501,80,350,327,238,335,298,917,339,250,535,161,14,518,514,49,568,434,46,163,83,130,130,-3,266,543,644,135,311
+HG3936-HT4206_at,276,226,735,260,401,197,42,281,241,233,310,211,178,251,364,439,415,435,310,397,684,243,229,531,406,357,322,185,478,150,285,422,172,223,-9,107,246,433
+HG3942-HT4212_at,-605,-987,-1015,-1033,-155,-858,-1107,-911,-886,-346,-570,-707,-531,-706,-464,-336,-476,-439,-395,-311,79,-554,-944,-449,-368,-438,-1502,-53,-553,-1112,-999,-383,-708,-379,-756,-1117,-976,-407
+HG3945-HT4215_at,-364,-235,-707,-325,98,-528,-305,-913,-372,-153,-168,-365,-70,-403,-131,-31,-271,-97,18,544,-298,-155,-379,-224,-246,-244,-868,13,-76,-280,-345,-448,124,155,-2,456,22,-459
+HG3962-HT4232_at,-283,-659,-945,-931,-304,-554,-1193,-806,-839,-361,-333,-559,-295,-331,-260,-307,-893,-314,-277,-408,-204,-719,-1025,-789,-339,-381,-1006,-894,-1041,-505,-1029,-704,-825,-279,-750,-744,-560,-1154
+HG3971-HT4241_at,424,188,501,217,150,268,331,314,358,221,126,229,158,256,143,190,161,229,143,259,199,275,104,162,167,124,289,257,79,43,261,155,94,34,192,368,332,362
+HG3976-HT4246_at,167,95,78,213,64,-10,173,214,144,60,37,86,92,143,146,160,167,95,119,70,-6,49,75,95,49,146,181,83,113,44,181,72,98,29,127,82,98,131
+HG3985-HT4255_at,-103,27,-372,-108,-147,-131,-184,14,-74,20,-95,-63,-113,-172,1,-109,-82,-138,6,-66,-82,-65,-189,-56,-117,-42,50,-172,156,-125,26,-52,-98,31,-20,-207,-107,-24
+HG3987-HT4257_at,-748,-197,-327,59,83,-170,77,380,680,144,140,-201,354,-137,477,110,1010,599,408,411,732,104,-341,-214,-60,-173,1977,544,-4,802,-902,-266,-559,-363,302,-20,129,394
+HG3989-HT4259_at,181,37,-156,-71,76,-88,-45,-127,-89,101,-35,28,-104,76,0,-54,26,83,21,-127,-16,88,62,103,-25,-2,-23,-11,100,3,-62,-56,-88,-81,-68,-96,76,-31
+HG3992-HT4262_at,153,24,95,413,148,154,25,341,20,-142,194,218,91,112,263,-212,98,108,59,-183,62,37,150,71,361,-185,-301,-14,129,-5,336,219,19,114,274,427,397,84
+HG3993-HT4263_at,-601,-494,-606,-607,-444,-339,-663,-518,-584,-358,-359,-461,-393,-484,-500,-405,-463,-263,-382,-702,-323,-422,-583,-573,-394,-477,-583,-536,-557,-608,-533,-375,-515,-322,-612,-580,-645,-524
+HG3994-HT4264_at,967,372,755,1023,400,314,998,473,510,512,372,303,475,328,361,585,511,385,325,602,524,404,414,517,561,522,619,495,786,330,1108,656,475,344,289,485,582,838
+HG3995-HT4265_at,1574,778,305,1334,891,1109,1369,946,419,1140,880,924,811,1047,833,1179,780,935,705,463,802,1319,1255,987,993,943,1054,1338,1257,-167,-106,1046,472,506,1057,1542,378,1003
+HG3998-HT4268_at,51,-160,-156,-151,-14,-202,15,-19,116,-79,-80,113,-68,61,50,92,-27,-1,-32,13,172,60,-70,-32,-58,12,-54,-93,-72,-212,-93,-89,26,-67,-172,-66,-216,-101
+HG3999-HT4269_at,-777,-592,-1242,-1042,-339,-661,-1001,-821,-758,-722,-557,-622,-869,-497,-603,-583,-822,-435,73,-41,-673,-360,-568,-477,-301,-663,-1326,-647,-411,-778,-41,-252,-516,-193,-837,-960,-748,-858
+HG4018-HT4288_at,513,376,174,133,119,80,248,293,495,423,340,182,246,315,57,275,430,163,500,748,142,240,140,203,237,125,441,475,175,522,918,743,256,287,480,329,569,1300
+HG4036-HT4306_at,2246,1844,2967,1715,856,2165,2095,758,1135,1204,989,781,967,2186,1061,974,959,1694,475,2426,888,1323,1333,1215,685,1544,3195,3251,1348,1260,1203,1865,929,233,904,1211,2072,1877
+HG4051-HT4321_at,9,5,-75,-95,-8,-71,-159,-89,19,21,99,-79,13,4,34,-55,78,81,3,95,12,52,18,-19,59,91,-43,-27,-187,-126,139,34,-8,-27,-112,-27,10,139
+HG4052-HT4322_at,-219,-202,-158,-220,37,-204,-132,182,-86,-86,-161,-31,-43,-123,-30,78,-7,41,32,-128,16,-98,-317,27,43,-30,-337,-35,-33,-100,-201,-63,81,-38,-93,-243,-210,-369
+HG4058-HT4328_at,17,4,-54,29,-28,40,-13,1,24,4,-13,-2,5,-2,-13,36,122,14,28,-61,42,22,-13,-58,-86,-20,-9,4,12,-107,212,111,84,444,-52,66,9,-35
+HG406-HT406_at,351,378,312,369,170,435,403,452,395,283,195,241,366,298,383,647,535,384,409,471,287,534,391,423,309,377,270,349,346,382,848,419,522,423,314,266,428,635
+HG4068-HT4338_at,395,402,106,1463,-143,277,189,175,399,-157,214,366,230,42,506,-180,519,178,145,388,712,-56,685,-267,841,213,347,-250,168,-322,130,-162,-51,257,226,302,264,714
+HG4073-HT4343_at,665,677,1447,549,605,577,475,275,2004,810,791,346,844,732,696,637,593,710,393,837,614,381,495,836,413,589,513,479,367,555,546,575,476,330,607,622,444,453
+HG4074-HT4344_at,447,314,923,403,608,537,213,124,838,265,474,185,1174,591,1418,346,736,555,462,624,339,188,347,639,225,389,372,147,144,298,446,307,524,438,102,350,162,611
+HG4102-HT4372_at,242,134,153,473,354,192,198,245,256,107,98,116,174,165,319,181,525,150,133,196,32,173,102,264,156,151,223,235,226,171,266,202,188,13,196,139,326,225
+HG4114-HT4384_at,679,650,975,866,469,736,821,907,942,580,523,505,536,595,441,555,1242,543,463,348,605,738,583,716,441,461,1162,949,848,723,760,750,903,251,575,740,831,1229
+HG4126-HT4396_at,117,15,94,161,7,44,87,148,97,-22,-26,12,157,260,282,-124,337,0,14,634,178,61,47,135,25,8,126,-133,36,-50,-23,-103,-37,-41,-14,2,19,-18
+HG4128-HT4398_at,-263,-67,136,-209,-103,209,-110,-311,125,549,111,-125,-138,-51,-34,-62,-136,-85,-134,-255,-48,-139,210,-23,-135,-88,-179,-122,-122,-207,-302,-195,-87,-51,-188,-364,-86,-361
+HG4144-HT4414_at,-19,-36,-127,-208,-112,-35,-80,-55,-35,-97,8,-47,-91,-85,-8,-86,-100,-51,-109,-118,-81,2,-9,-68,-69,-21,4,-110,-31,-50,-110,-59,-88,-59,-306,-36,-82,-79
+HG415-HT415_at,-136,93,-512,-565,-79,-261,-421,-503,116,-252,-13,-262,194,-297,-120,-191,194,330,-229,-178,-454,-69,-298,-160,126,-284,-272,-283,-336,-76,-185,-65,-359,-137,246,58,-321,-279
+HG4157-HT4427_at,152,77,182,106,213,142,117,97,148,71,33,110,176,121,126,147,159,116,91,268,112,109,98,170,135,111,115,158,84,119,120,36,137,39,79,61,101,153
+HG4165-HT4435_at,-74,21,-128,-160,106,-88,-65,-175,77,-3,73,15,16,-27,68,-135,-6,-3,6,-43,129,-26,-138,-80,-14,-13,-181,49,-64,34,-111,-176,0,95,12,9,-27,55
+HG4167-HT4437_at,618,352,536,320,316,394,458,524,351,403,360,171,291,316,312,419,457,276,269,444,152,394,180,482,300,413,356,562,420,572,684,742,362,87,324,486,345,822
+HG4178-HT4448_at,225,159,126,114,73,654,215,119,135,112,112,127,70,174,104,139,40,10,-176,48,-12,27,353,77,176,93,208,251,91,120,154,-110,71,113,132,122,700,151
+HG4185-HT4455_at,334,131,364,180,172,40,184,214,225,74,180,84,153,171,96,138,215,156,98,79,58,170,197,252,122,194,162,200,192,202,239,232,195,50,43,162,152,271
+HG4188-HT4458_at,-350,-201,-619,-216,-340,-362,-389,-352,-349,-147,-312,-251,-211,-316,-152,-190,-121,-288,-263,-168,-209,-290,-410,-355,-173,-120,-186,-395,-413,-379,-482,-225,-489,-145,-141,-557,-385,-460
+HG4194-HT4464_at,-202,14,474,105,116,26,-13,-112,57,15,10,-194,-158,-16,-83,128,107,16,95,66,58,-45,-254,-334,59,-157,-98,289,-204,-19,-120,82,-305,33,-38,-138,-33,-126
+HG4234-HT4504_at,315,136,325,224,123,151,443,8,260,83,137,83,71,39,88,184,109,343,23,124,-89,96,180,140,161,221,261,222,-96,198,84,445,295,81,464,158,191,492
+HG4243-HT4513_at,286,553,905,372,76,263,233,158,617,327,300,191,239,179,353,526,362,376,99,460,231,445,129,363,158,334,1095,316,127,580,115,687,347,436,195,228,199,751
+HG4245-HT4515_at,-19,11,-33,-40,-47,0,-52,-35,0,-36,-49,0,-11,1,-6,-74,-42,-4,6,20,-94,2,-89,-15,-24,-13,-18,-26,-86,-23,-5,-13,2,19,-229,1,-84,-61
+HG4258-HT4528_at,-129,124,85,79,90,-165,-23,-106,98,351,97,20,123,-149,36,136,42,49,118,383,-4,3,131,-104,44,43,147,-7,-108,-146,60,122,117,115,56,-71,75,-61
+HG4263-HT4533_at,-145,-71,-209,-287,-36,-40,-277,-107,-121,20,-127,-76,-73,4317,-55,-162,-310,-54,-13,-96,-89,-95,-191,-232,-93,-102,-208,-128,-173,-263,-231,-102,-138,-94,-159,-215,-256,-291
+HG4272-HT4542_at,936,578,1096,688,315,602,897,1193,866,747,745,525,666,723,593,754,1343,670,466,986,460,646,856,776,720,645,1242,971,788,1060,934,679,843,484,699,949,965,1175
+HG429-HT429_at,32,10,66,1,9,71,3,209,39,12,95,63,2,90,39,26,47,29,-10,-28,32,87,36,89,23,28,68,39,-21,-17,38,119,75,-26,36,-1,19,50
+HG4297-HT4567_at,928,3045,1829,822,1681,1015,448,461,1551,1002,1647,600,890,1406,1717,735,1734,2624,661,3278,2361,517,750,1381,600,574,445,606,257,1155,1194,892,799,1654,1492,1037,665,637
+HG4310-HT4580_at,-255,-195,-471,-476,-3160,-304,-446,-250,-245,-235,-199,-212,-61,-105,35,-235,-219,-211,-184,-105,-168,-91,-161,-149,-190,-175,-327,-442,-550,-455,-220,-289,-402,-82,-291,-476,-287,-419
+HG4316-HT4586_at,-431,-329,-562,-533,-203,-355,-541,-628,-284,-268,-326,-201,-310,-347,-255,-302,-626,-176,-266,-283,-204,-404,-216,-311,-358,-320,-607,-484,-464,-418,-409,-527,-443,-218,-474,-418,-438,-393
+HG4319-HT4589_at,13924,25285,15794,21231,22273,14846,13050,18936,21792,13129,21920,19431,15106,22760,21306,15203,26584,19346,18615,23965,26106,19140,19709,22320,17889,15369,24531,22409,14490,15286,20108,25056,19945,21146,25008,21725,20287,16638
+HG4321-HT4591_at,-64,-87,-98,-90,174,-92,0,-175,-68,-108,-127,-48,-182,-1,-83,-94,191,41,-91,-29,-9,-74,-72,-95,-69,-91,-37,22,21,414,54,102,107,-107,532,248,38,238
+HG4332-HT4602_at,1092,840,1519,1275,592,992,1209,1932,1221,891,675,942,715,903,655,748,2226,763,618,909,748,982,925,1022,803,835,1733,1409,1433,1232,1127,1046,985,528,1209,1202,1111,1457
+HG4333-HT4603_at,323,430,281,126,244,-122,280,149,-12,-207,-33,37,251,4,272,293,107,313,-134,170,-143,342,58,-139,1,274,190,-26,-286,541,123,348,-31,207,216,193,526,582
+HG4336-HT4606_at,539,288,579,550,224,446,488,691,434,349,351,267,260,404,242,339,538,304,311,268,217,405,381,493,266,490,489,562,615,409,457,337,379,150,406,499,612,536
+HG4390-HT4660_at,80,418,74,33,51,56,72,52,-20,1,384,-12,170,166,150,-68,325,83,-22,161,199,150,-26,85,-19,141,10,461,120,67,176,60,2,182,66,39,196,36
+HG4411-HT4681_at,-478,-191,-587,-479,-138,-398,-294,-263,-592,-293,-351,-399,-276,-157,-401,-499,-658,-137,-412,-283,-132,-189,-340,-331,-164,-129,-494,-549,-250,-85,-308,-226,-429,-165,-269,-273,-359,-525
+HG4433-HT4703_at,-100,-146,-431,-593,71,-462,-381,-352,-340,-126,-177,-399,-122,-201,-298,-365,-188,2,-176,9,-37,-51,-516,-233,-99,-71,-236,-375,-151,22,-359,-248,-224,-151,-88,-412,-311,-357
+HG4458-HT4727_at,-91,-70,-55,-132,-13,-64,-107,-77,-65,-86,-48,-125,-5,-47,-29,-78,-65,-27,-88,-77,-37,-43,-79,-76,-51,38,-142,-26,-91,-51,-47,-99,-45,-2,-32,-88,-62,-54
+HG4460-HT4729_at,121,14,33,207,131,-183,176,286,-39,-119,-9,80,-53,-117,253,198,-125,995,-51,102,136,540,68,242,-41,167,151,207,33,-95,85,16,192,-1,-84,-58,-895,236
+HG4462-HT4731_at,-79,-164,-63,29,-107,17,-42,-71,76,-134,38,-48,-130,-14,10,-110,-215,-54,-74,-115,82,-77,72,-182,-1,-131,3,-123,-96,-93,13,-83,-14,-73,-77,37,-270,55
+HG4480-HT4833_at,-447,-340,-467,-569,-180,-720,-841,-488,-148,-265,-224,-311,67,189,-148,-236,-126,-112,63,-26,-164,-461,-522,-265,-188,-118,-622,103,-204,80,48,-104,-210,-134,33,-566,-88,-368
+HG4533-HT4938_at,640,373,1138,462,411,376,789,520,556,439,480,356,412,319,255,376,754,505,256,458,377,439,319,516,385,525,949,692,529,706,614,509,644,286,425,642,600,878
+HG4542-HT4947_at,11003,12850,12401,10988,14453,7754,10234,9339,14765,9213,12541,11095,7957,12275,12432,10574,10255,11376,8963,16110,7424,11982,7838,13399,11475,9819,8186,12539,7538,11363,12787,12833,12809,9036,13525,10484,11931,10756
+HG4582-HT4987_at,244,101,30,301,274,44,1211,322,123,64,269,126,556,206,334,313,138,116,751,1873,493,213,104,1135,76,128,6,-14,14,119,69,6,58,59,-3,-49,-20,123
+HG4606-HT5011_at,491,346,634,478,448,344,831,610,676,442,575,350,512,714,504,407,686,339,400,505,26,243,296,488,345,241,397,402,466,637,523,540,616,230,312,494,567,772
+HG4638-HT5050_at,-396,85,-117,-473,187,119,603,-673,420,-137,510,-224,-175,121,143,-270,-245,-282,-156,176,-298,179,-32,527,-199,-320,-1561,-462,-536,485,-449,-344,114,-359,-588,-497,-370,92
+HG4660-HT5073_at,517,388,749,797,346,517,683,670,605,132,306,477,325,314,173,294,134,402,240,237,303,219,573,497,266,382,337,336,406,376,487,317,529,114,294,483,478,516
+HG4662-HT5075_at,-39,-309,-127,-381,180,32,-60,757,295,-6,-56,310,167,239,-72,-51,62,26,159,84,73,-41,-70,-87,-95,-250,114,198,-185,-112,-68,-206,-296,-134,954,39,-631,-74
+HG4704-HT5146_at,240,299,293,65,43,200,304,70,257,239,197,60,49,183,150,227,176,190,136,73,66,112,72,56,170,25,400,264,76,364,66,221,245,123,525,230,276,484
+HG4716-HT5158_at,204,842,766,433,592,631,416,47,1321,1068,575,343,622,525,887,268,394,811,951,1214,667,188,590,727,255,289,65,288,175,870,883,872,515,913,643,368,161,339
+HG4724-HT5166_at,296,199,-173,-164,-3,129,-277,-410,259,-119,56,-27,66,231,53,-40,-249,23,-149,-9,-91,103,-222,264,443,57,-164,-60,-230,-268,-223,204,-14,114,132,108,137,-192
+HG4740-HT5187_at,11,-21,106,83,16,-58,-126,2,-36,-77,-74,-94,15,-138,-26,-88,-146,-8,-22,-109,-138,35,-284,-26,120,-79,100,-226,7,-77,85,-44,-105,23,-68,-171,-129,71
+HG4747-HT5195_at,-104,-4,53,58,323,71,68,-143,81,160,130,114,122,205,296,2,-14,91,21,244,-82,-125,17,26,-10,-30,-40,-208,-40,-19,133,-82,149,193,145,158,-16,-188
+HG4749-HT5197_at,260,-128,731,40,322,101,144,-64,22,12,-12,25,60,-61,-17,36,246,433,-95,65,237,151,-376,59,170,147,794,-158,-206,73,-133,82,123,-61,34,96,65,163
+HG511-HT511_at,76,373,436,260,4031,309,162,164,401,132,313,143,95,298,264,271,334,290,117,440,-3,36,220,213,116,170,128,92,28,352,242,187,250,81,228,329,247,-3
+HG537-HT537_at,-239,-241,-394,-236,-96,-167,-47,-509,-207,-71,-162,-178,-137,-259,-256,-86,442,17,-178,-404,-374,-188,-402,-115,-66,-16,330,-665,-591,-204,-287,-369,-130,-275,-231,-183,-249,-161
+HG544-HT544_at,-2820,-3276,-3675,-3361,-1706,-2766,-3537,-4374,-3493,-2100,-2403,-2392,-1911,-2527,-2496,-1403,-4941,-1142,-2243,-3329,-1089,-2981,-2695,-2205,-2744,-1281,-3007,-1941,-2387,-1542,-3265,-4260,-3519,-2039,-3371,-3014,-3054,-4057
+HG613-HT613_at,11216,15296,12911,14866,17193,9618,10481,13639,14621,14909,15308,16309,17841,14996,15507,16152,14263,14316,15996,17978,20045,14275,14087,16466,16188,16364,17153,16367,14769,13529,14877,14306,14349,15612,12776,11021,14373,13456
+HG620-HT620_at,877,333,7,755,357,232,500,380,10,112,43,1360,1916,239,877,334,386,137,408,563,713,1884,134,415,1628,347,373,491,413,2897,2611,652,463,900,2208,650,703,2016
+HG64-HT64_at,147,135,589,111,29,40,211,341,105,188,38,41,23,62,18,21,211,64,102,22,118,86,262,55,139,99,306,108,247,135,-52,106,254,59,158,155,164,52
+HG644-HT644_at,-189,-404,-585,-408,-30,-133,-349,-419,-446,16,-140,-379,-130,-208,-44,-102,-214,-35,-120,8,-38,91,-100,-295,-55,37,-92,-28,-204,-153,-283,-216,-163,30,-188,-633,-291,-220
+HG662-HT662_at,4767,5058,6013,6422,8842,3739,3952,3805,9011,6770,6400,4338,6551,5968,6190,6270,7589,4520,5904,15775,13058,5694,4512,6208,6211,5844,6444,9472,4371,5734,6891,6271,8655,7814,9680,5187,6262,9223
+HG668-HT4793_at,-74,77,-49,-146,-12,8,-26,-163,-135,-59,-52,-12,-68,185,-131,100,-145,-15,-1,-40,-77,10,193,-63,80,-79,-143,-205,-81,-23,-132,-124,-64,-49,-85,-30,-84,-21
+HG732-HT732_at,215,135,94,49,76,193,231,178,240,70,145,127,12,197,-46,75,-9,144,-24,-74,14,160,271,135,120,-44,4,130,139,105,187,186,154,75,58,107,4,277
+HG742-HT742_at,-227,-40,-431,-266,-104,-396,243,-130,-255,85,-235,-211,-89,-182,-256,130,-100,205,154,117,-134,-133,-229,-152,-6,137,-136,-343,19,-202,-28,47,-254,-19,-203,-238,-183,-13
+HG821-HT821_at,14255,15210,16774,15804,17521,16597,18557,9859,16056,14826,17018,16362,12715,15810,13717,14963,14811,14980,14262,16053,20306,17695,17513,16138,15090,11923,17557,16024,12181,16265,15088,15674,14889,17065,15794,15868,12537,16051
+HG825-HT825_at,-397,-356,-857,-398,-192,-480,-280,-664,-609,-527,-425,-132,-484,-450,-311,-444,-508,-342,-473,-570,-332,49,-353,-206,-420,-449,-525,-649,-771,-643,-570,-449,-471,-242,-542,-584,-440,-671
+HG830-HT830_at,875,917,841,912,218,714,1048,622,662,529,484,538,367,657,466,480,276,368,491,368,552,231,642,664,620,401,500,914,961,546,986,761,824,454,489,788,794,1167
+HG831-HT831_at,240,187,257,39,147,209,107,181,203,161,159,58,147,125,34,75,295,222,54,135,92,108,108,107,137,107,222,223,170,218,42,213,292,62,227,-15,113,273
+HG846-HT846_at,789,627,1104,679,367,633,746,559,499,772,810,566,384,785,590,768,553,308,259,465,292,527,571,542,477,489,691,864,454,854,326,188,595,175,559,665,817,614
+HG870-HT870_at,-1,-135,-138,13,-8,-42,-178,-44,-131,-12,-148,-125,-39,-47,3,-47,-99,21,12,17,-113,-81,-53,-77,-65,-100,-57,-62,-137,22,74,44,-53,10,-48,-115,36,-126
+HG896-HT896_at,-278,-253,-144,-65,-44,-220,-265,-424,-453,-150,-130,-179,-119,-170,-188,-175,-322,-65,-152,-250,-96,-238,-172,-308,-39,-157,-372,-267,-336,-106,-334,-141,-229,-31,-321,-96,-339,-273
+HG907-HT907_at,-381,-221,-79,-635,-234,-647,-3501,-971,-21,-586,-651,-419,-358,-548,-510,-1017,-1549,-1056,-1131,-137,-1249,-1671,-313,-756,-1284,-1344,-3731,-525,-1428,-323,-272,-219,-112,-21,-1079,-1168,-483,119
+HG908-HT908_at,288,345,637,179,454,250,347,493,539,332,283,260,499,371,225,290,325,437,334,452,234,448,218,142,474,260,480,429,182,832,717,588,536,230,294,364,284,998
+HG909-HT909_at,-41,209,218,392,166,37,78,-1,285,167,290,153,224,374,-43,91,125,64,205,418,187,68,-93,67,222,-15,-93,297,72,144,-152,284,355,230,131,-226,385,507
+HG919-HT919_at,22,354,1096,566,292,522,307,818,778,634,551,498,753,520,114,32,359,294,198,330,72,228,598,247,606,142,287,696,529,438,313,327,661,209,428,630,982,492
+HG921-HT3995_at,-40,-136,-70,128,-38,42,166,-43,-148,-187,-294,-4,-139,-146,-58,-165,-152,-163,-47,-254,12,-211,45,-50,-191,-74,-23,-145,-134,144,-88,-257,-123,-13,-48,-146,-142,-109
+HG960-HT960_at,541,378,456,476,214,512,620,722,592,349,428,412,298,428,332,407,739,295,313,433,352,428,490,539,532,292,694,631,437,678,664,314,461,305,362,549,757,725
+HG961-HT961_at,-325,-343,-256,-242,-110,-334,-579,-475,-462,-310,-277,-298,-115,-274,11,-87,-161,-389,-211,-43,-284,-498,-208,-65,-36,-290,-366,-397,-516,-82,-203,-78,-183,-29,-414,-417,-305,-193
+HG987-HT987_at,206,215,-19,4861,2360,35,4869,268,108,90,87,829,260,139,2296,2334,482,68,1333,647,3064,459,100,4385,726,378,787,2463,2176,2522,2007,149,1442,1942,5090,1549,2324,1760
+J00073_at,607,289,720,1523,787,467,645,836,669,479,391,488,491,676,349,358,1125,596,842,864,737,360,1248,562,678,570,837,1014,997,719,1039,736,493,887,538,698,1085,818
+J00123_at,56,62,62,141,50,62,173,97,109,56,97,20,-71,94,8,21,266,-154,50,148,-71,122,163,-30,103,-105,159,206,98,200,124,218,119,29,129,111,180,-81
+J00124_at,225,194,221,443,116,128,120,187,95,292,167,307,312,158,326,486,357,146,63,268,61,173,332,229,233,356,506,152,79,140,375,426,328,138,173,96,211,55
+J00129_at,89,190,273,150,128,225,241,506,246,147,198,135,128,210,183,156,362,178,186,146,98,228,207,143,206,199,413,171,81,257,293,304,115,99,207,100,272,241
+J00287_at,-519,-808,-783,-1047,-323,-780,-761,-1451,-867,-357,-473,-712,-492,-748,-509,-261,-588,-293,-305,-1,-460,-835,-710,-411,-370,-349,-1143,-919,-844,-713,-775,-357,-546,-223,-839,-888,-889,-730
+J00301_at,-113,-28,-307,-126,-88,-190,-48,10,-25,10,-50,-34,-40,-54,-97,-196,-30,-42,-47,4,-102,-31,-5,-73,50,-48,-23,-93,-62,-268,-86,-12,-5,-58,-66,-234,-193,-13
+J00306_at,486,429,654,423,239,426,532,610,535,349,363,403,198,385,339,365,368,288,428,438,480,389,309,93,584,363,461,632,485,596,684,527,645,282,314,544,493,738
+J02611_at,786,521,716,798,563,657,909,791,926,701,522,395,505,668,443,709,1118,527,622,734,421,618,672,712,447,623,1018,804,834,777,646,721,654,416,983,926,1010,1425
+J02645_at,170,178,359,372,906,330,257,136,858,131,48,14,429,322,708,498,424,112,396,682,547,-155,167,374,196,97,-73,-268,12,-28,208,257,135,138,-210,142,-119,269
+J02843_at,17,66,-86,-87,100,-40,89,83,-38,-26,-72,-5,-105,-74,1,70,53,29,39,13,22,-49,-148,-64,46,61,68,-238,-98,33,-77,151,23,13,80,-53,32,-258
+J02854_at,-246,219,-175,39,99,46,-72,136,-139,-170,-101,148,-131,4,-54,-42,-234,-97,92,-147,-162,-83,-142,-58,192,-157,469,-321,-4,-129,84,-42,-212,30,-75,-86,-135,-264
+J02874_at,-14,-14,4,-63,33,-65,40,92,-40,49,-8,31,15,55,44,59,-15,62,10,40,-2,18,-43,-11,-6,-1,98,-70,24,-9,97,-4,112,111,307,-108,-10,-146
+J02876_at,-1426,-1150,-1784,-1418,-1180,-979,-389,-1128,-786,-750,-1127,-711,-1046,-890,-541,-815,-2028,-1005,-531,-1377,-620,-695,-159,-760,-811,-829,-776,-1083,-945,-1423,-1234,-1389,-1035,-652,-1530,-355,-1111,-1442
+J02883_at,234,167,421,206,139,74,102,244,133,173,157,58,21,253,96,182,239,146,79,67,179,26,151,278,245,46,195,234,288,258,150,130,245,101,156,285,81,375
+J02888_at,493,513,740,509,483,515,630,554,790,320,631,360,396,439,278,512,685,485,426,588,212,451,490,468,541,428,650,619,617,705,624,792,392,326,697,694,653,913
+J02902_at,2447,2527,2785,2390,2833,2066,2627,2634,3610,1996,2744,1151,2234,2607,2115,1835,2069,2187,1137,4008,183,1901,1635,3002,1789,2627,2040,883,1279,2396,1881,1591,2880,1036,1613,2100,1478,1517
+J02906_at,956,923,1658,772,770,485,1401,1572,792,952,653,538,762,669,301,932,1023,784,799,1315,577,885,1295,454,539,807,1273,912,1211,1100,1416,831,1086,680,991,957,1529,2349
+J02923_at,1673,2550,3322,2310,2934,1479,1618,355,2927,1468,991,2075,1652,3515,2653,1589,1665,2448,956,1269,109,338,463,2647,1042,449,544,1418,791,5609,1907,542,2181,1080,5874,3523,3733,2295
+J02943_at,294,337,341,226,78,218,324,442,102,173,202,117,186,268,146,308,241,190,243,344,139,320,70,143,130,120,488,234,254,335,155,434,313,267,239,197,125,344
+J02963_at,334,208,215,240,88,188,193,145,53,190,386,153,122,184,70,259,187,193,173,134,188,58,11,33,179,239,292,32,327,93,132,299,208,85,187,88,58,337
+J02973_rna1_at,-363,-63,-517,-165,-62,-177,-270,-307,-332,-312,-222,-206,-257,-306,-34,-153,-215,-239,-275,-273,-77,-201,-248,-183,-257,-285,-353,-417,-187,-352,-141,-250,-161,-79,229,-270,-324,879
+J03040_at,65,-212,-106,74,-53,-161,-68,-286,-160,50,-189,116,21,1,-25,145,86,-24,64,-256,87,-66,-201,-6,-35,-44,-137,65,218,-131,-120,-148,466,89,137,-11,96,922
+J03068_at,330,189,189,521,131,227,373,278,69,50,56,97,83,119,128,190,-32,15,31,221,151,315,15,245,89,31,59,102,211,347,201,-27,8,-5,46,270,275,242
+J03069_rna1_at,1879,1533,2154,1302,674,2587,1740,3550,1420,1408,1930,1175,1588,1787,1428,2381,2077,1756,1729,2503,2558,2067,2904,2380,2226,1617,1563,2151,2690,1889,1818,1764,1238,1257,731,1578,1849,3662
+J03133_at,367,211,410,366,137,259,386,433,328,106,231,176,167,289,169,236,418,294,145,236,222,320,315,414,320,183,395,274,372,380,390,367,340,103,266,324,405,601
+J03161_at,836,609,792,496,490,451,1078,442,831,411,450,198,1141,567,525,759,2011,774,792,1554,799,736,300,833,767,960,696,1001,526,936,498,1223,756,195,692,661,868,1027
+J03171_at,-185,118,187,434,194,-65,248,-64,-74,-126,-65,129,223,266,69,249,263,85,-171,-179,159,11,-70,221,336,189,212,538,14,-97,-464,-242,217,-89,9,-296,9,310
+J03191_at,5807,12826,11763,7133,6423,10009,5912,3775,13407,9922,7458,6351,10209,13606,7857,8133,13962,9903,5091,11909,1621,1881,8076,8613,4908,7766,4395,8409,5044,11929,7113,3555,7471,4847,10546,9600,9113,3971
+J03258_at,-273,-169,-464,-395,-61,-190,-294,-257,-263,-35,-193,-68,-52,-153,-103,-26,-144,299,-68,10,-93,-285,-313,-119,-207,-4,-219,-132,-201,-50,-120,-147,-248,-23,-5,-215,-170,-200
+J03278_at,581,537,804,676,425,128,757,859,657,384,366,71,157,475,289,950,1066,496,83,537,381,443,455,557,622,588,824,630,406,555,529,721,1252,189,481,398,506,816
+J03459_at,849,1096,1196,1192,1497,1194,720,959,2074,950,1078,834,922,1434,1216,1323,2021,1435,1233,3236,1255,585,870,821,940,800,1223,1255,759,2017,1072,989,1381,725,1307,1540,1136,1636
+J03473_at,2018,650,573,2291,2796,405,1829,2497,1204,324,264,472,1591,999,2352,2576,1875,2150,1338,4443,1040,1191,579,2741,569,2088,1702,803,430,603,404,355,841,500,426,871,671,109
+J03474_at,-667,-241,-624,-408,-190,-494,-294,-1109,-660,-143,-414,-347,-270,-538,-286,-113,-356,-161,-431,-115,-198,-588,-448,-672,-538,-93,-330,-494,-634,-524,-554,-545,-524,-207,-506,-536,-550,-692
+J03507_at,-16,59,241,57,-75,-17,35,-94,33,13,-13,-90,-13,-11,-17,26,172,-5,23,-131,19,171,91,15,44,-7,167,117,40,-16,71,20,0,-29,91,41,-5,4
+J03589_at,195,74,150,123,440,44,87,-122,509,59,86,34,680,436,359,174,527,238,42,585,266,-102,-22,357,82,340,-93,-83,-79,-51,-105,-29,-68,23,217,-56,-108,-222
+J03592_at,9621,5137,9518,13522,14321,9271,10811,6755,17246,8487,11557,15181,8798,10988,13845,10014,10361,10262,9433,18927,8384,10391,8619,12286,9012,11109,8781,12014,8663,9163,12013,6021,10531,9586,13353,11566,9318,8145
+J03600_at,2202,1250,424,-36,245,30,384,665,353,277,149,498,2794,332,281,550,741,67,343,1698,333,279,136,231,681,1609,408,129,230,692,341,247,347,93,382,456,573,727
+J03756_at,1211,655,1351,1017,543,769,1226,703,1122,632,676,390,676,521,515,888,1128,579,567,707,495,682,790,698,550,683,1315,1203,1067,1183,801,567,877,329,952,1092,688,1284
+J03764_at,530,319,571,290,215,307,307,437,495,619,294,270,388,328,298,401,258,179,273,309,183,414,419,388,747,371,394,252,334,390,187,312,398,111,366,283,641,395
+J03779_at,6350,1751,2818,1658,944,1410,2081,4386,2693,1804,1566,1746,8666,1405,869,8505,2268,1474,7857,4760,1253,2521,1377,1742,4091,5807,2746,2450,1899,1698,1879,1637,2056,979,1226,2092,2871,2869
+J03798_at,200,219,291,203,376,80,220,202,352,228,153,70,411,224,258,301,274,146,184,765,86,198,108,403,121,137,139,162,139,165,131,137,171,101,47,170,115,154
+J03810_at,83,26,86,6,91,60,47,58,99,14,76,18,84,63,11,78,48,97,55,73,-2,128,79,92,44,75,109,128,57,55,117,112,114,10,47,94,23,143
+J03824_at,-38,197,158,-103,325,17,-228,-229,215,93,189,8,13,243,181,262,159,218,530,391,126,-117,94,151,167,230,-212,200,365,168,290,540,-24,47,166,231,156,5
+J03827_at,6895,10249,9799,8140,7649,8850,6334,3970,11444,7301,10013,10993,5434,7739,6947,5748,5902,2880,3887,10744,9068,5832,6879,7294,5468,3196,5304,5700,5701,6637,12444,8774,6333,6786,8866,9667,7632,6844
+J03890_rna1_at,483,43,539,23,99,264,146,-419,273,102,253,173,260,-119,-7,318,100,408,284,-76,66,231,148,92,89,249,255,113,-158,67,472,32,375,-51,-456,211,389,864
+J03909_at,381,2320,214,429,1557,1340,488,-230,753,509,14,632,792,593,1155,110,-236,1287,413,170,64,133,-34,503,335,551,-136,685,149,6127,3832,-59,665,908,7198,1721,2596,6692
+J03925_at,299,311,153,20,258,48,52,94,12,51,102,-4,37,866,30,10,7,84,-13,109,48,-22,3,-59,37,115,10,-3,19,1620,216,-2,65,50,938,512,197,230
+J03930_at,800,458,798,402,419,456,833,376,562,483,481,321,430,504,279,546,371,431,484,446,262,507,533,538,406,516,572,679,663,766,728,772,760,218,269,684,679,1078
+J04027_at,96,390,108,63,357,44,-85,-104,242,211,385,84,95,156,192,42,-45,111,34,44,86,57,9,308,23,31,-75,489,40,1294,958,217,158,175,923,320,399,1105
+J04031_at,455,409,521,268,441,401,361,-20,522,312,434,119,249,566,298,265,210,492,158,313,82,192,379,469,269,372,287,146,266,313,285,372,576,269,341,296,313,387
+J04040_at,215,166,183,121,26,156,218,158,120,60,110,114,61,106,31,131,127,84,60,71,126,111,64,150,131,112,355,183,62,8,210,75,131,39,167,190,172,166
+J04056_at,-152,-113,-150,-93,9,-24,13,-101,-24,-76,-217,45,159,-211,0,-166,-214,-79,-77,49,-7,-96,-56,-41,-168,22,-250,-225,-98,-322,-297,-103,-197,33,-235,1,-326,-157
+J04058_at,138,176,182,191,312,151,230,148,242,79,85,81,169,256,242,129,196,161,46,511,638,52,79,311,161,90,101,90,122,125,316,236,199,257,181,209,76,94
+J04076_at,-50,-36,-80,-90,16,-99,-45,5,-54,-78,-51,-30,-33,-46,-81,-76,53,375,-36,-27,42,-32,-55,-56,-80,-25,-21,-35,-57,3,-71,-98,-20,-38,-103,-133,-19,-49
+J04080_at,68,67,75,-8,93,-39,31,29,59,-18,-23,0,-17,108,-14,86,110,20,-14,92,111,117,39,32,138,23,12,56,149,45,44,-5,42,-29,113,48,81,-51
+J04088_at,570,217,851,695,624,551,369,230,616,172,252,142,1280,420,854,304,525,793,318,348,258,151,657,472,235,83,267,68,274,664,443,575,464,126,178,167,165,270
+J04101_at,127,-1136,1206,737,55,192,-1,-592,329,173,504,-196,-201,-186,-194,187,-1608,-255,-163,-388,-36,11,112,-15,-288,-1317,-148,821,-3073,303,-440,-2247,-95,-55,-365,309,-1137,-246
+J04102_at,221,1813,-163,1275,1262,80,1112,-115,-149,307,816,2128,2502,-360,1709,1123,1533,-143,1468,999,-57,201,-281,1186,2253,124,29,560,-358,1461,1970,48,1798,677,1749,1242,1330,691
+J04111_at,204,162,679,20,302,232,152,332,561,890,525,205,456,196,48,225,214,380,208,1447,396,353,216,237,1164,508,223,437,122,288,344,303,849,118,210,28,498,346
+J04132_at,386,508,1291,125,53,842,-84,358,1165,333,591,-67,104,2140,12,-7,133,-78,-25,-96,49,17,254,65,-76,-60,-297,181,43,-73,-126,4,26,-137,-544,-158,53,29
+J04156_at,0,-7,-11,-42,-15,-12,13,73,-24,-32,-42,-66,-44,-11,-15,-77,19,10,1,17,-9,1,37,48,-5,-26,-40,-24,4,-50,-27,-1,35,-15,-21,-14,5,-15
+J04162_at,251,151,611,124,163,321,210,313,423,164,40,148,107,174,156,151,245,79,50,68,149,88,208,116,56,169,383,126,247,427,172,117,125,54,170,60,237,204
+J04164_at,1158,15997,3925,-300,197,586,465,1095,582,865,700,4666,2286,13330,1787,1571,8390,-112,4812,2617,6106,-394,4037,-191,13928,4546,-134,269,3986,-833,2215,-459,1645,3,-820,1967,5202,5619
+J04173_at,2398,4000,4429,1501,3678,1922,1043,751,6084,3448,2926,1284,3369,2632,2766,1922,2725,5147,1604,4028,2013,1485,1025,2404,847,1651,862,2376,1966,6032,3193,500,1019,1266,7109,3018,1372,2387
+J04177_at,528,313,761,398,196,295,374,347,344,210,253,153,282,212,185,339,565,320,241,364,198,333,303,307,217,327,719,384,276,305,315,325,258,166,288,272,228,716
+J04444_at,-454,-774,-5,-1242,1332,-259,-110,-605,754,415,-49,-227,621,-672,1427,-91,-468,10,-343,2445,379,-304,62,915,-259,194,-1677,1,-531,-489,582,319,60,191,-65,-1529,-977,440
+J04456_at,212,1346,880,10076,13149,531,4652,133,6915,696,544,1806,399,1342,5151,470,4109,6975,145,187,16,179,279,7505,179,244,111,4770,1118,13366,6523,572,795,6377,20599,5402,2212,1964
+J04469_at,99,422,-311,-88,75,7,-109,-250,-118,38,5,-8,-110,219,-19,16,424,-60,0,548,-58,-32,51,73,14,26,37,-103,209,87,536,-171,218,46,126,-222,389,-82
+J04501_at,167,-206,696,479,15,314,678,679,146,283,-307,247,84,47,257,-154,150,80,0,1304,187,414,248,-27,-9,58,450,167,252,143,210,-178,-18,193,-272,570,452,-755
+J04543_at,199,418,380,542,450,232,552,346,711,198,292,241,653,414,245,244,701,484,274,775,539,307,62,361,175,229,172,425,589,355,531,413,484,599,568,457,457,761
+J04599_at,1338,398,1254,1408,455,1120,1712,1962,1051,1078,557,505,405,1196,1089,499,340,282,452,320,93,1303,613,1051,521,462,469,1373,1493,1287,1353,1631,1158,424,1199,699,1085,1254
+J04605_at,285,489,313,429,330,360,287,236,400,241,178,244,179,943,271,254,130,144,194,459,16,109,313,239,176,156,145,263,125,328,246,145,319,143,329,397,578,387
+J04611_at,977,1940,1197,1526,1749,807,282,365,2650,1596,2259,1322,1415,906,1787,1103,902,317,607,3079,854,99,742,1309,485,1275,208,873,240,745,1680,623,492,1249,800,1169,489,450
+J04615_at,2117,4069,3726,1154,1209,2197,13,1479,4040,1996,2660,776,1561,1868,1648,1715,1949,942,657,3916,6050,1361,1223,2207,1304,1456,1264,108,48,500,-211,367,666,53,-58,-138,3256,755
+J04621_at,-29,-65,-77,-116,-15,-120,-5,-97,-83,-147,-251,-74,-56,-94,-34,-127,-13,-90,-101,25,-82,-194,-144,48,-130,-44,-168,-192,-223,-180,-173,-156,-177,-49,-115,-184,-151,-236
+J04739_at,40,89,3,-76,33,151,57,55,247,49,123,-50,93,147,97,-22,118,-24,-18,2,-86,153,-98,122,-58,59,-65,154,-64,52,-51,81,323,42,257,230,297,355
+J04742_at,-7,-9,-231,-39,-11,-37,-87,-74,-31,-12,-61,7,-8,-47,1,-137,-14,-33,-24,17,-116,-81,77,-31,-76,-48,-57,-83,-110,-75,-42,-42,-36,2,148,-10,-69,-152
+J04760_at,190,-79,183,197,63,-62,47,220,27,186,106,-83,148,63,290,322,-376,-8,67,202,-229,-15,212,216,117,179,-248,263,76,287,77,67,27,-73,-102,209,21,209
+J04794_at,1132,795,1109,1661,2132,947,1330,653,2451,779,1292,1062,1688,1245,3736,2072,1239,1554,2074,3411,1455,66,948,3684,1259,2252,1312,1343,1014,1208,302,390,1187,319,1733,1896,2289,204
+J04809_rna1_at,695,334,646,579,213,487,371,613,544,210,153,277,383,377,426,537,99,141,214,167,316,319,336,423,-4,262,455,515,281,424,266,390,237,189,418,384,449,621
+J04823_rna1_at,2140,3003,6947,3711,2874,4922,2713,637,7269,4682,5519,2717,3112,3805,5296,1760,2281,3207,1768,4455,5274,2922,4058,3037,1835,2174,824,2410,2092,7484,6668,5828,4122,5686,7619,5487,2483,3885
+J04948_at,584,389,679,1055,354,119,388,380,393,865,390,362,558,430,677,559,703,647,308,721,74,496,142,210,503,473,1533,793,223,264,908,757,688,329,770,749,1001,1362
+J04970_at,11,3,36,23,24,0,-16,-46,-46,56,11,11,22,43,26,30,44,51,93,95,-1,56,39,50,43,140,156,-31,50,-1,50,-31,42,-22,43,-5,46,-97
+J04973_at,696,795,939,893,1201,215,215,391,1022,300,1015,344,764,866,1227,692,451,490,425,1824,1286,401,482,1180,701,499,284,539,401,443,600,276,428,753,1015,410,383,212
+J04982_at,-11,-10,-120,61,18,19,-23,-68,-29,-41,1,-33,32,-21,-14,17,-21,16,12,194,31,15,94,-14,-26,-13,-81,-104,-12,-32,-20,-42,47,-38,-46,53,-36,-142
+J04988_at,4483,8334,7445,8127,10367,5005,5855,4826,10496,10431,8529,3699,10806,7995,8677,5577,11682,6625,5007,12931,5811,4407,5390,7804,8427,6653,6282,10377,6814,6816,5959,3950,11111,5903,11156,9226,7521,7741
+J04990_at,524,413,975,786,531,656,779,643,820,448,413,399,273,583,478,501,864,441,364,435,416,575,782,672,539,530,658,3038,456,9823,1280,804,646,15074,18795,2874,1153,2020
+J05008_at,-48,-26,-77,-132,7,-129,-11,-205,-21,-56,-11,-63,-42,-92,-39,-18,-37,21,9,-22,-57,-75,-64,-121,-37,-56,-156,-92,-113,-22,-2,-44,-40,-34,-38,-43,-93,-87
+J05032_at,166,278,451,416,503,90,184,142,414,225,257,107,432,714,635,472,655,332,267,788,903,139,117,523,150,197,170,291,60,134,71,5,191,187,102,160,156,152
+J05037_at,-721,-96,-837,-773,-369,-8,120,-2,-784,-14,-506,56,15,-574,247,-418,-1395,-368,-728,302,331,-396,-634,420,-512,-353,-1617,-456,-1101,485,-180,-634,206,-511,-15,206,139,-771
+J05068_at,-3,-121,-17,-199,-91,78,-173,-292,-7,-64,-22,-15,-91,-106,-23,10,-75,4,-111,-34,6,-68,-53,20,-12,-19,-31,-34,-117,-206,-163,-98,20,91,-153,-261,-79,-19
+J05070_at,174,-105,98,83,111,-85,-42,-74,67,16,77,152,73,87,73,52,-16,-17,55,-2,139,78,18,215,70,181,-125,83,40,68,35,-3,88,59,-67,-57,-10,98
+J05073_at,-61,-172,-152,1,-110,81,120,-457,111,-136,-62,-25,-31,-92,-81,-137,-164,15,-111,-90,77,-53,-68,-128,-54,-107,-15,-174,-137,-118,-281,-229,-128,-170,-98,-48,-179,-244
+J05096_rna1_at,74,52,75,54,24,0,8,37,45,37,22,37,46,89,50,63,51,66,-4,50,22,73,7,89,5,37,40,74,76,50,58,58,73,15,88,60,63,46
+J05125_at,-25,-58,-131,-127,-88,-51,-82,-62,62,-103,-102,-28,-28,-22,-57,-53,-92,-84,-62,-40,-44,-20,1,-67,-10,-21,57,-25,31,-85,-7,-21,-46,-38,-14,-61,-70,-56
+J05158_at,-230,-101,-559,130,-209,7,18,-83,26,-305,16,-181,-103,28,-172,-193,-353,-70,-130,-185,137,-64,49,126,-132,-30,-388,-204,4,-424,-501,-280,-315,-51,-200,58,-32,-138
+J05213_at,90,-67,106,-131,5,26,28,-136,69,-47,-52,-35,-41,74,-86,-83,-7,42,-7,-148,67,-2,68,-48,36,-42,20,92,48,5,-78,99,3,-59,-56,-219,40,-30
+J05243_at,610,927,1697,425,529,1682,386,629,2760,1722,1587,169,719,859,661,1034,447,252,1041,1717,604,304,397,642,295,1122,209,206,-16,-92,87,71,102,237,238,57,628,-44
+J05249_at,2004,1170,2572,1328,1578,978,1344,1536,2338,1681,1408,1110,1938,1745,1555,1576,2011,1582,1293,2808,1021,1109,689,2374,1577,1396,1583,1599,1406,2014,1700,1715,1999,843,1618,932,841,2526
+J05257_at,511,228,257,114,48,56,-5,947,64,148,106,352,282,2,-58,263,21,153,740,580,178,1068,220,-216,680,939,181,138,86,238,321,94,414,-91,87,39,290,582
+J05272_at,1286,824,890,1447,879,780,1530,1095,852,636,712,676,1180,1018,490,894,966,699,746,1680,482,795,822,1137,981,742,909,1508,805,2180,1061,1115,38,463,838,1402,1084,1502
+J05401_at,93,0,-54,4,-44,83,-82,-2,-78,-49,-31,84,-82,23,-85,-15,31,-36,-53,-115,66,-36,-89,-97,39,-8,179,-124,-72,-5,29,-121,85,-38,16,-78,65,-135
+J05428_at,58,-8,101,148,30,39,57,140,27,84,71,20,17,43,-12,27,-31,16,23,0,-8,73,-18,101,86,83,-73,88,69,55,45,127,17,19,25,71,107,97
+J05448_at,-48,237,-213,-225,112,-348,-75,-136,196,-112,-80,-119,47,0,164,-87,-90,-182,-119,142,11,11,-26,106,-5,-245,-363,-171,-189,-40,-27,44,-16,-83,-106,-75,-309,-264
+J05459_at,-82,-1,-90,10,-5,-101,-16,-220,-4,12,-22,-58,115,0,-19,18,117,2,19,103,-103,-86,-15,130,-33,45,150,-46,-52,-23,-25,-168,-73,10,51,-64,61,-14
+J05500_at,210,184,273,460,78,481,556,451,334,381,277,228,144,373,42,368,541,175,443,439,217,132,267,156,268,346,882,411,1033,244,1413,1022,600,414,540,459,456,982
+J05556_at,182,48,237,195,74,192,124,241,209,15,112,113,80,136,65,91,240,154,141,105,128,134,151,88,76,139,90,88,139,29,74,221,237,95,106,147,150,557
+J05614_at,2561,2805,5729,2247,3347,3919,1181,941,5284,2032,2906,833,6606,2321,6214,1518,6945,4263,1878,1969,-66,959,3522,3144,1387,923,1905,306,875,2522,2816,4317,2775,3515,689,2150,382,1859
+J05682_at,128,100,142,220,167,32,141,86,109,66,0,41,198,133,185,74,202,91,64,126,26,83,32,240,65,114,158,10,36,141,77,211,123,77,110,112,155,134
+K01383_at,398,398,601,459,478,378,341,389,382,365,293,217,421,382,318,305,353,331,335,430,283,445,210,532,511,387,344,442,406,469,602,622,482,346,460,497,406,603
+K01396_at,158,1187,339,353,508,823,70,476,691,306,82,132,138,720,277,181,350,141,197,111,61,139,75,339,97,278,550,644,245,4851,1999,357,99,701,1950,274,1225,532
+K01884_at,-26,79,6,-47,-5,-7,-21,70,29,-27,-31,7,37,-31,-25,19,152,15,16,-13,106,24,-5,-18,-67,4,-45,14,60,20,-69,-20,48,-14,46,-74,94,-13
+K01911_at,3172,5,36,40,250,3,100,-56,-83,79,58,54,4554,-31,2315,445,157,-29,831,7533,122,1813,-9,924,222,375,42,22,45,-86,-25,101,32,-63,-34,-24,31,-133
+K02054_at,8,-26,72,99,69,136,100,-82,0,36,-32,8,16,28,7,17,-10,97,-56,8,-52,71,138,18,137,32,89,-67,-4,109,98,85,-6,53,-20,-20,62,-19
+K02100_at,238,51,143,149,126,142,151,4,123,173,73,50,109,37,11,130,440,115,137,100,56,167,157,53,72,41,59,252,48,160,125,134,91,-59,55,255,-31,199
+K02215_at,26,-12,-31,41,-33,-16,-72,26,-10,38,3,40,17,42,-6,-72,5,-33,-7,52,46,-56,-53,-61,-73,-39,23,-59,-31,-49,36,31,-6,7,28,-18,-16,27
+K02268_at,231,-116,223,233,46,138,468,257,216,84,245,119,-67,241,-23,57,-131,1,-73,-109,151,-10,197,215,135,7,-148,10,307,82,294,296,135,-161,339,-17,-254,73
+K02402_at,-67,-8,2,8,-19,-26,-16,8,-105,-16,-79,15,-49,-42,15,-25,-61,-42,-41,-31,-59,-51,-70,21,-31,0,-89,-33,40,-8,-28,-64,-60,-46,-3,-52,-25,-30
+K02545_cds2_at,-1,-43,59,30,17,1,-70,-19,-28,95,1248,58,0,1031,0,56,196,22,32,-13,52,43,117,153,82,-21,-6,82,14,-46,70,33,96,7,24,17,233,109
+K02574_at,2070,1030,1676,1741,2203,617,2664,1958,1067,870,840,342,2081,2552,1912,1026,2393,1306,907,5302,515,2133,459,2565,1417,1211,1605,2017,829,2678,3663,3351,2195,1446,3355,1399,990,5749
+K02765_at,102,-48,-51,342,8,80,-52,275,-54,83,6,89,3,76,-71,-173,-74,-81,-316,-262,142,37,117,145,53,74,-45,374,346,-52,-960,-341,-34,-177,5,17,-95,146
+K03008_cds1_at,-194,23,-222,28,-78,37,5,-82,-121,-150,-122,79,-125,43,-39,-115,-98,-123,-91,-130,-21,-235,104,-147,-35,-16,61,30,-134,-43,55,-111,-110,34,36,10,44,-141
+K03008_cds2_at,368,179,307,121,358,216,188,214,245,207,116,148,381,359,253,158,283,169,116,91,284,241,345,261,49,202,71,221,283,300,207,242,298,86,406,332,220,402
+K03021_at,141,93,230,111,28,81,206,395,-61,130,-91,58,78,367,90,124,193,273,63,167,-213,6,53,146,-30,17,517,-344,206,125,127,40,126,94,112,205,83,149
+K03195_at,582,486,640,807,675,423,818,809,712,760,693,596,523,742,558,429,425,554,883,936,874,920,632,638,688,443,489,714,819,759,3010,1775,1039,1451,1420,500,847,1637
+K03218_at,260,187,218,93,206,183,161,61,335,15,86,109,41,-337,76,65,-65,140,95,309,-152,-88,136,139,-66,220,40,-79,9,126,-292,182,230,67,122,236,160,-269
+K03430_at,571,429,635,200,449,154,349,335,297,419,400,231,323,375,287,348,472,305,282,512,229,334,408,512,427,261,536,234,81,335,249,461,386,169,529,307,492,558
+K03460_at,902,1275,921,1117,1022,572,1278,832,1428,1625,1740,1478,431,1277,529,1127,654,410,1343,3026,3523,439,583,388,1783,1395,1502,973,1293,444,1881,1916,2021,3055,1320,1501,1751,1810
+K03474_at,14,548,13,105,-130,128,436,52,104,263,-281,221,-104,203,52,169,159,147,231,-34,-138,211,273,184,237,-48,12,-78,-79,-23,-41,27,171,61,92,-188,437,-216
+K03515_at,1301,3048,2624,1647,2305,1538,1997,649,2754,3363,2490,1227,1115,3110,1828,1592,2849,5325,1119,3414,1124,724,1909,1797,1361,1689,2437,2130,1291,3497,2214,1631,2211,1704,4922,2485,2103,4115
+L00137_cds1_at,90,77,215,88,72,199,245,521,53,199,121,215,159,43,245,351,251,324,5,321,264,290,-36,381,265,298,303,212,127,386,145,47,139,51,-52,158,89,294
+L00352_at,227,317,412,186,155,417,194,269,815,572,865,219,419,179,152,191,430,165,316,173,83,198,189,458,235,678,106,200,79,2101,415,199,364,217,2241,264,574,576
+L00354_at,70,-51,99,-40,-92,35,136,59,28,43,-82,70,-22,5,-109,-62,9,-20,19,30,-31,37,41,-128,9,-71,219,-32,-2,45,-11,106,31,-83,-43,13,-3,61
+L00635_at,559,350,683,498,322,336,258,689,599,189,424,310,427,494,361,242,205,332,363,316,269,585,286,525,391,421,10,594,214,528,282,613,491,253,406,265,549,286
+L00972_at,227,259,456,320,116,142,305,452,253,193,178,208,16,105,154,224,456,123,91,66,162,200,355,205,186,160,361,199,341,56,117,309,521,9,114,5,274,242
+L01042_at,-17,129,36,103,44,-53,-23,-40,-101,21,27,43,34,44,93,31,95,24,-19,188,97,167,-121,233,32,26,4,36,-12,22,85,20,68,-45,86,-39,67,50
+L01087_at,0,385,839,-159,110,455,-144,-397,671,-134,374,-150,-41,116,-93,-176,284,-100,-32,309,219,77,45,-107,-66,-217,-98,-63,-33,-443,-2,-677,-432,-117,-80,-22,54,-361
+L01406_at,83,-129,367,-206,-48,-19,-80,-370,-293,-124,-20,-21,-73,-213,-63,-193,-764,-190,194,-74,172,286,-20,106,-15,-150,-35,-172,-110,-359,-29,-144,-151,-242,-162,-224,-78,200
+L01664_at,-39,-54,-28,31,488,49,13,73,140,21,50,51,-4,-20,23,28,79,26,-13,121,36,31,89,83,-23,28,128,188,14,129,196,-60,1333,543,-13,166,-18,-29
+L02320_at,31,-32,-62,-105,23,-5,-58,-175,-34,-28,-82,17,0,-45,-11,-93,-66,-10,-13,45,-93,-35,-22,-35,-70,-38,3,-40,-79,-68,-39,-16,-4,-2,-61,26,-3,-9
+L02321_at,108,-249,520,-268,134,60,374,-58,-94,-101,1,-70,250,-124,168,38,319,125,-97,-96,44,19,-132,257,586,81,366,-115,307,179,-165,98,281,-102,78,-15,-77,211
+L02426_at,822,1263,1467,1324,1955,1111,1073,797,2094,1323,1828,662,1959,1159,1831,1340,1141,913,711,3113,2703,1008,1284,1107,694,1104,801,1212,851,1256,1711,1066,1078,1779,1576,1489,859,1319
+L02547_at,10,19,1,14,90,-32,62,4,-13,49,24,-56,46,47,86,30,112,54,-32,33,-12,-43,18,42,-84,63,62,-43,-26,-50,-63,-28,38,5,-48,-20,-78,-107
+L02648_at,-78,125,-74,-599,-217,99,-374,-479,-237,38,-320,96,157,-300,126,-252,-298,-78,-41,58,-12,333,-93,-244,-12,-126,59,14,122,213,-113,-197,-107,95,-218,113,-161,467
+L02785_at,-58,26,106,-90,-6,26,-5,-16,-56,39,12,-12,24,20,6,21,-64,72,58,30,82,24,-18,-1,-27,-49,187,107,7,63,51,70,7,11,144,40,-10,-146
+L02840_at,120,115,149,-10,-17,204,228,124,9,140,204,86,59,-15,28,134,124,116,-6,94,104,57,113,125,30,29,239,85,127,40,45,156,95,-23,102,-34,56,242
+L02867_at,73,-340,-179,218,-580,-142,5,244,387,18,-40,212,-386,127,-125,5,-68,-347,-93,-300,-71,-95,-226,53,-523,-575,209,161,603,120,468,72,-577,0,122,456,127,989
+L02932_at,29,82,199,39,116,69,110,88,84,59,66,0,94,57,148,70,29,117,107,220,39,78,13,95,60,93,-82,90,-4,-7,7,65,39,39,-66,-35,7,23
+L02950_at,50,113,161,-19,181,88,45,139,153,119,-13,-60,59,18,47,-30,27,47,-79,638,559,5397,-37,56,152,144,129,73,28,118,221,136,26,90,-37,-71,-53,182
+L03427_at,-76,-32,-15,-54,-60,-96,-110,-119,-45,-37,-12,-43,-59,-32,-19,-60,-124,-15,-371,-59,-81,-66,-28,-7,12,-20,7,-106,-81,-137,-27,-42,-89,-47,-97,-160,-77,-40
+L03532_at,1684,2197,2683,1195,2127,1481,1409,1007,2906,1642,2994,993,2047,1585,1965,1685,1650,489,1160,2989,3574,1381,1943,2322,1041,1500,1031,1221,800,1923,1260,1605,1537,847,1500,1556,1508,1181
+L03785_at,648,327,825,349,355,282,431,535,517,491,293,284,313,622,211,366,357,394,292,455,839,435,353,403,500,466,430,631,685,630,440,689,604,331,489,593,643,815
+L04270_at,-796,-970,-2111,-1555,-331,-1257,-1487,-2470,-687,-206,-1082,-791,-303,-587,-557,-943,0,-357,-208,-889,-749,-404,-1183,-952,-539,-857,-2484,-62,-413,-104,-915,-1068,-923,-227,-302,-1067,-797,-1753
+L04490_at,-10,175,635,-154,352,732,-208,371,1209,317,789,-155,204,252,868,778,740,152,343,1713,604,-19,294,81,-98,416,-347,-1,278,162,792,206,-25,297,-1134,-10,396,-607
+L04510_at,3,66,15,24,87,46,30,86,23,43,103,31,85,47,69,91,53,52,94,250,103,28,7,67,51,83,53,59,12,34,44,118,91,51,36,-61,15,16
+L04656_at,104,158,15,182,88,149,82,76,49,128,-56,67,6,139,116,66,177,5,58,109,32,-13,64,102,132,85,90,187,9,138,152,171,89,19,176,129,73,113
+L04733_at,370,125,390,598,124,307,670,-205,539,167,249,8,539,216,226,478,367,52,75,885,653,51,357,804,-124,211,212,405,290,73,-256,-145,-183,303,204,64,103,178
+L04947_at,-588,-459,-728,-553,-255,-579,-662,-688,-571,-320,-434,-469,-387,-557,-217,-401,-748,-333,-328,-449,-321,-519,-518,-573,-405,-397,-877,-752,-615,-747,-652,-523,-616,-318,-577,-673,-816,-786
+L04953_at,419,291,432,517,95,497,435,731,511,143,285,422,71,335,227,195,342,187,138,132,196,357,353,279,165,172,267,224,254,358,232,544,395,35,338,494,107,339
+L05147_at,-379,-394,-313,-273,63,-339,-176,-268,-496,-193,-185,-293,-87,-250,-42,-223,-216,-206,-173,-458,-93,-198,-229,-79,-141,-220,-580,-197,-262,-124,-222,-234,-53,-86,-187,-325,-225,-192
+L05148_at,545,2959,2458,608,461,2075,488,1009,2379,1608,1834,586,610,2439,864,1415,2068,452,497,2009,1044,805,1916,545,1051,777,464,450,360,427,402,716,373,302,492,328,1039,454
+L05424_cds2_at,-234,-65,-423,-408,-15,-8,-404,-698,-398,-196,-186,314,-225,-36,60,-228,-292,51,-19,-238,24,-32,-256,-257,160,-170,-539,64,-226,82,509,213,181,-213,1067,-372,487,162
+L05425_at,82,7,246,66,341,8,171,137,113,222,294,66,265,86,335,339,205,155,141,644,226,241,91,219,158,242,206,121,218,114,204,287,228,39,106,257,18,118
+L05500_at,-136,-259,-581,-303,-496,-24,-349,-721,-204,-155,-140,-235,-303,-471,-237,-398,-342,-385,-334,-443,-92,-48,-269,-503,-82,-343,-472,-470,-122,-434,-318,-477,-626,-247,-327,-269,-322,-269
+L05512_at,340,315,548,245,51,490,576,637,232,60,253,139,93,27,176,130,142,111,90,33,301,194,362,113,264,110,76,129,235,179,167,419,317,65,166,243,353,276
+L05515_at,-145,-213,-261,-182,-111,-108,-149,-82,-111,-71,-115,-40,-210,-188,-129,-133,-399,-104,-203,-237,-354,-163,-180,-194,-113,-242,-369,-182,-170,-110,-175,-108,-55,-257,-52,-99,-168,-340
+L05568_at,134,157,247,264,103,71,290,77,194,201,73,71,98,76,97,210,310,130,53,163,84,128,201,4,109,22,370,135,216,288,154,160,157,42,144,65,10,358
+L05597_at,-76,-29,-29,85,-51,-28,62,-38,-49,-43,-39,-12,-95,-29,-13,-34,8,9,-18,-13,-43,-30,-79,-5,18,-5,-81,-1,-4,-70,-51,2,-49,11,17,-2,-87,-70
+L05606_at,-516,-320,-717,-498,-399,-401,-488,-457,-654,-474,-447,-169,-370,-502,-299,-474,-546,-414,-232,-286,-21,-499,-454,-603,-231,-398,-485,-801,-750,-622,-325,-357,-479,-122,-586,-476,-569,-304
+L05779_at,296,397,672,587,299,647,525,548,708,510,334,172,221,421,398,292,226,83,430,269,71,353,457,145,234,180,381,542,307,426,517,255,579,113,258,515,560,441
+L06132_at,850,701,1581,1359,2088,958,846,602,2057,1225,1074,702,2174,1135,1894,2687,1321,1391,3571,2464,5022,835,1257,1189,1032,1981,2899,1088,625,1273,823,575,1197,867,1570,1352,408,941
+L06139_at,-243,-16,-120,-234,-112,-19,-132,-130,-86,-129,-102,-113,-116,-202,-84,-172,-109,-128,-114,-185,-157,-48,-98,-220,-86,-233,-137,-120,-158,-222,-238,-103,-63,-67,-30,-164,-78,-162
+L06147_at,-1410,-1235,-2135,-1737,-740,-1353,-1581,-1578,-1661,-1248,-661,-893,-840,-1253,-402,-1211,-825,-657,-1292,-718,-579,-1190,-900,-1084,-489,-703,-2307,-1576,-911,-1475,-2070,-1224,-1653,-789,-1841,-1445,-1716,-2342
+L06175_at,8,-182,-288,-151,-30,-184,-191,97,-121,-123,-235,25,502,22,391,33,-310,173,154,609,-182,78,-144,9,316,75,-291,-64,-81,162,-207,22,-133,-70,17,-36,-268,-239
+L06419_at,-819,-1487,-821,-309,242,-279,-756,-2084,-698,-262,-494,-1155,-535,-1098,43,-398,-779,-166,-641,-107,-61,-1171,-756,-649,-346,-525,-258,-1419,-743,-31,-1231,-1078,-407,-203,725,-625,-623,172
+L06499_at,20764,17636,23324,21733,20332,32791,33797,24655,18208,26774,22297,30546,23104,18283,18949,23166,19482,24312,24377,9995,24322,28109,34139,21817,24538,20358,31261,21029,37884,26190,20909,24380,18636,28159,17347,28210,21618,22037
+L06505_at,9324,11126,7629,10999,13543,9241,12210,5880,12629,12481,9711,11213,10858,12182,11638,10669,8666,13789,11866,11470,18006,7803,8551,11733,11813,11113,8194,13322,11994,10254,13772,14507,12919,15619,11564,12265,11196,12668
+L06633_at,12,133,-45,244,98,-42,20,55,-49,-44,8,232,93,131,146,26,-15,351,167,-35,-51,-62,-62,231,572,165,-10,-11,19,218,103,118,465,54,127,-17,116,996
+L06845_at,-399,-59,0,-603,611,-695,-761,-686,112,-15,89,-477,71,-209,431,253,-213,-60,366,823,1118,-226,-644,420,-149,311,-982,-265,-165,5,-616,-896,-751,-199,306,-639,-881,-1017
+L06895_at,-883,-323,-696,-575,-284,-794,-1265,-1284,-737,-392,-486,-530,-293,-604,-414,-339,-437,-363,-356,-461,-301,-748,-509,-627,-305,-570,-910,-878,-673,-188,-180,-443,-257,25,-306,-570,-776,-458
+L07033_at,309,158,261,442,443,254,325,286,241,237,165,173,201,422,328,435,321,408,237,518,193,112,269,490,312,264,444,129,211,177,208,193,125,290,110,272,263,264
+L07044_at,-80,285,175,-52,97,46,30,-55,83,-24,130,83,87,398,148,100,59,17,50,679,-4,236,20,67,203,98,-86,-12,168,91,-62,62,138,237,85,150,246,51
+L07077_at,8,9,37,55,43,62,120,23,-6,35,-1,34,33,-4,14,58,9,80,16,51,-39,20,-13,54,-1,2,78,37,45,23,-3,47,-4,31,38,13,86,19
+L07493_at,74,185,408,241,161,224,112,131,430,345,249,152,273,317,288,146,282,195,165,612,527,14,226,312,203,190,345,197,86,174,167,145,181,315,108,98,230,174
+L07515_at,210,80,156,249,230,131,137,116,37,60,109,-15,101,133,552,85,-37,127,79,30,198,95,144,224,99,127,107,74,168,-26,54,36,99,49,41,60,-45,-7
+L07540_at,-572,-374,-804,-646,-177,-563,-873,-1077,-382,-225,-387,-639,-261,-325,-201,-328,-317,-273,-329,-273,-271,-631,-463,-476,-331,-243,-666,-592,-651,-554,-540,-432,-529,-165,-318,-610,-841,-804
+L07541_at,61,91,198,107,170,120,18,176,250,24,130,70,170,159,170,91,379,118,50,79,66,53,302,159,50,95,106,76,146,65,53,187,121,65,54,147,31,83
+L07548_at,215,294,9,193,405,192,329,280,161,224,381,212,558,529,393,311,481,543,249,757,128,153,326,538,238,271,353,363,281,673,356,417,573,115,535,400,311,339
+L07590_at,104,28,39,-5,65,49,147,67,60,6,40,102,10,119,48,68,17,62,34,9,-14,81,26,45,83,-43,165,115,-9,35,34,-3,88,15,204,113,93,111
+L07592_at,-520,-318,-854,-322,-1,-147,-596,-358,-352,-85,-98,-117,73,-232,86,154,-637,-98,-104,237,2,-524,-176,-514,-603,-45,-375,-396,-360,-213,-423,-421,-344,-215,-380,-347,-833,-907
+L07594_at,64,-16,-191,-70,-7,1,-70,73,-25,37,-6,35,4,57,61,126,-30,-15,-46,-53,-7,10,-15,-79,16,12,51,-5,9,-68,-2,66,-112,-7,9,14,-51,-20
+L07597_at,52,62,-157,368,995,8,937,-229,209,-349,-4,-45,1110,231,1202,376,95,111,-16,1330,103,51,144,1498,-94,773,-281,106,110,23,-290,-319,-192,61,592,-156,-328,55
+L07633_at,3586,4802,5153,3301,4524,3378,2629,2287,4423,4220,3408,2021,5470,3623,7313,3746,5103,1752,4003,8242,1544,1743,2669,4011,4293,4515,2326,1751,1928,2747,2436,1302,2857,2695,3532,2626,3186,2787
+L07738_at,-274,-467,-171,-440,-336,-110,-30,233,-309,-39,-86,-517,-252,-312,-234,304,152,-185,-62,-736,38,-223,1,-151,38,-467,-740,-15,-336,109,-319,-237,-52,-243,-107,-192,-210,-200
+L07758_at,481,361,751,687,834,394,389,448,874,436,578,166,514,674,589,629,483,353,340,1421,624,347,381,683,247,448,497,260,139,504,235,251,388,165,201,156,342,369
+L07765_at,397,314,306,284,145,222,452,352,338,176,228,165,188,292,221,307,216,68,214,158,112,164,305,275,331,115,131,251,293,1394,226,233,279,98,730,346,275,360
+L07868_at,24,65,107,-34,51,3,-48,0,0,30,4,-10,2,35,10,31,176,40,-146,-20,-44,79,-110,-26,14,52,132,39,57,-80,21,-114,16,-63,-70,7,-34,-67
+L07949_at,10,18,67,17,22,28,-6,-13,-8,1,21,31,2,-14,0,-8,1,-14,-6,26,9,-14,-11,25,-4,-13,61,-7,-16,80,8,-9,-4,-10,10,-36,52,-27
+L07956_at,179,51,234,424,628,-32,384,154,204,-8,-11,60,319,73,525,520,335,742,277,1127,777,11,100,507,-3,54,420,191,69,15,45,-73,-88,19,-71,108,-23,-127
+L08069_at,1361,2148,907,1392,2016,357,527,511,655,390,338,544,1347,580,1794,756,931,307,654,3039,438,410,294,1408,1972,347,-237,497,247,722,1037,394,650,238,2234,370,478,655
+L08177_at,-110,18,-192,-88,30,-49,-82,-58,-111,-61,-92,-97,-46,-45,11,-81,45,45,-2,-42,-104,-141,-193,9,-42,-52,-12,-86,-14,165,202,-37,62,77,174,129,94,510
+L08187_at,984,947,1325,823,625,821,1082,1003,981,671,663,655,539,723,608,755,846,2272,567,938,550,685,729,741,756,626,1201,751,687,1138,482,1080,896,306,1063,949,1105,1557
+L08246_at,543,2972,485,740,2453,375,961,404,783,1288,733,2095,1405,742,1718,623,1016,1198,1010,1969,1377,791,596,868,635,827,190,3127,853,6159,5503,2083,6718,1766,4915,2056,4136,4126
+L08424_at,-18,23,-150,-82,-41,-140,-63,-110,-87,-39,-67,-60,-11,-49,-54,-75,-107,-32,485,-10,74,-48,11,-90,-97,-39,-81,-47,-163,11,-117,-14,-72,-109,-103,22,-47,-40
+L08485_at,16,36,61,-4,20,48,-21,61,17,16,24,-12,0,7,-47,48,60,36,1,47,62,23,110,-27,30,33,75,51,-14,126,33,-19,32,33,54,49,66,130
+L08488_at,-163,-12,145,-53,80,-5,10,-1,-137,177,-43,-37,8,178,-35,-22,-71,257,100,17,-56,34,77,-20,93,24,84,-20,96,-14,31,-57,-45,0,47,154,133,12
+L08666_at,987,1564,1617,1488,1626,821,1549,1031,2160,1111,1909,1136,1076,1177,1199,825,1013,992,658,2061,1597,1084,1046,1639,1029,1177,594,1693,1654,2492,1327,2249,1604,1010,2711,1517,780,2522
+L09190_rna1_at,149,97,253,153,120,85,142,206,162,68,134,81,136,149,70,201,83,249,45,92,139,133,104,90,73,102,231,150,127,166,130,196,178,38,147,143,197,271
+L09234_at,-6,28,-61,-46,-32,-10,-65,-2,-6,-44,-50,-50,-30,-48,35,-4,-60,-17,-47,-67,-13,-19,-93,-28,-44,-53,-17,-89,-127,-50,13,-36,-74,-30,2,-19,-45,-84
+L09235_at,130,133,254,266,178,188,62,236,237,99,131,97,141,229,84,109,72,179,94,196,76,126,77,162,169,130,206,176,165,298,436,484,172,122,275,295,274,140
+L09260_at,626,760,685,482,400,704,475,164,939,536,717,556,470,542,870,415,763,248,440,1492,1086,439,454,772,642,668,646,326,348,425,553,326,400,504,844,608,561,473
+L09604_at,1525,2283,1821,2829,1448,1216,1779,1334,4977,2409,3922,7639,5105,2150,1678,1800,2558,751,841,1491,544,1378,1048,2861,9016,1985,1201,2286,2188,8017,4441,1768,4319,4859,6117,6363,2743,4230
+L09708_at,53,235,238,123,55,-33,84,173,169,177,81,109,215,116,137,198,512,117,103,429,287,1,96,141,170,124,122,667,305,735,295,175,213,195,662,58,116,177
+L09717_at,-2,100,-5,-27,51,-19,-21,116,88,38,65,63,104,0,50,65,336,87,-1,104,117,-14,68,25,35,-14,131,348,62,360,211,139,114,141,466,164,131,66
+L09749_at,-47,-20,-398,-121,-40,-181,-159,-55,39,-65,-134,-64,-165,-4,-108,-237,-144,11,-107,48,-27,-190,-112,-82,-58,-145,-51,-202,-137,-220,91,-118,-191,0,-62,-226,81,-301
+L09753_at,-246,-98,-328,-260,-159,14,-292,-277,-265,18,-106,-129,-77,-122,-99,35,-123,-211,9,-211,-123,-253,-212,-25,-178,-106,-179,-291,-221,-158,-93,-305,-209,-109,-226,-179,-165,-230
+L10035_at,53,56,18,40,30,-238,-15,-37,-66,50,71,-67,8,-5,93,37,56,13,14,-8,-3,-107,-30,-71,-93,35,34,-36,-151,-11,-50,-50,97,139,65,-6,38,19
+L10102_rna1_at,97,60,49,-23,66,248,129,212,107,154,36,44,25,-4,-6,36,50,57,77,61,-68,-40,98,39,33,72,82,71,62,202,52,64,45,69,39,81,31,79
+L10123_at,51,109,98,98,34,32,112,172,87,7,53,90,28,33,41,107,173,105,30,99,14,54,22,123,65,53,197,102,129,111,65,25,48,46,148,56,162,24
+L10284_at,1859,1631,2878,2792,3380,1566,2175,2115,5840,3033,3391,1258,3137,2494,2837,2615,6160,1922,3469,6803,5085,1552,1791,2623,2408,2228,2491,2741,2219,3815,2933,1652,2574,2365,3978,3352,3366,2364
+L10343_at,92,60,157,70,179,58,95,-85,74,181,136,-50,136,39,190,287,255,176,32,154,58,-53,98,395,4,246,-7,207,117,86,123,9,18,115,219,115,88,90
+L10373_at,536,1258,2098,254,127,1655,295,245,2951,1712,718,229,1452,1949,24,302,10,-110,992,-212,13,183,269,64,434,635,352,100,137,40,63,127,-62,-7,288,180,211,-259
+L10374_at,-11,64,17,-6,1,37,85,167,13,51,10,-28,29,18,104,10,10,-36,9,31,-84,35,81,8,60,-5,-32,-63,16,-9,141,-67,27,70,-18,43,-37,-28
+L10378_at,954,472,970,805,805,480,784,874,1071,413,724,422,695,594,670,478,318,433,886,704,149,759,132,762,951,391,949,637,524,626,464,866,489,410,1080,508,618,451
+L10381_at,-63,-89,-115,52,9,-7,-62,-170,-82,-44,-58,-56,12,-64,4,-57,-53,-16,-22,53,-104,-77,-146,-71,-94,-81,-186,-139,-209,-46,-78,-141,-96,-7,-102,-117,-53,-52
+L10386_at,469,-286,213,343,-3,135,131,-527,302,229,-371,73,216,-91,7,373,-126,116,1,-330,-186,-91,385,60,-52,-100,-54,413,-403,434,-1123,-1847,360,-420,-784,289,-110,-753
+L10403_at,-378,-224,-705,-232,-228,-129,-213,-346,-506,-76,-356,-165,-175,-269,-203,50,-237,-194,-16,-286,-81,-126,-89,-88,-121,-174,-475,-382,-269,-137,-60,-290,-372,-201,-409,-115,-139,-112
+L10405_at,-13,-19,111,89,61,49,181,202,6,67,63,37,70,-18,53,-44,120,141,-4,136,37,30,66,50,64,18,223,-54,281,74,47,99,12,83,58,-24,70,95
+L10665_at,117,82,169,167,48,112,142,209,-76,84,2,57,68,136,43,130,15,93,72,72,-1,19,165,101,18,72,3,80,48,71,196,297,86,-30,64,139,110,214
+L10678_at,-92,139,-117,-120,-83,-103,-50,-158,-86,-35,-72,-94,23,43,-79,-49,-68,-90,82,14,-66,-130,-22,-57,-13,-94,-84,-170,-134,-124,-189,28,-35,-31,-106,9,-69,-182
+L10838_at,2794,2393,4962,2308,3514,2937,2742,2548,4845,2207,2022,2096,1862,1823,3866,1953,2225,1283,1498,4164,570,2079,1972,2411,1871,911,1383,970,810,1903,1982,2107,2914,1735,1548,2775,2168,2736
+L10844_at,-60,-35,-25,51,-207,80,38,74,0,-321,-32,-93,-124,-81,-197,-335,-230,-191,-101,-273,-224,-138,-134,-255,59,-27,-436,-143,-62,-97,113,241,-174,-175,-111,-81,-147,-33
+L10910_at,423,841,581,471,799,172,584,404,327,380,1078,248,754,716,677,896,445,89,701,3845,1055,714,406,1473,219,415,198,517,221,687,530,819,1001,214,401,202,535,615
+L11005_at,-40,4,224,31,80,80,115,20,-20,10,-4,-67,70,102,70,68,-44,-68,20,62,-44,15,-41,15,-18,5,65,-150,-40,23,59,6,-75,46,-100,-27,-5,-36
+L11239_at,-81,120,-281,-22,67,-7,-110,127,-162,-152,-47,34,-80,-58,33,-52,-68,-64,255,135,56,-26,-110,-94,227,-78,140,-54,7,-135,564,608,22,137,86,-40,82,473
+L11285_at,859,891,1248,985,956,1449,878,358,1910,1234,1463,206,531,1160,743,1327,789,1467,1186,2175,617,92,1054,735,564,987,239,936,1012,1294,1713,1235,686,929,1237,1357,1949,287
+L11329_at,-359,1280,-1998,-1786,38,-558,-1179,-1521,491,-7,-501,-392,-603,-879,-503,-99,-523,-294,474,-61,-33,-1268,-1242,-343,30,-396,-132,-1533,-771,178,-42,-1507,3984,-420,-779,-405,236,-247
+L11353_at,-193,142,18,-247,-46,3,48,23,-124,68,-12,-211,38,-34,-8,-400,-16,49,23,253,139,-162,125,64,59,141,18,35,74,9,-149,175,-184,19,-16,-79,-66,-191
+L11369_at,96,161,-114,-38,150,80,53,-685,-282,236,-67,123,229,-141,13,214,-16,76,77,187,-24,85,-170,50,120,101,295,115,-257,309,77,81,-108,34,-6,-177,302,-375
+L11370_at,1325,1266,1716,1052,847,990,1345,2034,948,1193,1139,1161,1003,414,626,1241,1836,935,1019,1411,572,1248,1155,1120,966,1235,1854,1379,1363,1128,505,1485,1033,294,1397,863,1848,2100
+L11372_at,-82,-46,-49,-62,-2,-122,188,290,101,43,-42,-21,1,65,-21,-19,205,-40,132,-36,66,-44,-43,-30,-32,-100,84,118,69,-58,-65,184,149,51,99,111,44,21
+L11373_at,1418,722,1150,1935,2410,946,3078,1820,960,559,750,763,1629,750,2131,1337,1512,752,929,1694,669,1050,936,3558,1114,1179,1028,1046,610,1195,1339,1391,1271,775,956,763,874,1863
+L11566_at,12112,15076,11838,14972,17050,11010,9281,15556,15645,13138,14742,14089,9225,14926,15441,15276,10397,14391,10687,14550,3739,15127,13242,14585,16806,15814,11281,11740,6963,10654,14267,16400,14708,14117,10867,14646,13625,12517
+L11573_at,33,-36,-25,-19,-64,42,42,26,37,-2,37,-10,-24,-24,34,75,-32,-49,48,-17,14,-53,41,-11,-1,23,103,-27,2,0,-93,6,-97,-13,-17,-71,-50,-73
+L11669_at,723,995,-203,704,1142,-17,566,506,515,-26,372,878,798,699,1179,172,1313,552,410,2225,1121,976,-41,1002,830,868,-187,2951,1288,3128,735,1091,1111,1132,2378,1357,1171,1122
+L11695_at,-93,-84,-176,-3,3,-42,28,-32,-73,-66,13,-8,-21,-39,34,-51,-132,-53,24,-70,4,-30,37,-97,-4,-37,-189,-67,4,-80,27,90,-15,211,-51,-108,3,-35
+L11708_at,137,251,222,268,120,10,327,206,227,120,149,17,158,171,97,177,113,172,-25,233,117,26,138,171,120,140,469,178,199,251,91,58,257,89,94,30,25,284
+L12168_at,3477,3509,3291,5036,3863,1735,3810,2045,3956,1333,1654,2118,2376,3849,4086,2711,4752,2528,1972,3900,1821,1951,1210,3094,2127,1891,2746,2788,1853,4202,1511,1652,2007,2533,3791,5285,3828,2248
+L12350_at,78,32,35,63,84,-62,-36,31,50,54,100,61,60,61,56,209,96,67,75,193,46,-45,-85,-72,82,49,37,12,-43,27,19,65,152,55,60,47,50,104
+L12392_at,1413,732,1150,1409,952,640,1371,1025,999,671,809,587,934,809,883,933,416,1347,845,1064,683,1174,889,922,1039,938,1267,1049,1033,1671,1673,1431,1278,843,1314,1339,1283,1958
+L12468_at,100,80,134,71,36,62,50,103,89,41,32,31,48,89,7,79,87,20,59,39,11,73,20,69,74,58,93,63,24,47,83,82,70,43,60,113,96,116
+L12535_at,305,373,612,326,403,145,290,263,571,160,264,146,320,354,186,278,461,144,184,658,301,115,134,323,157,115,186,291,228,469,407,440,293,202,381,391,327,333
+L12701_cds2_at,116,-19,116,112,10,151,181,35,136,-86,-26,79,-51,-41,-69,-71,-79,-66,-107,52,61,133,214,-170,-5,-91,-43,-189,-110,39,2,-41,-92,122,-91,120,43,-105
+L12723_at,346,168,312,326,412,151,253,119,279,399,319,140,167,208,327,124,90,290,190,429,354,210,55,220,49,17,67,232,84,206,294,-35,168,143,311,163,207,139
+L13042_at,258,32,307,197,-19,266,156,139,202,193,85,57,25,173,79,-102,135,59,39,-63,42,68,254,-45,-111,36,486,160,60,231,289,21,237,6,117,129,116,465
+L13197_at,44,18,222,385,52,117,534,-17,-196,115,152,152,-42,78,-1,-78,212,65,88,-35,52,232,41,43,-33,38,48,63,507,-3,200,68,365,101,-7,176,183,463
+L13203_at,1055,932,1597,256,239,142,297,853,381,138,844,421,1071,828,424,569,774,288,181,960,590,941,739,1058,263,790,1165,697,415,945,249,759,1377,-17,251,1136,381,1569
+L13210_at,-381,329,2281,300,-321,745,798,-469,1931,129,223,360,1672,696,943,487,292,129,614,1239,228,13,-195,225,699,542,-300,2222,1385,487,1274,-257,1474,1507,2701,4622,-726,-254
+L13258_at,185,-32,220,-63,35,-8,-129,-34,95,7,77,-79,-39,67,-90,1,-145,3,-82,-198,-387,88,45,96,47,-3,-129,35,-64,41,-69,-93,68,-111,-69,-51,70,72
+L13278_at,193,31,198,91,194,96,178,112,198,9,36,-22,170,188,217,240,254,32,200,338,119,7,85,191,14,6,79,6,-7,22,-32,-16,16,-17,-16,60,34,-44
+L13286_at,54,-47,19,-23,13,-42,-82,5,2,3,-7,1,-84,5,29,-33,-13,13,-118,-61,48,15,9,-5,-32,-49,1,-92,-48,0,-10,-57,-33,39,31,-138,-134,-61
+L13329_at,61,118,108,10,51,21,-10,-4,21,38,85,31,6,69,-1,1,101,38,37,33,-1,6,37,18,18,23,-54,62,-36,-45,22,59,129,18,139,48,284,2
+L13391_at,23,1217,30,-13,176,-1,-179,178,98,467,71,-31,5,125,372,378,-38,109,3,617,475,785,3,-76,1133,350,272,-14,-117,501,591,10,1540,43,-48,43,619,1251
+L13434_at,478,482,637,484,251,375,537,1046,1009,234,960,152,473,411,388,436,668,529,399,1201,229,914,364,916,414,504,632,612,447,576,524,531,597,426,584,793,820,794
+L13436_at,307,322,515,89,14,48,327,679,228,189,255,79,-223,225,93,792,652,408,178,275,333,44,132,266,495,258,298,25,526,243,119,241,208,-55,3,18,305,499
+L13689_at,628,658,692,289,210,254,403,769,1014,163,651,160,1084,309,357,316,1479,185,304,1964,999,513,467,668,305,328,458,689,300,253,274,333,512,578,499,516,686,562
+L13698_at,22,-89,-30,20,13,-62,-38,-119,21,-10,3,24,53,8,-31,107,-88,-22,18,55,41,0,77,41,29,70,-40,-31,-98,-64,12,1,13,42,-61,-44,44,-46
+L13720_at,-1579,-518,-1862,-894,-768,-576,-1103,-1659,-1352,-804,-897,-632,-736,-1473,-771,-1224,-1438,-736,-618,-1367,-643,-1313,-965,-1312,-1439,-794,-1517,-1546,-1430,-1366,-1183,-1477,-1739,-708,-879,-1037,-1035,-1375
+L13738_at,104,728,279,619,495,172,562,248,419,208,104,454,477,-12,518,531,689,141,696,1740,708,1199,545,498,964,419,42,1108,781,409,770,736,504,424,629,430,621,887
+L13761_rna1_at,294,655,459,407,620,266,220,463,505,206,582,150,361,476,401,437,930,254,258,950,692,398,207,465,295,254,344,429,365,388,425,827,537,514,332,440,324,532
+L13800_at,173,193,61,140,225,40,188,55,140,-4,97,66,291,130,312,169,535,65,145,969,393,163,214,291,51,171,187,172,96,100,116,116,97,57,112,86,101,47
+L13848_at,451,996,731,630,836,499,438,1021,901,436,1197,354,447,772,677,869,1514,321,451,2314,660,1020,733,778,612,155,533,590,492,767,709,975,696,447,609,511,494,573
+L13852_at,1967,1752,1827,2221,1773,1269,2796,1514,1650,808,482,1103,1830,2522,3042,2445,2945,670,3079,3939,847,831,737,2519,2118,3684,1137,3176,2592,1898,1064,727,1004,669,1298,2941,2783,1039
+L13923_at,349,144,442,368,250,190,344,439,428,241,230,185,162,370,218,278,271,230,283,259,271,350,113,327,310,220,201,354,336,521,281,217,303,102,334,295,454,712
+L13972_at,411,855,907,521,559,149,603,1113,681,333,236,597,666,778,629,400,808,445,629,997,317,1404,315,665,476,557,384,680,750,689,856,1053,1635,610,581,330,1365,1598
+L13977_at,211,116,75,-79,222,23,-258,-193,197,-76,-4,-86,192,37,151,56,247,262,-32,245,473,-14,-53,-56,-66,102,522,347,-26,424,114,83,90,74,595,57,166,12
+L13994_at,-393,-299,-338,-342,-270,-232,-396,-337,-365,-105,-253,-275,-302,-69,-242,-150,-485,-176,-232,-365,-4,-421,-283,-441,-406,-203,-696,-474,-329,-578,-621,-483,-523,-210,-365,-196,-339,-519
+L14076_at,1013,494,750,824,834,608,446,392,984,596,1302,379,1202,1014,875,715,1039,708,736,1402,965,1009,849,750,441,393,278,744,690,1036,1169,976,729,343,555,426,518,898
+L14269_at,54,29,290,52,9,62,43,5,45,37,33,8,-10,105,0,58,32,49,48,4,56,37,119,98,59,36,32,-11,72,10,105,35,213,0,43,88,55,81
+L14542_at,-94,-12,-76,-99,-23,-60,-73,-44,-19,-35,-23,-81,-92,53,-25,-77,-30,-5,-44,-8,-53,-14,-20,-101,-83,-31,-100,-54,-93,-40,-58,165,-31,-29,-20,-39,-25,-46
+L14565_at,734,229,507,130,-116,-88,94,88,711,353,180,-54,240,382,-11,-177,505,402,-2,647,-54,754,30,-598,-234,432,-206,-126,-685,469,59,158,795,166,352,-485,-504,-394
+L14595_at,-473,-168,-354,-214,137,-261,-383,-745,90,-71,-129,-215,-174,-103,-138,-147,-350,78,-66,-81,-123,-111,-169,-379,-122,-208,-719,-372,-278,-166,-382,-446,-112,-91,-263,-132,-465,-61
+L14754_at,453,314,387,328,-197,592,280,793,839,556,567,511,225,263,151,225,802,510,339,1130,610,704,625,751,783,339,621,820,663,323,1283,898,391,265,740,674,245,502
+L14787_at,88,180,42,205,44,160,241,133,198,113,42,183,156,113,139,151,304,26,69,253,203,163,193,197,117,182,550,-3,-28,13,165,149,151,57,205,70,210,336
+L14812_at,337,343,476,216,84,220,285,392,358,262,186,209,261,374,211,388,196,57,202,251,253,109,208,276,124,310,485,337,536,244,465,423,371,173,478,299,495,580
+L14813_at,3359,3301,4341,3046,2071,4516,2688,2530,3607,2296,2512,3842,1842,2151,2961,1955,1586,2155,2307,3458,2803,3635,3835,1960,2471,1950,5216,1837,2755,2395,4866,4298,3530,1967,2651,2882,4352,5767
+L14837_at,143,28,140,128,8,104,186,122,120,38,1,129,24,55,59,131,36,100,69,964,-3,28,9,117,24,64,173,76,79,101,213,209,190,15,96,129,111,165
+L14856_at,768,355,1061,495,442,994,1164,778,452,696,612,620,340,485,394,585,374,375,531,632,454,848,925,755,482,535,736,763,899,1002,1031,889,776,531,539,1232,1106,1497
+L14922_at,75,101,72,33,248,44,-1,-59,229,154,293,-7,223,137,95,-13,99,115,44,197,123,45,32,170,49,12,-1,20,-173,-64,37,51,75,22,13,88,70,15
+L14927_at,-1245,-1815,-1605,-2162,174,177,-1408,-215,-1414,-682,331,-163,-331,115,-176,-1581,-560,229,-714,-1179,-850,-69,-670,110,130,-208,-2739,-1856,-1882,318,-2181,273,-1511,-352,-1507,-774,-1263,-1126
+L15309_at,208,86,279,191,32,163,263,241,117,96,128,14,131,135,65,143,-31,70,115,180,46,107,186,125,128,149,298,186,129,150,123,78,134,38,119,134,178,139
+L15344_at,-336,-611,-392,10,31,-721,-495,170,5,-409,134,-538,-2,-510,-398,-335,-141,109,-170,-559,-322,-241,-497,244,-158,-211,-934,179,-259,-25,55,-142,-337,-265,129,-812,-720,143
+L15388_at,-341,-435,-559,-127,85,-601,-1019,-271,137,91,-140,-617,-41,-447,-131,-965,-901,-140,-128,-693,-37,-819,-340,-20,-746,245,-1162,-438,115,-894,81,-79,-606,-11,-7,-61,58,-1151
+L15409_at,528,437,586,479,462,558,320,107,514,392,501,281,405,360,658,357,588,296,198,610,18,506,364,467,284,100,416,228,151,464,384,243,464,147,515,465,597,123
+L15440_at,-1637,-2244,-2113,-2056,-1327,-1792,-2187,-2449,-2027,-1456,-1249,-1677,-1615,-1479,-1496,-1487,-3236,-1072,-1086,-3136,-970,-1243,-1985,-793,-2170,-1590,-3777,-1467,-1457,-1727,-2167,-1717,-2086,-1359,-2137,-1113,-2828,-2284
+L15533_rna1_at,-39,-43,35,132,-62,14,16,-26,56,-2,-4,-63,-47,-27,-66,-126,27,-10,-12,-39,51,18,-47,-106,-67,-50,54,-42,36,-33,9,33,-31,-82,-2,-27,-22,64
+L15702_at,1718,1279,1975,1679,817,1191,2029,1932,1297,933,1171,734,741,815,865,959,1266,871,1037,1305,480,1573,1223,451,1265,712,1556,1686,1257,1472,2376,2557,1382,683,1189,1396,2017,2428
+L16464_at,316,134,718,215,247,225,263,202,479,211,229,222,263,206,258,258,153,361,193,237,66,317,142,252,363,265,28,297,170,413,242,295,677,154,189,266,389,516
+L16782_at,83,50,289,123,247,113,62,316,178,153,157,71,203,95,164,86,311,308,73,341,31,83,104,56,81,160,192,141,86,206,83,76,199,77,62,13,150,214
+L16842_at,569,1299,1065,620,1632,821,73,233,1852,1584,1286,449,1244,1041,1741,1046,977,676,868,2240,99,402,706,1223,316,1370,244,492,57,1551,1265,566,749,912,2606,1196,795,635
+L16862_at,1787,-12,3010,1383,1430,1118,1356,1355,1940,-42,103,304,1400,1708,981,1761,2652,1407,1306,1342,980,910,197,1538,1130,1632,1938,1251,1534,1267,542,351,573,226,1936,889,1599,1574
+L16895_at,224,114,238,282,48,158,196,202,182,71,95,48,95,126,98,15,160,10,100,96,102,153,140,11,121,95,250,106,226,201,165,165,213,23,249,156,245,120
+L16896_at,153,39,-466,401,138,-343,-104,169,-478,97,-205,122,84,-18,243,68,-191,76,103,643,-221,-189,-530,-50,189,-27,-643,147,281,-527,436,116,64,-255,-15,64,-233,-74
+L16991_at,343,368,724,464,235,46,-89,-146,225,640,455,60,296,269,695,279,100,-49,21,450,102,146,148,54,545,112,690,-143,-91,360,213,-34,-10,-111,439,-171,-52,122
+L17128_at,154,151,247,158,173,94,117,121,79,78,87,54,87,37,155,98,189,104,-49,138,68,147,39,133,95,152,355,303,216,208,78,79,169,-34,436,116,115,115
+L17131_rna1_at,4801,2853,2648,4421,5889,2935,5111,1227,7355,6734,3457,2254,4628,4860,7462,2755,4334,4265,2689,5104,1266,1061,4174,4182,3689,4174,1436,7635,4258,5886,10584,5522,9246,5674,7169,4880,3140,3617
+L17325_at,-54,-33,-117,-91,-48,-65,-78,-76,-95,-27,-94,-21,-4,-81,18,-89,-112,8,-48,-6,-68,6,-34,-65,-47,-19,-87,-88,-146,5,3,-82,-83,-53,-71,-109,-19,-139
+L17327_at,-206,299,646,130,171,581,702,416,679,626,319,326,102,70,-26,155,721,186,167,112,81,383,478,145,190,330,-209,124,483,27,553,625,95,119,93,-349,843,233
+L17328_at,203,108,231,164,162,55,114,212,126,101,109,93,119,96,81,169,165,129,110,148,76,138,157,105,138,142,236,161,129,105,131,195,148,14,155,117,151,252
+L17330_at,186,43,356,200,61,161,240,-418,-10,45,146,-64,-8,-44,190,125,57,182,-10,81,-3,66,106,-45,-67,48,389,-169,-466,41,20,-329,28,17,-207,158,234,-250
+L18960_at,1055,1528,1748,901,1874,565,1256,1203,1133,769,941,1135,1528,1325,1464,810,1337,515,589,2141,2082,775,571,1642,1257,1251,583,1304,1457,1091,1188,1299,1234,695,1354,1160,1127,2014
+L18972_at,552,390,761,435,519,526,584,313,698,652,442,304,459,546,583,408,439,401,319,845,464,380,484,589,328,501,491,517,387,474,293,389,537,274,317,379,385,414
+L18983_at,3234,1758,4000,1828,2134,2185,2634,2470,3215,1710,1593,1126,1536,1755,1323,1615,2947,1411,1321,2983,936,1843,1670,1871,1655,1512,3855,2112,1974,2510,2050,2353,2137,1074,4250,1891,2257,4492
+L19058_at,-9,-10,18,-61,-25,26,-67,127,25,15,78,11,21,-48,-30,-22,-45,14,-46,-24,-6,-19,-186,8,27,136,-23,201,177,-5,-131,35,10,51,-32,71,26,-14
+L19063_at,-214,-130,-126,-134,-72,-40,-210,-56,-116,-83,-81,-56,-56,-70,-40,-15,-86,-131,-84,-113,-102,-48,-170,-170,-25,-35,-256,-54,-96,-119,-136,-119,-164,-22,-60,-96,-188,-149
+L19067_at,904,652,821,690,421,419,885,785,1162,438,985,425,560,484,643,299,1179,556,829,2555,1430,549,398,1177,423,1274,1002,1352,678,1478,1224,1575,844,632,1252,748,1239,825
+L19161_at,304,89,220,297,400,122,336,134,401,647,96,336,454,230,514,599,197,266,632,1182,53,60,199,555,263,181,452,129,156,126,268,383,611,69,346,362,123,488
+L19183_at,184,141,224,115,84,142,126,292,477,130,268,106,441,197,254,63,731,390,102,370,303,160,184,386,115,136,173,204,36,100,18,67,203,85,166,256,140,49
+L19267_at,1335,1070,1765,1088,178,1104,1127,1442,301,601,1184,1039,862,770,849,1035,343,299,601,467,1196,1178,1432,1391,1225,1509,73,902,971,263,925,965,96,512,18,-133,964,76
+L19297_at,-120,-197,-320,-136,-3,-243,-109,-233,-277,-102,-165,-34,-84,-146,-107,-109,-359,-80,-290,-304,-122,-133,-167,-336,-229,-117,-409,-602,-64,-212,-73,-91,-402,-177,-549,-70,-221,-260
+L19314_at,303,263,776,333,111,183,208,251,176,479,192,181,228,365,51,235,247,356,237,225,241,200,262,477,298,180,45,430,428,194,255,273,205,193,306,283,462,-185
+L19401_at,136,162,256,101,83,321,159,65,193,93,130,165,119,135,85,107,194,67,66,40,77,209,188,129,147,107,195,144,108,111,94,106,88,9,143,137,232,119
+L19437_at,990,2605,1794,2016,1912,1068,1021,1187,2680,1305,1060,2073,1651,2133,1829,1358,4200,1406,1084,2853,1684,343,936,1612,1926,1859,535,3489,1714,3460,2691,2393,2158,2115,2655,3725,2509,1420
+L19527_at,15020,17275,15112,16768,17138,10903,12484,16858,16403,12314,16361,18167,17561,17067,16403,16854,16112,17500,14843,15262,24472,18848,12134,15864,18719,16465,18031,16229,13323,14983,16708,18340,16443,17702,15200,16611,17159,16029
+L19593_at,44,29,5,66,46,21,-57,-13,3,31,47,31,55,-9,33,95,123,47,5,83,88,30,75,58,58,49,115,24,103,-1,-21,63,67,-25,66,47,34,-83
+L19605_at,1790,3155,2567,1154,1114,1795,15688,1146,3583,1838,1442,912,1810,2744,1435,1694,3203,1683,1096,1885,1024,941,1751,1136,1227,2492,937,2131,1478,2949,1382,849,1659,1312,2464,2129,3169,1541
+L19686_rna1_at,785,7260,6254,623,6139,3583,-398,-865,9695,6816,5763,4378,3068,5611,5939,3349,3152,5773,1717,8042,974,613,4307,2617,2738,3648,862,3079,572,2211,769,446,2594,3584,3147,5698,2325,-530
+L19711_at,-76,-55,-25,73,99,-19,134,455,-30,12,68,47,17,59,-15,122,617,83,107,275,41,-137,87,233,131,90,533,-4,122,-10,253,193,166,74,117,-65,46,267
+L19778_at,4,-2,-17,33,64,-21,73,61,-4,31,-13,-8,62,78,10,-15,68,48,2,29,-1,31,81,64,41,10,-6,14,-31,61,-9,-45,13,-9,19,7,58,5
+L19779_at,4660,4644,2488,3153,3185,1198,4528,1454,1798,5702,1248,11149,4229,841,2826,3097,5339,932,1045,6219,2700,2809,1212,6566,11473,6414,1678,20201,1055,9452,16492,10574,7493,8137,20688,5272,11139,3959
+L19783_at,19,184,29,108,187,-12,-35,2,103,43,77,30,112,69,108,58,83,73,90,262,406,141,-75,160,26,64,161,96,48,58,88,184,48,102,75,14,138,5
+L19871_at,3,886,74,160,190,154,161,254,190,1683,668,369,178,164,138,76,-51,168,257,733,137,40,72,69,1199,156,139,204,170,231,825,397,3773,97,327,112,355,734
+L19872_at,-43,526,-96,36,166,3,53,-4,-36,-26,19,44,115,75,116,-23,344,118,45,-56,27,-15,55,89,21,43,-64,124,36,922,160,121,269,114,981,214,209,70
+L20010_at,1616,1417,1378,815,1185,1337,1517,773,2842,1154,2010,366,2142,1483,1779,806,2259,612,1236,3458,1467,557,1580,1785,690,1280,1063,1201,1231,833,1142,459,628,592,592,984,1129,533
+L20298_at,1290,1752,2509,1793,2431,994,1710,778,2928,1620,1216,500,2597,1727,2050,2020,2739,699,2027,4266,1576,795,499,2375,694,1074,1079,770,488,1462,669,530,1070,552,797,1326,897,505
+L20316_at,1465,1221,2330,879,1218,1445,1895,1707,1737,1434,1088,1106,1303,1277,700,1262,1485,703,825,382,465,1231,913,1084,1116,727,1013,1709,1488,1928,1898,2014,1682,683,1909,1816,1215,2454
+L20320_at,104,71,69,188,242,10,174,22,49,77,260,58,65,210,126,108,49,118,173,266,193,115,96,157,28,19,1,87,24,124,275,389,190,202,212,119,165,84
+L20321_at,42,37,29,70,157,-67,57,17,3,59,3,33,59,44,32,51,131,39,62,136,192,9,37,28,55,58,35,-4,-2,-15,43,6,42,-10,-29,-11,40,9
+L20348_at,52,35,75,22,19,-90,70,-14,28,123,-3,33,21,31,-39,17,132,2,73,115,-51,-3,-79,90,70,76,128,-7,-7,28,-83,113,-64,45,44,-39,-43,46
+L20591_at,31,0,42,-39,-12,62,-13,77,45,6,21,-4,-23,4,-46,42,15,-1,28,-7,-36,86,-15,-14,28,30,42,69,2,28,88,41,66,10,-8,47,48,72
+L20773_at,1911,1212,1546,926,849,718,853,970,1495,1030,1250,959,690,1067,843,964,782,674,601,2280,795,779,780,1000,587,808,738,756,634,872,984,1147,891,673,985,829,1260,786
+L20814_at,12,43,-5,12,81,35,-38,-2,24,82,64,48,74,53,35,50,54,33,69,105,57,10,49,93,94,78,153,87,-137,41,55,66,35,71,60,27,24,133
+L20815_at,442,611,647,532,340,437,969,802,695,483,257,267,288,445,207,175,345,383,335,449,307,253,524,585,504,362,563,440,329,597,579,733,594,151,593,746,647,662
+L20826_at,177,100,334,58,48,110,188,242,189,134,217,110,23,154,44,241,71,115,85,128,94,142,155,26,77,159,244,296,137,77,69,373,103,9,143,139,146,427
+L20852_at,-5,43,58,56,8,-1,55,73,26,15,48,24,48,53,51,93,224,47,-3,138,102,-11,51,73,38,41,132,80,-43,41,23,8,116,170,31,-9,59,53
+L20859_at,-49,187,-118,-47,65,67,-119,-29,-104,19,33,74,127,225,282,-208,78,1,33,141,-196,-70,-58,91,35,18,-35,24,-127,1,49,-17,64,53,477,136,29,-115
+L20861_at,142,65,90,212,70,128,151,397,134,137,145,67,116,125,172,49,272,104,89,101,113,138,167,217,74,65,181,111,125,67,236,109,161,17,174,128,78,215
+L20941_at,2654,6765,3387,1646,2189,2951,1885,2193,5145,2334,3947,4207,3709,2466,4968,2102,3974,1891,1712,5593,3173,8670,2505,1876,5221,4124,1128,2537,1226,13963,13317,16171,13057,8213,12449,3250,6749,14471
+L20971_at,311,344,82,-33,218,49,18,1385,86,65,26,1108,3274,48,231,506,152,76,2879,4725,38,238,20,52,1552,1127,242,138,48,815,853,163,1770,346,89,96,139,1443
+L21715_at,-225,-160,-293,-185,-134,-188,-273,-56,-160,-117,-145,-163,-100,-209,-8,-77,-328,-21,-181,-156,-162,-193,-208,-122,-150,-155,-93,-131,-113,-264,-173,-256,-113,-71,69,-201,-84,-122
+L21893_at,397,230,870,610,397,526,544,1024,519,234,202,100,450,505,318,499,1286,526,449,590,118,431,668,561,213,201,1114,613,819,666,538,399,386,311,479,599,588,863
+L21934_at,22,44,50,30,34,21,43,7,15,37,5,20,46,58,52,-3,85,35,16,36,13,-7,98,56,2,31,35,12,-12,62,78,99,69,37,170,9,30,73
+L21936_at,552,206,473,636,751,362,315,590,653,321,482,159,720,953,1688,405,554,972,781,1202,1707,295,300,886,271,1042,305,456,250,396,313,301,373,329,355,465,403,316
+L21954_at,1173,1948,1048,763,2197,179,1829,253,246,414,233,411,717,1022,2320,734,942,528,66,895,218,155,-58,1603,326,871,546,2548,194,7867,2210,635,708,3218,5609,1098,2322,1460
+L21993_at,-160,-614,-575,-274,-641,-288,-641,-166,-882,-35,-54,-79,-209,-165,-70,-529,-357,-76,-185,-1467,53,-130,-421,-341,-165,-817,-952,-480,-521,-530,-684,-646,-897,-414,-995,-43,-580,-1009
+L22005_at,-450,-3,-379,-799,132,-389,-845,-122,-570,-500,-228,-517,-276,-56,139,-574,-312,46,-234,191,-344,-584,-459,-270,-162,74,-690,-457,-238,207,-650,364,-468,114,-423,-801,-656,121
+L22009_at,3401,2996,4007,2949,4156,3871,3495,4965,3349,1960,5389,2693,2079,3052,2990,2487,2429,1345,2556,3906,4714,5656,2815,3253,4131,2007,2301,2695,2536,4887,2168,4509,2757,2453,2539,2837,2690,2132
+L22075_at,132,153,206,53,297,124,-99,152,185,84,284,171,67,65,216,136,293,-10,33,158,94,296,24,66,152,79,-84,59,-52,498,662,523,558,197,340,180,159,1153
+L22206_at,-563,-896,-896,-696,-447,-53,-204,50,-720,-329,-358,-80,-282,-288,-337,-536,-879,-112,-335,-729,142,-90,-497,-510,-507,-538,-1575,-739,-228,-662,-405,-199,-734,-399,-1063,-307,-448,-1742
+L22214_at,391,410,432,387,198,307,468,616,192,350,168,260,142,279,227,298,-57,274,255,428,158,232,324,262,197,158,569,192,526,445,727,151,317,439,26,370,395,804
+L22342_at,1334,1330,1188,1027,773,937,1184,1064,1353,781,556,395,826,1084,1040,934,1699,799,808,1439,580,549,450,960,728,638,1215,1199,1151,642,1483,229,880,351,536,843,868,2133
+L22343_at,427,151,436,366,360,231,305,332,276,165,123,143,216,453,558,216,213,247,138,501,68,228,224,432,233,304,265,141,69,304,381,238,158,94,172,230,325,564
+L22548_at,-294,-171,-450,-211,-150,-170,-204,-224,-163,-248,-265,-89,-183,-59,-70,-199,-341,-64,-129,-379,-128,-185,-180,-427,-83,-233,-295,-339,-153,-238,-186,-70,-94,-33,-151,11,-116,-79
+L22650_at,55,12,55,7,25,-32,21,-89,-49,-24,-21,28,10,-1,42,-40,35,8,2,87,77,32,-77,46,29,-37,-46,22,-16,59,-13,3,73,34,34,30,-7,77
+L23116_at,-137,59,55,67,297,-37,441,-43,-24,50,-40,67,165,215,228,69,75,-79,39,154,138,116,85,407,4,-19,-39,45,363,63,31,-39,18,-15,80,209,-6,-116
+L23808_at,-116,-177,-246,-211,-60,-94,-289,-77,-202,-44,-104,-37,-183,-110,-72,-94,-161,-98,-91,-211,-83,-69,-72,-112,2,-146,-48,-60,-67,-105,-240,-121,-180,-22,-94,-181,-232,-75
+L23852_at,56,74,218,77,101,19,149,247,139,100,64,79,64,167,35,71,77,47,75,83,-19,44,113,-48,41,48,89,510,91,186,158,58,206,71,182,96,92,216
+L23959_at,-823,-1003,-1084,-1234,-470,-659,-1285,-1322,-420,-539,-952,-564,-393,-439,-240,-985,-733,-787,-235,-925,-925,-1081,-1084,-538,-463,-511,-1835,-1012,-908,-745,202,-518,-644,-250,-776,-737,-1275,-1341
+L24203_at,-90,-180,-167,-122,-69,-144,-87,-55,-172,-128,-237,-139,-129,-193,-44,-178,-187,-118,-115,-323,-179,-109,511,-206,-135,-130,-369,-88,38,275,-197,-419,-307,-146,-140,2,-179,253
+L24470_at,54,55,55,39,43,46,16,203,-3,1,50,45,71,73,8,28,1,28,25,17,-58,18,79,73,-16,39,40,40,-36,19,65,90,36,-18,22,32,44,113
+L24559_at,1367,1070,2019,984,505,1419,1337,1248,1555,1218,1269,176,928,1203,1091,1163,533,775,883,2198,534,1354,697,1106,1084,873,1473,1409,1351,2241,719,939,1331,603,1219,793,792,1424
+L24564_at,-945,-791,-1035,-813,-302,-844,-971,-883,-862,-658,-641,-643,-537,-792,-586,-677,-1086,-708,-372,-955,-426,-513,-965,-752,-870,-713,-1179,-865,-925,-245,-338,-266,-925,-598,1228,-902,-1212,-764
+L24783_at,493,937,1044,473,280,563,415,530,621,427,702,252,1126,618,505,529,1278,624,557,819,553,493,611,991,506,521,284,247,363,371,476,603,555,432,-51,385,344,330
+L24804_at,990,976,1223,644,945,723,776,548,1276,686,901,488,985,695,893,641,2851,572,452,1396,67,389,625,1161,744,254,455,549,372,825,762,668,879,552,1294,854,936,531
+L25080_at,7881,7772,4378,5676,5292,4052,3295,5181,7537,6187,7185,6502,8718,3463,6257,6094,9778,4118,4634,9683,5157,4345,3311,5116,4153,10084,3439,5083,2154,6182,4124,2982,4446,4283,7518,5874,6504,5300
+L25081_at,1853,267,872,395,807,337,287,929,884,760,358,132,745,361,116,1090,-236,2141,413,2150,449,422,332,421,381,1026,272,1164,420,521,26,561,1349,435,-144,459,689,950
+L25085_at,809,1802,1839,660,1777,878,-67,241,4105,1125,3224,484,731,1780,1246,1035,1414,2639,206,2969,2163,942,868,1392,849,949,-4,941,377,2062,2074,2769,1534,1487,1850,1496,444,1307
+L25119_at,177,20,271,68,144,90,11,256,107,130,165,77,71,74,62,129,262,70,141,117,102,240,115,84,156,197,48,213,235,213,171,149,192,86,67,70,318,276
+L25270_at,-312,-213,-552,-195,393,-23,78,133,-212,-303,136,25,932,45,609,-233,-824,-444,-234,178,-316,-177,-436,83,-3,-47,-1272,217,610,-382,-2,10,-131,81,-744,-31,-273,-368
+L25441_at,-12,-13,44,13,33,30,97,17,57,56,6,-31,57,54,88,85,43,7,18,60,-4,62,-11,38,10,5,57,-20,36,50,-1,62,43,11,57,-37,68,15
+L25444_at,324,362,7,-206,521,154,-52,439,682,155,333,206,401,544,356,152,637,260,346,74,341,-83,332,494,50,88,100,672,353,40,676,-117,-94,-33,21,95,713,-67
+L25798_at,-56,70,93,273,57,87,-8,241,220,410,31,58,28,44,56,209,-14,72,24,-74,109,-44,-3,-21,85,-50,-120,46,-149,93,40,40,27,35,2,151,61,226
+L25851_at,362,1623,2103,573,945,414,272,184,2161,468,1315,73,278,365,828,255,426,228,222,707,1406,124,512,897,214,294,297,347,209,277,270,351,238,426,343,600,369,313
+L25876_at,553,234,944,1263,690,565,949,353,901,973,516,211,989,501,1026,248,607,1096,293,220,607,205,539,366,363,242,350,385,440,729,834,464,480,715,388,575,249,530
+L26081_at,-333,-431,-484,-371,-344,-360,-273,-347,-346,-305,-450,-129,-272,-413,-224,-317,-514,-276,-314,-285,-53,-260,-514,-440,-178,-293,-378,-361,-399,-331,-331,-488,-360,-170,-531,-376,-340,-409
+L26234_at,116,-148,94,85,-1,62,-5,128,-144,49,36,53,5,20,7,1,-28,-23,73,-102,-7,-24,-9,-21,95,36,147,52,88,118,43,112,0,49,81,117,112,163
+L26247_at,4279,13116,6428,3675,6411,4201,4239,3625,10626,7341,13447,5459,7492,3139,5550,4538,3282,5267,5160,11184,4499,8800,3995,5819,6383,7484,2315,7770,4328,11257,12512,12221,8885,6632,9491,6252,10998,9246
+L26336_at,154,109,181,175,123,192,225,169,163,165,89,153,119,146,125,174,-92,163,160,142,114,96,214,150,88,111,230,109,204,138,145,166,291,117,153,139,201,236
+L26339_at,-887,-767,-1155,-680,-398,-289,-988,-817,-667,-577,-318,-681,-197,-741,-6,-290,-542,-459,-217,379,101,-615,-763,-113,-580,201,-1232,-803,-1072,-789,-503,-90,-760,-85,-207,-606,-778,-1080
+L26494_at,718,68,920,921,97,693,235,563,627,170,61,439,198,225,365,233,-140,54,90,355,277,632,604,47,42,80,316,254,170,577,579,580,163,374,272,340,278,372
+L26953_at,115,3,19,5,9,58,45,19,55,14,-2,30,62,18,46,16,28,46,-10,35,-74,44,-34,129,28,-21,114,24,-4,0,17,12,111,5,15,57,45,104
+L27050_at,-146,-139,-239,-165,-69,-64,-226,-194,-127,-118,-19,-76,-69,-127,-34,-137,-307,-140,-108,-193,-219,-94,-93,-88,-89,-4,-244,-118,-108,-136,-124,-167,-200,-89,-138,-111,-79,-195
+L27071_at,20,115,9,20,65,78,73,134,-60,-7,-28,-56,-7,17,60,23,77,34,12,26,12,-23,51,29,7,-2,-65,22,-28,-23,-54,10,41,-22,-72,-53,22,98
+L27080_at,-399,-512,-775,-627,-94,-544,-772,-1368,-809,26,-301,-605,-188,135,-624,-537,-327,-555,-549,-677,-126,-1258,-600,-343,-826,-569,-605,3,-57,-1076,-2450,-650,-1241,-583,-716,-188,-1578,-2279
+L27476_at,116,99,287,140,163,179,136,133,218,80,84,110,270,173,116,337,57,178,294,136,294,60,197,226,89,191,111,94,100,241,228,165,126,70,198,51,93,176
+L27479_at,355,-35,493,199,-76,-19,181,77,249,64,-56,21,183,-186,71,-94,91,138,-104,51,-274,-68,-51,7,103,38,159,218,55,177,160,160,105,-15,205,275,395,367
+L27560_at,-97,-14,-63,-31,-9,-16,-87,-50,160,-31,628,-11,-28,-72,-1,-38,-80,-65,-69,-52,-36,-102,-56,-77,-24,-53,-118,-76,-168,-8,-74,-18,-50,5,309,-126,-101,-98
+L27586_at,165,97,14,69,7,152,164,200,98,111,80,27,111,103,82,36,212,43,64,26,81,142,56,188,122,71,118,84,93,58,78,16,8,54,52,139,84,28
+L27706_at,486,491,569,293,421,293,369,293,843,451,581,308,812,675,763,621,640,511,396,2105,1154,256,360,789,397,644,603,434,302,413,263,225,544,531,512,363,270,284
+L27841_at,297,715,773,528,400,606,924,451,784,391,701,237,629,781,850,1024,1953,691,640,1518,1024,357,769,956,237,289,674,669,755,686,898,730,527,514,767,640,771,657
+L27943_at,439,1169,755,1400,885,1175,1663,2484,555,1054,1092,1097,974,1298,341,1097,1841,1031,1126,711,732,1347,1299,338,1525,1098,2151,560,572,2550,2723,2769,1633,1053,1713,1379,1738,3776
+L28010_at,802,575,978,1042,1302,782,868,662,1759,1071,904,300,1873,1998,1770,1072,2871,586,677,2592,2247,438,547,1376,464,660,909,431,449,306,603,438,623,427,614,480,518,1088
+L28175_at,-229,1034,-185,361,89,-58,-275,-298,-18,119,11,8,-205,-98,130,225,351,-23,-64,140,-62,-201,32,341,244,-87,-132,118,-88,603,-269,-55,764,-41,-174,-319,-234,-192
+L28821_at,-24,-22,-214,-79,126,-197,-31,44,-370,99,88,84,85,19,105,-135,375,-35,-196,253,809,-41,-18,249,144,-49,-190,874,137,203,318,996,205,544,153,102,215,154
+L28957_at,30,34,232,196,165,30,208,356,227,276,148,-4,160,17,26,177,339,250,250,233,-7,325,20,30,67,227,405,497,331,215,16,120,307,162,157,146,487,348
+L28997_at,255,147,242,265,239,76,228,280,172,55,176,-25,169,266,292,100,302,173,104,230,158,147,32,160,158,142,200,101,110,200,200,272,194,99,75,134,256,136
+L29008_at,143,533,542,775,1237,369,578,298,598,519,364,169,279,528,684,340,1729,84,168,1071,500,149,455,1074,313,158,291,636,675,309,246,118,570,137,398,478,63,169
+L29217_at,-1566,-1109,-2200,-1862,-590,-2297,-2537,-2093,-1494,-1690,-729,-959,-980,-1144,-269,-1464,-2174,-885,-863,-315,-382,-1619,-1263,-247,-742,-286,-2594,-1629,-1180,-1351,-1946,-1001,-1116,-498,-1172,-1844,-1779,-1993
+L29218_at,658,437,716,679,791,408,695,571,170,285,140,136,460,771,597,631,1339,476,353,1245,128,243,398,806,512,243,200,571,240,528,289,384,397,344,396,302,609,632
+L29277_at,617,671,1248,635,634,609,567,824,800,551,510,290,443,964,540,31,988,501,331,572,219,405,197,885,408,402,397,797,601,1902,1238,1166,1251,538,586,500,1044,2007
+L29339_at,-131,-98,-277,-182,-22,-206,-189,-209,-187,-128,-54,-181,-52,-137,-108,-165,-144,-60,-37,-110,-98,-98,-210,-46,-146,-98,-242,-132,-351,-86,-166,-205,-169,-171,-117,-150,-148,-143
+L29376_at,39,-16,5,-368,-17,-39,-72,55,-133,-56,-244,-33,284,25,337,31,-337,110,16,418,86,87,-62,89,25,32,-403,-87,-204,-27,-57,-106,80,-27,-202,-99,-118,-71
+L29433_at,-185,-12,-555,120,-74,145,43,-95,-213,-166,100,45,-134,-162,-57,-284,-175,108,-200,-258,-116,5,-62,-237,31,-213,65,-183,-144,-122,-351,45,203,-213,-342,-516,-66,-330
+L31529_at,-181,-52,-128,-57,-24,-55,-110,22,-100,-124,-96,-27,-103,-19,-42,-81,193,-5,-55,22,-41,-149,-26,-117,-83,-91,-150,-68,-74,-45,-53,-59,-66,-19,-66,-9,-73,-74
+L31573_at,-170,-671,-768,-527,-256,-380,-297,-484,-622,-405,-94,-264,-227,-303,-286,-289,-499,-305,-95,-281,49,-176,-495,-130,-284,-263,-219,-221,-413,-80,-735,-749,-664,-94,-611,-306,-348,-600
+L31584_at,476,364,489,490,174,330,401,1066,245,443,189,258,429,881,597,583,402,3570,491,475,259,274,288,333,279,638,688,297,387,775,685,496,259,174,399,381,422,809
+L31801_at,1054,923,1632,1065,1037,787,1056,1074,1273,754,1157,306,1203,1182,820,860,1149,812,821,1537,441,723,560,717,329,696,1214,934,533,1086,718,690,1061,143,989,865,1019,1674
+L31860_at,-107,-54,-46,-28,-12,44,-58,50,-20,-19,31,-45,-40,7,-2,-27,-43,-19,42,68,6,-57,-53,-142,97,-40,-25,-42,197,-49,200,98,16,67,-20,-49,2,-31
+L31881_at,-14,-225,-72,-95,-72,-17,-58,49,-94,-254,-122,-222,-28,-121,-162,-14,-110,5,75,87,73,-236,-110,102,113,-149,-212,245,76,-46,206,247,99,43,-129,-85,51,199
+L32137_at,227,132,312,60,146,252,15,337,29,135,57,-11,37,238,23,170,32,112,117,158,34,149,106,189,200,138,295,184,50,319,408,199,196,163,40,23,312,8
+L32140_at,3,9,26,53,-62,-113,-47,-32,-118,26,-14,-50,-50,-4,-5,-25,-7,29,-39,-87,-32,-31,-13,-43,-30,-36,9,-61,-36,57,-54,-5,50,-39,9,7,-68,53
+L32163_at,8,41,94,70,-10,-24,87,68,49,25,-20,31,35,21,23,-17,41,9,3,30,34,9,36,26,8,2,81,4,24,31,14,-24,41,10,-16,53,5,88
+L32164_at,98,43,458,-11,94,330,75,178,230,71,202,5,143,119,20,35,162,241,30,251,68,5,100,270,38,219,253,339,250,55,103,240,-1,-2,61,124,24,25
+L32179_at,194,119,285,220,32,277,184,319,77,33,200,173,57,121,116,129,112,136,12,158,114,146,218,125,158,106,251,108,48,173,187,212,228,43,0,194,276,363
+L32866_at,-130,51,-276,-139,18,-131,-164,-452,-1,-233,162,-130,58,101,106,-399,-87,244,-37,-212,86,-282,174,-274,-49,20,-472,7,-110,863,-135,-32,-356,65,-270,-370,-283,-153
+L32976_at,265,160,141,69,125,-78,90,80,113,45,163,176,563,155,208,404,-265,204,284,947,79,179,-159,300,514,941,173,251,180,295,170,150,284,195,214,236,132,46
+L32977_at,959,2475,1170,666,1015,844,549,473,2071,1328,2579,1227,1534,1258,1616,1467,2188,1137,978,5304,3117,1065,1227,1321,1126,1054,807,895,415,1615,1398,1169,1500,1946,2052,1389,1253,1156
+L33243_at,601,297,234,39,186,83,404,-161,64,-94,393,160,13,-255,116,296,78,260,-47,314,326,35,203,501,374,299,422,-317,-331,0,593,-338,18,22,-1135,364,972,-108
+L33404_at,-664,-529,-661,-922,-227,-364,-583,-737,-670,-408,-388,-428,-348,-478,-373,-310,-861,-342,-129,-265,87,-479,-440,-355,-338,-343,-930,-683,-569,-418,-640,-529,-564,-143,-542,-554,-641,-746
+L33477_at,-153,-144,-278,-98,-74,-133,-144,-250,-169,-24,-152,-173,-60,-123,-57,-130,-136,-174,-93,-116,4,-252,37,-153,-132,-120,-107,-205,-38,-172,-165,-120,-126,13,-125,-132,-135,-223
+L33798_at,-637,-438,-691,-617,-15,-512,-525,-886,-551,-268,-434,-344,-294,-515,-374,-294,-668,-255,-252,-362,-147,-503,-697,-450,-430,-72,-835,-685,-538,-343,-636,-451,-300,-134,-459,-485,-575,-584
+L33799_at,29,-41,67,-537,385,-62,188,-43,67,131,92,-114,-16,48,-49,49,-117,156,21,241,-44,119,-72,60,7,-140,314,-160,189,82,-112,28,155,114,-159,102,232,307
+L33801_at,287,354,361,93,124,289,45,83,288,115,204,114,211,323,301,147,393,269,93,135,189,52,224,468,66,194,269,260,129,201,146,197,80,142,128,163,383,30
+L33842_rna1_at,1185,1337,808,2226,3197,908,1403,1073,4877,2385,2049,2052,2149,1945,3238,2058,2847,3247,2736,7479,4052,612,1170,1756,2077,2622,1952,3523,1755,1960,1474,690,4484,2060,1544,2040,937,673
+L33881_at,277,200,287,274,252,122,126,175,275,123,103,77,241,336,244,296,394,168,89,384,143,99,245,231,117,155,78,120,175,97,109,130,171,23,147,100,194,202
+L34059_at,253,167,562,337,160,261,252,463,746,372,442,-38,136,397,-116,181,1007,244,171,317,144,294,294,-23,142,336,175,261,262,418,28,24,184,166,133,294,339,209
+L34060_at,844,655,404,350,162,542,344,737,305,222,189,169,200,166,413,284,230,501,209,826,103,528,473,212,283,156,608,274,468,444,778,274,343,115,571,775,1014,987
+L34075_at,336,209,482,480,402,268,347,326,446,134,334,182,259,387,400,355,329,176,228,373,158,328,250,530,315,128,283,243,214,439,418,455,394,113,261,298,338,477
+L34081_at,-38,-6,-42,-9,28,-8,-38,-4,2,31,-54,5,11,28,-12,-24,50,-8,27,-16,-17,19,3,-21,39,29,48,-31,28,11,14,-43,0,-13,-2,7,-13,-2
+L34155_at,-111,-270,-223,-47,8,-65,-324,-374,-37,-28,-78,31,116,-284,108,121,-15,-5,-53,-246,143,-222,47,33,-137,-212,250,-195,-283,-37,-287,-220,-210,-67,-380,126,-307,-346
+L34219_at,112,89,120,219,114,69,42,191,45,90,61,135,20,119,136,101,309,85,2,44,109,66,47,168,14,25,176,247,238,146,86,33,122,45,-103,141,301,130
+L34357_at,284,87,237,211,133,204,122,220,181,61,130,162,92,133,31,119,146,74,5,115,53,141,123,66,158,83,198,-10,105,120,167,132,234,33,113,155,194,276
+L34409_at,88,-15,-6,126,-10,-16,43,103,108,82,108,24,42,74,-7,12,118,27,9,83,63,22,60,66,-16,7,117,29,110,93,37,68,78,47,62,48,38,126
+L34587_at,795,1319,1754,725,1358,732,524,176,1600,1073,1663,1020,1526,1085,1451,1057,742,1181,885,2423,2578,865,1022,1228,653,741,112,246,209,1009,1835,1059,983,1389,685,852,645,1410
+L34600_at,96,91,54,153,237,163,67,7,130,115,106,50,73,318,342,162,183,129,88,592,409,111,79,129,77,65,103,14,-14,37,95,118,27,106,228,-6,31,31
+L34657_at,250,581,238,-11,-17,280,-136,-4,576,-62,312,125,1132,121,38,88,741,-64,654,-94,-3,-81,-83,-13,143,106,-31,140,84,626,285,-95,156,90,832,544,1018,157
+L34673_at,-107,-36,-95,-17,1,-120,-53,-86,-30,-31,-44,-70,-16,9,-6,-2,7,-26,-21,-25,-73,-19,-144,31,-56,-28,46,-36,-158,-23,-50,-10,-37,-33,-57,-121,-27,-66
+L34820_at,353,75,366,207,135,208,325,217,213,245,235,70,46,189,139,227,179,62,128,185,54,238,286,221,294,204,337,195,146,283,338,322,322,87,128,248,359,397
+L34838_at,-658,-557,-956,-1404,-181,-899,-1031,-971,-708,-803,-540,-599,-396,-730,-315,-352,-498,-218,-167,-114,-389,-554,-600,-747,-260,-225,-1146,-1115,-391,-888,-1187,-397,-738,-122,-1025,-932,-391,-1070
+L35035_at,88,183,378,238,284,129,238,160,224,303,352,-18,234,402,134,246,157,121,107,668,278,-1,117,432,103,107,306,147,226,39,325,540,592,134,354,270,146,224
+L35240_at,529,13,215,80,48,17,216,626,69,71,49,110,386,142,51,43,203,-15,190,393,372,166,100,202,129,284,51,627,24,437,448,228,434,207,752,41,222,504
+L35251_rna1_at,44,-20,37,-38,-4,-65,-23,73,21,-1,-17,-41,97,5,-57,48,111,8,36,-4,-31,-56,60,-116,-64,-64,84,-46,115,-25,-28,2,20,49,2,2,-25,-116
+L35269_at,266,273,322,153,88,55,132,61,214,108,134,60,204,75,160,286,306,232,84,514,51,230,34,159,158,229,608,146,110,192,-62,24,277,37,495,183,407,341
+L35475_at,1118,589,1741,809,326,1010,757,1202,1329,672,896,406,606,495,504,830,-121,716,353,777,394,598,651,705,800,683,1148,949,841,674,618,758,721,388,863,614,1139,1112
+L35545_at,-49,-1,28,-22,-20,-1,-13,-41,-63,10,-103,-7,-66,-67,-11,17,107,-53,0,83,-103,-17,56,-88,27,-7,53,-80,-137,-128,62,111,-25,-43,58,-11,27,-36
+L35546_at,314,80,26,173,187,106,183,61,126,78,86,5,80,246,7,60,-26,39,41,108,91,-41,220,26,122,1,-156,-59,57,57,205,235,101,107,109,34,145,196
+L35592_at,168,57,83,149,71,72,89,142,136,65,54,109,113,-76,65,170,6,26,117,113,181,90,100,196,99,-119,70,254,170,136,141,283,143,69,122,130,170,161
+L35854_at,-95,57,-78,70,-19,10,25,85,141,53,-28,53,-65,-10,-69,-40,-56,35,-81,-110,-91,-14,81,28,-36,-234,25,26,125,-21,-54,6,130,17,51,88,45,347
+L36033_at,144,50,78,24,150,-69,151,-413,236,2,85,-150,-79,52,-23,-212,-154,-78,-66,-185,146,68,-233,-92,188,-194,46,14,-36,87,412,-35,306,-38,332,31,106,-36
+L36051_at,-35,-78,3,61,-22,-44,40,-221,-45,-21,-112,37,23,-22,-46,29,-161,1,-80,-51,-41,-48,-146,-69,-65,-70,-183,-84,26,-103,2,-52,10,-77,-11,-119,25,-110
+L36069_at,-761,-464,-1017,-1105,-453,-753,-1021,-1284,-977,-638,-613,-695,-491,-608,-590,-801,-1203,-592,-554,-326,-438,-262,-733,-612,-774,-410,-1115,-983,-795,-972,-1188,-799,-707,-644,-867,-931,-1161,-1193
+L36151_at,1810,2961,2471,1389,2015,1392,1695,1416,2844,1410,2160,1013,2213,1886,2309,1453,2649,703,1092,3048,1726,1469,1632,2184,1871,1301,1300,1711,1397,2883,1539,2462,1183,1200,2704,1365,2975,1547
+L36463_at,-444,154,645,221,-34,147,398,151,313,407,238,179,251,300,169,773,173,228,91,-67,172,-43,252,377,-40,225,248,366,-201,-45,615,484,539,358,280,264,328,652
+L36529_at,117,64,103,-10,160,-26,47,-40,133,54,224,11,304,134,166,132,165,-24,168,415,219,70,45,179,76,-35,-59,98,48,62,175,116,81,74,45,40,36,-75
+L36531_at,656,328,1123,629,399,460,957,596,701,390,521,308,297,348,412,455,551,571,398,530,337,787,246,476,354,729,927,711,577,554,526,507,588,191,535,707,683,1050
+L36642_at,24,-30,-27,29,23,-16,-23,-26,-16,-16,-33,27,-11,3,-7,1,-26,-30,20,19,12,-49,-51,-20,-17,-57,-28,10,-45,-23,51,36,14,7,19,2,17,-2
+L36645_at,421,64,136,54,133,-10,126,514,77,65,35,11,60,655,128,13,-43,262,-42,466,142,300,-30,112,21,107,46,68,-4,85,-12,78,112,-63,26,-22,86,162
+L36720_at,-137,60,-58,272,200,96,-156,440,-148,163,-412,168,646,601,87,-278,-21,9,329,59,403,-275,-72,110,-2,-242,-117,-384,9,-245,330,-317,-98,117,-462,415,-246,-250
+L36818_at,744,238,818,717,782,231,693,403,163,57,470,110,556,283,591,490,662,389,337,1041,197,128,214,727,298,827,726,508,444,834,134,397,282,380,825,618,500,215
+L36844_at,271,149,179,236,110,314,250,191,194,39,193,119,-7,148,-4,74,162,182,36,96,43,253,93,64,154,39,79,14,100,222,257,207,178,10,147,245,146,374
+L36847_at,90,200,353,14,43,35,149,44,87,247,52,129,130,89,80,101,65,114,53,167,-86,41,68,31,137,11,175,-25,211,51,209,280,339,75,181,240,473,173
+L36861_at,83,115,196,302,88,151,109,254,111,72,161,77,52,38,150,126,134,55,111,99,128,226,174,164,139,161,139,-59,64,140,282,213,119,63,24,249,154,185
+L36922_at,911,886,1516,747,536,398,601,829,833,882,600,515,363,911,578,714,794,713,492,437,316,681,980,905,622,630,816,917,767,1040,792,754,1037,245,762,485,1251,439
+L36983_at,485,339,-218,43,125,113,781,-472,624,-132,213,-28,474,95,449,-155,118,-84,151,1665,-81,646,-167,847,145,331,-771,-26,-192,140,-115,-486,-37,-31,-234,-1,126,-688
+L37033_at,927,3244,2550,1764,1086,2258,1754,1523,1805,1746,1792,682,1155,1987,868,1104,2101,782,2389,4296,372,1069,1430,1494,1669,1649,262,789,954,1492,4382,4638,1955,2317,2185,2512,2091,2640
+L37042_at,266,473,1174,371,626,656,374,451,988,689,661,268,403,536,345,816,430,450,792,1767,68,324,357,617,299,186,358,550,134,731,1200,1253,728,568,1529,659,468,1198
+L37043_at,1186,877,1403,945,1190,336,1072,1320,1187,384,883,353,572,797,832,342,506,389,368,1851,2178,1353,596,1480,544,547,888,501,415,626,519,1135,1013,427,901,468,855,881
+L37127_at,92,1185,711,626,589,215,-95,-632,715,874,941,244,666,913,1242,901,1701,568,562,1769,-221,210,754,1769,706,542,-100,339,478,977,-977,-132,639,534,213,85,922,298
+L37199_at,123,72,392,148,-30,208,470,212,259,153,237,-20,-34,199,-181,148,-242,175,7,-74,-48,163,296,103,12,127,273,245,281,263,-54,338,212,101,-466,172,48,544
+L37347_at,-78,-106,-115,-45,-84,90,-40,-212,-127,-36,-72,-51,-53,10,-47,-145,156,-8,-136,-101,79,-26,-112,-237,-101,-130,165,-35,55,-109,-132,-244,-145,-51,-90,9,-191,-69
+L37362_at,39,-55,-68,-63,-41,-138,-16,20,41,-50,-115,116,43,-80,0,-45,-92,46,-12,-19,-314,57,-174,-199,89,-63,126,57,-110,325,-21,85,-5,55,63,-36,16,104
+L37368_at,1655,2104,1938,1381,461,1209,1440,1617,2243,1129,1773,879,1832,1360,1237,940,1675,773,873,1537,1725,1452,1472,1226,689,1520,1334,1276,1247,1818,1505,2079,1874,1129,696,1496,1695,1725
+L37378_at,-45,32,134,119,29,30,47,163,98,48,-37,64,116,85,25,22,184,13,54,213,-37,-104,18,83,-51,114,78,-60,-110,-20,23,72,-170,37,124,-95,-35,175
+L37792_at,718,562,831,646,239,213,717,587,330,415,237,215,445,517,245,517,511,441,279,475,753,652,383,1109,383,685,747,739,283,670,709,515,502,85,833,640,622,760
+L37882_at,86,171,-44,235,120,51,25,-50,-58,-79,-38,0,-24,116,212,-85,240,-13,-120,221,128,-94,-51,163,-147,-109,-42,-98,-2,-56,-133,-19,-79,-103,168,-34,-11,-118
+L37936_at,403,402,374,503,663,426,332,467,378,85,364,66,401,524,665,389,766,312,358,1066,228,332,127,468,231,297,98,305,175,366,864,492,362,362,266,143,151,469
+L38025_at,-163,-167,-201,-342,-59,-195,-325,-445,-132,-195,-89,-117,-98,-264,-117,-253,-401,-130,-16,96,-88,-47,-245,-107,-120,-181,-256,-245,-187,-189,-465,-90,-140,-25,-314,-283,-421,-107
+L38486_at,536,987,583,524,376,316,554,761,417,574,379,425,430,639,283,459,2196,282,664,285,660,513,474,512,378,446,721,820,839,618,785,505,894,327,169,563,677,874
+L38487_at,-413,605,-428,-158,511,528,-285,-203,-359,-239,63,-607,269,-39,840,220,540,13,-439,-26,149,-27,123,678,-115,-24,-330,-734,-536,606,-287,302,-1191,-26,-52,-277,755,-111
+L38500_at,41,69,135,30,110,72,-65,13,36,76,55,71,65,121,58,204,243,78,63,72,39,92,47,61,100,111,195,115,-115,-1,-2,37,55,-29,130,60,95,55
+L38503_at,355,109,224,239,184,87,220,257,210,234,123,146,57,233,98,142,194,345,296,256,194,147,151,113,135,170,319,276,165,138,70,235,251,142,254,115,21,305
+L38517_at,-268,25,-134,-8,-187,-3,-57,-338,-132,-39,-38,-125,4,-99,-146,58,-248,29,-288,-188,-83,22,-233,-454,36,316,-364,-122,117,-110,-432,-517,-130,-214,-262,-171,-374,-791
+L38608_at,-8,76,184,71,111,117,115,-46,106,111,129,10,40,-3,103,32,260,153,25,64,86,90,45,135,19,91,46,291,185,210,134,139,187,119,374,166,115,321
+L38616_at,325,359,351,395,370,227,497,155,321,266,275,238,201,394,407,301,599,295,318,612,139,241,246,332,297,269,367,314,365,445,308,236,323,27,548,525,461,418
+L38696_at,733,1277,1985,813,1199,1324,781,686,2591,1701,1744,896,1158,932,1178,896,460,977,756,1619,-27,814,929,1015,670,1229,464,721,327,978,700,947,859,438,598,923,1075,664
+L38707_at,621,552,548,608,518,522,892,634,576,461,384,409,279,425,424,398,818,446,549,810,183,507,522,420,559,692,383,724,675,804,896,607,758,355,489,784,888,913
+L38810_at,575,807,883,571,1031,988,732,311,1408,754,686,642,1014,1104,1062,549,50,318,504,1634,1235,289,701,733,534,773,-106,636,468,482,520,395,377,395,244,796,444,-479
+L38820_at,-15,26,31,-30,-1,140,-53,-82,60,31,-43,-10,38,116,3,12,94,35,30,-23,39,7,81,-23,-4,23,67,25,-50,231,105,-34,-21,5,375,-15,45,225
+L38928_at,123,220,460,33,190,26,255,380,396,90,221,61,225,537,209,67,210,306,102,436,346,87,-43,353,186,273,-20,295,170,183,149,314,227,6,227,51,140,322
+L38929_at,103,269,96,-36,44,49,25,256,96,196,112,40,-16,-44,1,114,82,-52,155,199,0,40,47,33,109,34,131,119,64,71,-67,89,71,26,-21,-24,43,167
+L38932_at,2022,1425,2352,1807,1391,1200,2039,1562,2421,1473,1541,875,1609,1331,1008,1410,1171,997,920,3185,2241,1768,1445,1172,1093,1664,1896,1319,1247,2278,2097,1918,1697,924,1533,1879,1661,2576
+L38933_rna1_at,40,144,43,-21,355,-33,43,97,62,107,73,37,178,151,30,2,367,13,109,-22,14,141,58,442,99,155,67,280,440,244,80,236,568,139,277,-94,7,40
+L38935_at,265,293,765,299,245,442,593,412,633,334,298,301,203,230,116,228,211,358,220,264,236,236,454,487,236,230,494,622,339,213,288,333,305,94,258,512,336,576
+L38941_at,15962,21492,18010,18467,16105,11471,16188,13618,18757,17741,21851,9174,17992,18691,13319,18762,12462,14221,20398,22264,28788,12732,13189,20579,14209,15345,21251,22386,13302,10975,20056,23514,20327,16980,20303,16823,16831,21232
+L38951_at,278,792,429,139,422,905,356,385,879,381,1908,283,1952,1288,1422,343,1241,509,519,3295,1676,300,581,1689,649,865,355,567,473,274,117,178,436,261,387,-363,219,-25
+L38961_at,257,127,82,-6,120,-35,10,20,411,50,365,11,419,222,328,116,405,70,205,841,316,-18,47,287,19,226,172,125,14,202,-55,2,79,-34,96,256,17,-107
+L38969_at,-219,-145,265,117,-6,343,-20,362,209,56,-155,136,-247,-255,107,-177,-192,74,-260,-304,-379,243,-104,-48,-245,-171,-769,-259,-560,77,-299,-120,-165,-34,-386,-98,189,287
+L39009_at,-166,-80,-133,-6,-69,14,-107,-11,-9,-32,-84,-28,-22,-62,-50,-57,50,-89,-39,-48,7,20,-100,-109,-94,-68,-79,-28,-86,-124,-72,-88,-60,-18,-65,-98,7,-128
+L39059_at,57,402,161,-82,291,225,16,-125,120,140,300,-54,175,212,228,184,55,-21,46,685,450,258,-32,404,158,159,-53,374,211,235,-91,235,-56,-7,320,-81,-47,30
+L39060_at,-130,0,-209,-80,58,-58,-166,-113,-111,-72,-61,12,44,-128,120,43,92,-70,4,61,96,-3,-167,-69,-80,-34,-175,-115,-96,-166,-103,-184,42,-50,-29,-109,-158,-155
+L39061_at,214,133,212,82,92,119,84,158,137,51,62,47,42,184,190,84,64,91,77,167,158,124,43,145,123,114,50,132,50,137,91,141,19,41,42,141,113,81
+L39064_rna1_at,-73,160,260,-65,112,96,-112,-83,66,252,63,100,161,340,199,49,379,166,71,356,12,209,75,116,32,229,126,48,100,106,-77,110,106,30,200,-2,45,53
+L39211_at,68,-20,7,-34,-17,96,-28,13,103,1,-17,96,57,70,25,-63,52,3,10,0,94,113,-45,-72,-9,-45,-95,15,-88,35,58,3,-1,131,35,30,27,-18
+L39833_at,14,55,-17,-21,4,115,-65,-11,-28,-47,32,-56,-16,-42,43,14,64,-19,21,39,-17,24,11,60,-9,-16,-57,68,0,-34,59,51,-29,-18,-26,-13,7,3
+L39874_at,731,946,1661,718,975,1331,1660,487,1047,977,1228,508,944,1281,913,890,2175,659,1116,2548,1709,1153,1189,626,947,500,973,1514,1526,909,516,419,1681,444,1376,1102,1441,919
+L40027_at,1125,829,1110,792,975,762,868,1066,1918,840,1206,395,1280,949,979,1116,1761,634,663,2188,1494,717,864,1171,871,1271,200,951,771,973,1150,1060,817,683,681,824,1257,1236
+L40157_at,71,0,88,-3,110,-17,-50,-44,0,42,23,-4,69,-13,70,38,136,97,-5,73,59,95,-30,35,24,83,78,144,12,-35,4,33,83,-29,-8,31,125,-29
+L40357_at,736,482,828,715,1406,229,541,83,691,593,745,192,1240,623,866,554,1796,571,277,1551,795,221,328,541,374,203,37,405,605,458,13,306,579,181,362,434,1199,153
+L40366_at,-75,-30,-254,-73,-93,-39,-42,-277,-73,-141,-94,-48,-77,-55,56,-104,-119,-108,-102,-552,-101,-81,-136,-217,-52,-95,-104,-247,-170,-106,24,-57,-35,-91,-25,-238,-9,-195
+L40371_at,-83,101,-63,-105,239,140,-122,-56,19,-131,35,-37,-202,138,31,66,60,-125,-50,139,53,69,-169,217,165,-132,-220,-61,-52,-179,75,19,17,154,101,-26,70,-75
+L40377_at,-169,-180,-497,5,212,-247,-184,-353,-313,-225,-179,-168,-79,-166,-41,-156,-292,-54,-208,-102,-209,-23,-193,-196,-85,5,-309,-67,-428,-188,-66,63,-61,-94,270,-414,-307,-273
+L40379_at,-48,18,-253,-270,37,-97,-183,-113,-15,-94,-24,-53,-65,-76,66,-109,-162,340,-108,-13,19,-138,-115,-160,-24,-52,-292,-107,-221,282,100,-74,-48,-95,351,-159,-91,-159
+L40380_at,121,116,263,147,175,133,149,131,71,-37,76,43,57,144,86,104,-7,108,36,66,78,119,62,83,128,118,-34,32,84,69,60,180,98,59,0,3,118,178
+L40387_at,443,389,443,509,35,437,640,185,494,493,358,441,175,260,305,315,215,312,263,474,229,422,379,75,356,166,530,297,60,1491,3827,1509,5,-43,178,695,440,3203
+L40388_at,0,25,7,27,221,5,-154,-65,95,32,352,0,30,49,80,49,41,-13,-50,151,32,107,-32,13,17,-85,-23,93,-105,69,67,111,199,183,224,30,-4,56
+L40391_at,1167,1083,2377,1128,1342,883,1282,500,2481,741,768,402,1929,1182,1561,1218,830,355,1003,2177,1724,230,338,1842,174,825,320,446,228,1218,379,48,353,239,378,627,865,596
+L40392_at,578,692,831,552,781,501,917,425,485,451,572,327,886,769,649,681,937,298,758,2162,660,306,511,804,370,301,671,501,589,500,418,608,393,206,571,470,516,669
+L40393_at,108,71,-70,278,266,71,82,-67,130,38,73,34,176,121,166,148,106,4,135,361,97,86,24,281,31,63,-89,32,-21,166,178,-25,-17,87,258,3,87,269
+L40394_at,258,107,148,59,358,222,147,11,363,120,132,106,97,236,126,396,110,339,299,339,198,141,75,262,185,167,14,239,7,366,11,418,343,133,192,107,212,200
+L40395_at,418,377,299,561,607,574,994,221,637,440,464,373,508,527,410,553,301,244,310,900,610,298,250,612,284,332,251,536,149,300,451,333,463,396,431,364,410,432
+L40396_at,12,9,3,24,10,8,3,-31,10,15,39,22,-6,25,36,30,-57,2,16,33,14,-43,-15,50,-3,-26,15,4,40,-21,17,11,-24,15,20,-18,-16,4
+L40399_at,-47,-40,-169,-173,63,-208,-171,-646,-124,113,72,-159,215,-44,102,91,45,99,50,338,29,27,-62,127,19,166,-48,69,-45,-330,67,-86,-25,71,-126,27,21,-348
+L40400_at,46,350,401,315,130,348,166,137,130,44,237,205,136,136,258,261,540,149,83,321,91,337,155,313,183,165,372,162,182,180,192,324,279,39,217,459,500,189
+L40401_at,395,571,604,242,287,716,349,257,471,345,863,218,221,351,351,262,432,299,211,806,638,353,714,280,391,225,417,427,403,394,391,363,532,294,191,408,885,387
+L40402_at,-142,-150,-217,-143,-135,-104,-325,-236,-214,-68,-150,-79,-68,-142,-107,-106,-313,-22,-126,-83,-37,-221,-165,-127,-124,-160,-328,-186,-290,-112,-110,-174,-172,-45,-174,-234,-173,-236
+L40403_at,-95,-83,-109,-36,42,1,-28,-77,-256,-114,-62,34,-49,-179,2,-126,-49,-8,-94,-112,-33,-61,-239,16,-76,-19,-21,8,-161,20,-13,-151,-175,29,-187,-37,5,-276
+L40407_at,-110,97,188,26,30,56,109,-95,-129,30,180,-127,6,-83,13,-5,-340,32,-121,44,-103,-27,47,-41,155,22,239,60,185,57,102,4,236,-3,-161,3,15,292
+L40410_at,534,566,533,584,781,307,675,374,863,454,564,275,832,752,969,452,1070,556,361,1722,717,426,507,673,450,403,585,478,334,360,302,435,480,515,337,502,533,399
+L40411_at,274,219,230,408,284,106,238,152,65,281,202,194,185,175,466,187,226,133,76,104,102,120,121,394,400,61,93,280,180,155,381,328,361,101,415,231,512,220
+L40586_at,101,350,119,47,116,140,131,128,107,129,187,143,76,139,124,96,379,97,44,157,152,143,182,81,110,135,253,93,134,245,252,286,264,129,608,172,299,154
+L40636_at,65,-63,44,84,139,-16,6,146,104,-28,-85,-132,103,-22,-23,68,-1,-2,14,-41,0,-130,7,52,-73,126,82,-68,173,26,154,-27,-112,47,22,-68,-38,166
+L40904_at,87,208,-20,-44,207,-48,-178,647,356,120,176,123,4,-14,173,254,-156,131,435,122,91,9,-41,47,578,304,-189,125,322,-362,939,585,48,243,-82,-40,188,925
+L40933_at,-73,-355,-550,-232,37,-58,-499,-208,-16,-79,-268,-367,-239,-125,-293,-322,-522,36,-21,-443,21,-455,-104,-246,-333,-281,-815,236,-48,-136,-105,-438,31,-91,-203,-171,-45,-10
+L40992_at,-100,143,5,21,23,40,142,265,396,59,-68,24,150,-65,31,384,462,67,176,170,27,-94,188,210,244,118,-128,412,382,167,254,52,117,91,117,61,244,145
+L41066_at,-55,-45,-155,-39,-84,224,18,-7,15,59,-26,-53,-4,-34,-86,-46,-129,43,60,7,48,3,87,-440,139,30,-65,98,79,47,-123,-198,-29,-147,138,-69,-11,-62
+L41067_at,702,419,799,527,960,346,813,475,771,93,289,66,436,1229,1021,91,457,233,159,685,450,249,486,1186,289,592,521,433,375,225,55,274,185,83,28,117,318,425
+L41143_at,-564,-318,-862,-676,14,-138,-504,-655,-410,-12,-435,-518,-194,-350,-373,-489,-1012,-616,-106,-452,-262,-1038,-153,-42,-514,-269,-1500,335,127,-849,-699,-923,-315,67,-154,-537,-317,-843
+L41147_at,-61,-99,102,-360,-116,94,89,-58,46,-208,57,-188,-180,257,78,94,-487,-15,-68,-697,108,-54,37,11,-18,201,-186,230,173,208,149,81,322,37,-593,-122,-158,490
+L41162_at,-449,-725,-1015,-372,-746,-220,-399,-356,-199,-570,-379,-536,-818,-695,-495,-581,-900,-678,-594,-233,-249,-716,-695,-628,-663,-730,-538,-959,-981,-465,-897,-752,-822,-352,-902,-491,-1001,-1214
+L41349_at,-56,-24,-88,-63,-10,-14,11,-80,3,15,-1,53,34,167,-22,-28,-65,58,-4,-45,-12,30,-3,-72,-15,-6,-7,-4,-72,-8,-60,-37,69,-27,-58,-56,80,-103
+L41351_at,-176,-28,-60,-130,315,-334,-211,-143,-161,-231,-2,-369,-133,-297,191,24,-193,-43,86,-281,66,-136,-286,-14,-175,108,34,208,-192,424,-48,-457,398,3,318,-52,-289,-397
+L41559_at,-10,-13,58,-9,125,53,258,56,-15,61,14,103,17,138,-48,2,278,81,10,1,-6,60,157,0,49,-49,255,126,158,155,219,4,138,226,455,156,276,90
+L41607_at,44,0,91,38,79,74,-8,41,15,47,54,31,77,98,48,74,84,92,45,30,22,54,26,-3,44,91,37,161,36,130,26,127,118,89,17,32,98,82
+L41668_rna1_at,-22,-10,157,-13,69,-19,-77,10,-91,42,-47,-117,59,25,67,34,-27,172,-15,38,-87,-92,-150,279,32,-53,-62,-7,26,-8,-32,-109,-46,31,40,73,-121,-82
+L41680_at,-557,-515,-378,-597,-132,-216,-613,-386,-417,-515,-309,-418,-287,-667,-318,-399,-317,-369,-114,-404,-137,-265,-205,-175,-284,-222,-715,-180,-605,-433,-532,-469,-487,-217,-573,-681,-498,-818
+L41690_at,544,482,788,334,558,325,663,307,897,589,164,202,490,535,385,460,451,446,418,771,104,120,444,662,297,465,431,586,699,519,274,389,372,93,330,334,482,404
+L41816_at,-812,-994,-1370,-905,-371,-858,-910,-1071,-1020,-559,-633,-307,-529,-745,-313,-912,-580,-473,-544,-816,-322,-639,-786,-566,-453,-513,-226,-559,-651,-711,-1046,-1046,-913,-620,-1006,-1141,-941,-2007
+L41870_at,459,141,467,272,409,106,546,311,660,51,73,70,502,346,927,273,276,67,135,1520,244,122,163,1200,129,239,242,128,88,41,85,42,71,23,109,-22,82,33
+L41887_rna1_at,290,349,440,207,168,208,436,368,295,214,137,77,493,415,475,490,1192,286,213,1506,277,128,148,351,280,308,230,133,149,142,75,104,257,46,71,228,263,141
+L41913_at,68,5,10,-67,-4,62,-26,79,1,-21,-11,53,21,23,14,21,125,45,-36,21,-42,1,26,-5,31,-16,-6,-53,2,67,62,-27,-65,-14,-3,5,-8,-17
+L41919_rna1_at,-19,-141,94,13,80,-176,426,257,229,171,5,74,-47,216,-226,268,-176,669,251,17,18,31,153,19,165,186,87,-288,134,436,237,247,296,-11,432,317,174,358
+L41939_at,-89,-299,-134,-352,-68,-293,-307,-253,-160,-227,20,-349,-146,-139,-92,-25,-403,-125,-127,-151,-77,-121,-252,-204,-266,319,-417,-257,-218,50,-416,-187,-299,-129,-396,-299,-219,-93
+L42025_rna1_at,377,219,248,189,285,152,262,356,197,161,132,90,268,249,217,224,436,252,115,453,23,273,117,167,165,313,98,181,45,498,422,360,207,142,451,141,333,436
+L42176_at,57,-43,-161,57,-28,30,84,88,108,31,-67,1,-78,21,34,-153,136,-58,6,59,72,71,34,-133,-21,-49,34,-10,-98,-118,-14,-121,-48,122,-57,-22,26,-78
+L42243_cds1_at,91,137,195,52,224,167,186,146,186,70,176,84,209,209,93,137,211,260,53,430,51,-22,104,212,-39,-2,200,-6,26,283,102,171,178,17,208,150,-35,15
+L42324_at,348,259,333,699,241,176,702,608,241,214,175,140,260,337,515,779,429,216,495,119,347,364,277,209,389,417,337,234,269,434,702,636,409,203,225,289,381,678
+L42354_at,342,653,169,644,-221,17,90,340,3,445,184,339,165,85,278,51,1116,46,413,561,393,77,623,-92,107,216,833,42,170,398,507,636,104,-83,532,17,245,322
+L42373_at,662,653,792,1034,832,327,680,1157,1067,471,524,523,727,883,701,569,1429,533,713,1665,590,899,436,1475,632,841,952,918,355,1114,682,826,537,442,687,643,963,829
+L42379_at,-4,1134,232,55,1093,-56,272,376,100,194,29,646,711,355,745,393,590,932,1100,1950,301,1022,94,345,986,909,1056,1439,1033,2806,3735,1768,646,2997,4025,494,385,1397
+L42450_at,84,-21,-61,109,40,60,102,199,65,84,-65,-24,-6,37,25,38,185,67,5,84,-23,-13,113,38,-18,18,87,143,-48,172,16,110,52,-3,-5,116,-62,38
+L42451_at,701,472,390,637,416,490,312,508,-21,692,503,349,741,494,630,705,841,418,650,753,419,-92,499,250,241,514,851,449,144,315,740,206,543,298,336,508,852,86
+L42452_at,-79,-103,-103,-74,-37,37,-72,49,-119,-111,-33,56,-80,-71,-50,-151,-331,-47,-85,-180,19,-136,-159,-97,-42,-144,-378,-101,-151,-8,-65,-86,-127,-22,-47,-83,-48,-135
+L42542_at,474,316,382,573,807,206,362,425,876,322,287,38,1165,671,458,632,982,492,371,1600,1380,149,172,763,99,699,436,298,379,331,315,381,257,235,242,298,307,234
+L42563_at,317,181,607,511,269,334,421,277,498,108,405,158,274,252,152,419,644,296,338,410,266,427,229,410,55,311,652,427,257,352,315,597,340,139,144,436,634,654
+L42572_at,472,388,451,406,752,359,578,340,675,294,358,86,494,519,759,456,532,344,396,1153,737,49,328,588,156,281,261,240,175,268,286,158,199,70,264,294,264,169
+L42621_at,878,268,920,725,449,400,690,791,748,402,428,248,324,626,230,870,601,282,496,713,184,632,427,490,549,449,646,494,605,719,510,426,524,165,444,512,642,568
+L43338_at,74,14,106,-92,-13,124,-188,52,241,-20,340,-89,-5,-9,130,29,276,156,-5,161,6,-145,-15,52,211,15,-381,17,-204,93,-111,174,243,-13,64,28,25,374
+L43366_at,235,135,364,388,111,245,388,349,202,199,147,201,123,222,201,132,56,141,250,146,208,122,151,180,215,104,68,131,36,208,289,321,202,230,192,421,195,393
+L43631_at,841,761,846,699,834,499,890,571,995,584,1039,307,1146,916,779,605,955,437,822,3315,828,632,324,1181,408,653,599,546,406,743,449,1066,722,430,676,393,527,545
+L43821_at,-93,-74,-264,-150,-107,-199,-146,-136,-185,-41,-161,-97,-51,-129,-160,-138,-169,-103,-138,72,-19,-160,-159,-179,-95,-159,-294,-225,-182,-89,-223,-189,-123,-90,-85,-206,-174,-129
+L43964_at,-2,-145,-23,-296,-13,-16,57,-115,-40,-84,-103,-160,-75,-21,-84,-49,-54,-34,-81,-284,52,5,-140,-104,-13,-55,-15,-52,-43,82,-155,-11,23,17,-116,1,36,50
+L47345_at,350,495,937,310,278,88,547,836,457,21,391,87,24,573,198,216,135,546,318,689,43,128,119,325,275,340,345,271,230,807,129,1030,442,101,503,217,423,900
+L47726_at,84,43,76,3,46,14,132,179,7,57,38,35,4,41,0,1,5,8,38,10,78,48,53,26,-20,23,26,-86,62,56,11,74,62,23,69,40,46,79
+L47738_at,571,2893,2723,731,649,1858,280,1716,2388,913,2147,140,556,1483,1505,904,643,669,1137,3810,1631,857,813,899,223,759,899,12,218,8,-80,201,449,65,172,239,683,153
+L48211_at,-49,-48,7,-53,-22,-39,-115,-572,-182,-64,-113,-91,-113,-95,-162,-33,21,-142,12,7,36,-52,-188,-104,-33,56,-183,-70,-93,40,-98,21,-106,-14,-120,17,-216,469
+L48513_at,-30,25,57,11,-16,72,-20,-103,60,2,-17,109,66,181,-35,289,-87,64,133,-123,9,-41,39,32,21,65,-71,215,31,-8,113,-19,77,-11,47,138,203,-28
+L48516_at,66,17,7,-10,-17,-1,10,259,-157,8,-172,-86,-52,96,-42,37,319,-46,102,75,21,109,39,69,55,28,211,-172,76,-56,148,183,49,41,48,-2,-111,162
+L48546_at,291,1276,660,955,396,451,756,883,246,562,21,-382,618,526,650,1415,1324,-136,659,2078,622,962,659,1066,611,925,414,627,435,128,689,278,385,81,957,699,618,8
+L48692_at,-32,67,-27,9,87,-103,87,-44,51,71,31,-1,38,89,21,31,16,27,6,158,-6,-53,-62,78,4,-29,-89,-16,-57,32,-78,-31,29,-19,2,-26,-21,36
+L48728_cds1_at,263,217,163,354,197,202,295,364,123,303,134,201,79,200,125,263,343,203,278,307,131,147,305,39,213,333,470,86,259,178,314,309,309,255,180,350,298,390
+L49054_at,-64,-84,51,29,-7,-58,10,41,-11,-15,6,-12,-23,24,-44,10,101,39,-30,3,4,-41,34,-117,-15,29,-162,-87,38,-28,-82,-41,104,26,19,-40,-31,-35
+L49169_at,741,5605,1287,557,1132,714,1194,1145,1320,2693,1037,1365,1106,652,1258,1118,1506,1356,2167,2460,689,2432,444,1227,7647,4029,1380,3030,807,4689,4359,989,11578,644,6796,1117,6372,5100
+L75847_at,-13,61,-46,45,9,-7,57,73,-32,19,-21,-8,16,51,15,16,-49,20,25,52,38,-13,3,41,56,1,-65,-30,-24,-14,3,40,-20,-6,-9,2,-12,28
+L76159_at,431,387,428,262,750,295,166,193,661,480,626,47,370,330,408,411,718,343,405,831,747,238,322,450,213,220,75,184,187,287,335,126,309,411,211,214,164,184
+L76191_at,1720,1127,1093,1599,1569,638,1925,877,1679,574,1191,2128,1696,1106,2065,1271,1536,678,762,1933,1049,789,813,2190,1038,1670,957,1089,764,2244,2081,761,1151,1153,2756,1123,1108,2414
+L76200_at,1610,3479,5013,501,1058,2521,161,2227,4727,2845,3048,941,849,1380,944,1883,-483,749,1301,2611,658,1633,1402,69,1704,995,117,-630,519,843,2904,5607,1096,2450,959,943,669,1362
+L76224_at,1011,578,1196,463,325,343,873,979,754,358,516,140,484,425,229,788,507,345,283,452,363,717,417,651,619,584,788,596,396,931,504,712,408,163,558,716,511,1161
+L76380_at,232,247,492,376,148,266,334,431,303,159,292,140,132,262,186,138,473,138,107,169,49,387,243,268,237,149,530,328,230,340,297,325,359,89,171,327,503,656
+L76465_at,116,18,132,40,56,83,68,64,166,-22,100,-5,34,1608,46,48,176,32,31,4,132,27,7,16,23,57,291,54,52,34,23,62,32,37,71,52,211,18
+L76571_at,49,-113,101,-80,-66,-65,-28,-149,82,-141,-18,-34,-65,-9,-140,-31,-374,-121,135,-26,-16,44,-134,-66,-64,-48,-508,-80,-74,-26,190,114,190,91,-104,-87,138,-35
+L76687_at,73,7,180,19,16,62,-3,-11,45,16,54,-41,7,-57,-10,59,-49,28,23,31,52,73,11,14,504,-23,45,-63,26,5,-91,-25,-44,-30,-95,0,48,98
+L76702_at,394,310,764,122,231,300,-325,112,1012,626,318,-262,1171,-132,221,536,926,129,352,826,-29,-204,237,337,-323,190,765,146,218,-89,-71,-298,-210,74,113,185,-387,-820
+L76703_at,417,502,433,304,451,193,194,328,499,144,550,109,379,374,367,301,342,199,209,963,558,185,343,394,183,210,161,181,67,141,254,297,158,163,184,184,398,353
+L76927_rna1_at,-94,-180,-85,-140,319,-99,-21,-244,-15,36,-89,-24,243,-51,175,28,-84,62,-56,174,-192,-99,-267,177,-53,5,-308,-145,-331,-98,-277,-282,-129,-153,-180,-6,-126,-92
+L76937_rna1_at,77,133,42,68,195,87,78,76,134,59,261,27,144,128,71,182,84,190,129,174,227,150,-53,143,101,27,65,150,139,63,299,392,161,137,138,35,22,210
+L77213_at,549,56,622,-41,517,-12,374,322,425,-33,337,91,164,489,50,402,482,304,279,739,106,-122,-123,454,226,285,154,357,526,247,125,374,171,211,78,-43,348,670
+L77559_at,16,-92,-112,-82,12,0,-73,-116,-83,-30,42,-47,-10,-76,-90,-72,-118,-33,0,-123,9,23,102,-137,-178,-10,-68,-159,-55,-77,-44,-111,-74,-34,-89,-137,-124,-147
+L77561_at,376,384,598,528,218,553,609,653,433,279,195,287,161,366,142,398,346,252,191,400,303,332,328,236,281,259,599,363,473,470,547,603,481,123,689,446,469,760
+L77563_at,76,-132,47,71,-45,-24,-55,-122,-245,108,-142,-89,59,-61,-71,208,-35,154,-32,-42,-48,-75,13,-1,-90,-29,31,-74,-122,-132,-127,-81,-38,-75,-48,-71,-41,-133
+L77566_at,-77,-19,-207,-215,-20,-136,-287,-26,-185,-105,95,-155,-40,-58,-116,35,-73,-38,-14,94,-48,-39,-146,-51,85,-40,-256,-72,-79,-21,-32,229,-87,23,-96,-137,-162,10
+L77571_at,-127,-767,-938,-163,34,-83,-265,-1209,-243,-192,-197,-228,-101,-138,-185,-19,-710,-389,-132,-255,-274,-176,-108,-121,-372,-233,-865,-319,-372,-340,-440,-306,-243,-103,-334,-294,-259,-298
+L77701_at,-847,-751,-840,-620,-53,-720,-848,-1304,98,-903,-616,-551,-250,-203,19,-406,-1324,-93,0,-929,-321,-827,-866,-542,-705,-274,-1534,-441,-1399,-477,-149,-567,-685,-271,-845,-1876,-1042,1129
+L77730_at,250,205,270,211,73,144,215,262,171,160,111,107,166,197,113,270,252,193,97,292,87,257,273,156,192,212,444,189,211,283,177,89,194,70,230,230,284,299
+L77864_at,-590,-259,-563,-1104,-126,-412,-888,-1197,-533,-329,-784,-435,-264,-280,-403,-363,-873,-776,-301,-9,-346,-443,-493,-513,-592,-342,-1653,-645,-925,-344,-347,13,-501,-323,-230,-655,-1398,-484
+L77886_at,1126,87,360,79,38,316,25,85,416,131,180,73,31,126,34,507,418,138,59,357,1316,-10,260,160,19,151,215,99,168,43,151,56,-13,94,197,9,105,48
+L78132_at,127,111,95,49,68,28,53,122,115,2,147,22,20,81,71,15,71,-40,50,74,123,85,41,91,58,-16,70,-12,57,22,86,144,90,19,113,34,50,104
+L78267_at,175,103,95,9,76,76,5,38,72,71,77,73,41,62,46,81,214,62,67,152,-11,73,129,93,5,41,158,28,88,-19,-20,55,4,65,81,-13,166,10
+L78440_at,617,1471,1057,725,315,528,651,986,644,500,491,291,361,893,300,522,1007,504,391,502,359,427,524,362,362,341,624,636,442,542,789,708,572,602,484,323,719,807
+L78833_cds2_at,-42,-114,-120,-192,-98,-172,-146,112,-359,-79,-299,-33,7,-141,-190,25,89,4,115,23,-176,-69,-283,-126,48,41,-78,-154,43,-335,-102,109,-129,-105,100,-336,-154,-7
+M10014_cds1_at,148,85,272,68,66,51,107,218,153,14,115,56,82,80,41,142,120,68,83,53,73,167,77,94,10,69,111,108,305,83,205,74,225,39,67,142,173,426
+M10050_at,-232,-113,-273,-165,-102,-147,-117,-313,-301,-236,-129,-126,-96,-192,-63,-189,-355,-76,-111,-172,-51,-239,-125,-67,-155,-287,-151,-123,-48,-138,-114,-114,-101,-86,-130,-173,-274,-225
+M10058_at,-711,-249,-1430,-638,-447,-567,-917,-890,-1231,-432,-321,-346,-257,-604,-717,-303,-447,-763,-412,178,-208,-649,-632,-666,-626,-621,-1638,-994,-394,-1014,-803,-542,-967,-223,-558,-1224,-1234,-2010
+M10612_at,707,138,555,351,342,108,235,409,420,76,63,27,236,54,51,248,173,186,181,525,149,71,176,315,214,239,442,677,168,510,664,398,153,270,1996,2109,188,332
+M10901_at,690,373,156,599,616,140,1712,1161,322,169,1105,219,843,268,589,327,331,271,1187,1511,1331,724,237,1897,302,507,397,228,214,440,419,367,313,123,240,302,189,641
+M10950_cds2_at,-112,-129,-28,-31,-21,-24,-45,-32,-15,-16,-66,-12,-57,-31,3,-45,-90,-28,-18,-57,-49,-188,-58,-20,-72,-53,-81,-73,-38,-123,-50,-41,-47,-46,-30,-70,-25,-76
+M11058_at,36,28,159,13,103,35,-18,-43,183,113,165,-8,6,68,21,17,3,98,2,15,-57,-35,-74,-26,-86,-89,-53,-24,-62,-23,22,58,55,22,76,-66,15,-29
+M11119_at,1768,1189,2088,2045,900,983,2651,1191,1136,1076,1079,780,836,1328,872,1411,1706,1193,877,1700,1492,1301,412,2231,828,891,2023,1175,1106,1261,1257,1385,1351,591,893,869,1584,2063
+M11147_at,5418,17348,6156,7070,9017,6221,4746,7881,9431,5092,6027,15280,6183,13077,8506,3720,12676,9783,4453,13988,2900,6074,3729,6023,13278,4718,4110,12406,7855,24521,21277,20124,16705,11012,18372,12276,19173,21498
+M11186_at,80,244,-23,359,-71,216,411,62,245,-152,-94,83,227,-110,-122,44,51,4,-16,-188,269,-10,146,129,-133,-82,-48,22,276,8,-360,-19,-3,118,-172,646,579,154
+M11321_at,-171,-206,-192,-255,-135,-28,-196,-305,-115,-164,-117,-136,-128,-50,-172,-136,-126,-220,-124,-236,-92,-163,-121,-32,-176,-110,-280,-159,-175,-159,-78,-79,-209,-62,-158,-100,-275,-223
+M11353_at,14913,14924,19777,14619,14573,10619,14650,17011,15050,9423,15490,9183,12586,16065,13228,14483,16101,4215,11163,16819,17227,11360,10052,15896,7078,8793,13124,9205,10726,9395,13237,10437,11838,7933,8476,10304,14909,9112
+M11433_at,124,31,-31,33,51,-168,3,-32,52,30,-32,-12,-11,59,-30,-43,-41,48,-4,123,-4,47,1,20,53,-12,46,-80,-108,-31,-38,41,63,41,26,-74,0,8
+M11437_cds1_at,-97,15,103,33,-30,28,-154,46,-11,-30,24,-38,-43,0,-15,-9,-60,-15,-20,-21,-31,39,0,71,-5,4,76,18,79,5,-78,-11,0,-19,-36,18,8,52
+M11437_cds2_at,179,72,400,103,114,5,47,209,-50,20,59,-14,-2,94,31,-11,-125,53,29,88,283,124,148,210,126,151,39,-57,153,74,33,180,94,1,40,-47,12,-18
+M11567_rna1_at,-552,-526,-1312,-820,-446,-531,-799,-787,-605,-698,-482,-438,-485,-501,-437,-628,-336,-423,-475,-490,-356,-476,-461,-524,-426,-533,-876,-616,-565,-794,-822,-659,-838,-319,-754,-618,-703,-509
+M11591_at,94,-14,125,-19,9,-24,-107,38,52,85,21,-4,-61,101,-39,24,-32,10,42,-96,-37,98,45,-40,80,31,48,-46,28,77,-48,-283,16,-50,58,-26,7,32
+M11717_rna1_at,291,441,321,660,689,60,253,218,197,6495,118,-24,1663,347,49,112,1016,185,143,631,1886,11,98,799,7344,263,212,182,55,227,372,437,692,516,7053,166,2,433
+M11718_at,179,54,21,119,-29,94,36,53,-64,128,42,54,105,0,43,46,117,134,100,93,116,159,414,-80,208,169,165,209,122,165,197,190,139,99,26,24,163,-69
+M11722_at,3282,1627,2783,1544,1896,2372,613,4066,1391,972,780,2433,9811,257,6270,6845,1234,-135,7686,10926,1830,219,807,1628,2790,5455,2495,454,2,455,297,166,-252,297,412,385,1284,58
+M11726_at,389,265,494,575,141,257,196,343,43,270,260,301,70,311,163,221,61,23,312,206,139,304,283,329,294,268,240,393,353,194,355,307,387,91,338,421,548,605
+M11749_at,-308,127,-348,-57,92,-113,-119,-367,-271,2,-182,-136,-21,-33,-42,42,-288,59,56,74,16,-206,-91,75,-5,75,-122,90,-12,-171,-109,-33,64,-15,11,-104,-153,-118
+M11973_cds1_at,69,82,172,161,52,-44,57,113,62,-241,56,-51,1,89,58,87,134,42,-56,146,74,180,55,76,103,124,323,-353,254,43,127,68,161,-74,-6,98,79,324
+M12036_at,-179,-283,-353,-248,-97,-279,-490,-851,-283,-80,-182,-179,84,-287,3,-80,-492,-121,-162,-46,-94,-201,-180,-217,-170,6,-331,-207,-262,-306,-616,-307,-186,-158,-368,-690,-287,-578
+M12174_at,710,394,376,756,803,506,341,1716,464,932,803,827,632,269,228,273,305,72,230,1155,11,1027,220,531,1376,163,538,579,339,349,454,520,535,231,757,291,955,944
+M12529_at,-338,-500,-834,-93,-501,-312,-720,-484,-385,-138,-401,-224,-281,-457,-319,-256,-753,-219,-137,-232,192,-347,-218,-462,-255,-153,-636,-184,-276,-620,-310,-49,-92,181,-70,-839,-550,-195
+M12625_at,0,372,587,-33,349,-92,-84,-652,430,295,247,17,29,269,276,100,200,330,31,310,-46,-94,-62,193,380,-156,-356,-273,-353,456,255,151,103,396,297,-154,88,93
+M12759_at,1080,4490,214,114,89,115,77,128,163,85,-103,1136,92,92,116,271,492,3386,791,103,123,69,75,-59,6644,530,4554,225,153,282,579,127,198,91,175,325,1322,264
+M12886_at,723,9456,19653,-190,95,7978,-270,1289,16572,21880,6008,612,282,14079,433,4811,7932,969,319,6259,356,-28,3894,139,2572,342,-276,970,682,-204,-131,-179,1983,113,-154,74,6667,-260
+M13143_at,304,278,486,214,201,131,220,104,279,179,209,179,115,174,176,436,-165,184,320,246,264,175,313,88,329,200,264,385,329,167,246,176,293,10,209,224,241,353
+M13149_at,240,194,355,297,117,87,154,289,177,102,71,139,44,201,91,176,107,146,141,89,62,181,151,208,97,137,231,238,216,220,254,171,190,145,38,30,199,310
+M13194_at,488,638,690,588,687,439,534,227,740,797,443,462,681,646,810,1295,420,435,1193,1797,715,367,801,697,574,988,777,700,526,981,934,213,890,322,569,855,1069,290
+M13207_at,-203,-231,-244,-533,-96,85,-267,302,-362,-275,-269,-238,-152,-103,-287,-213,491,-38,-156,-294,-394,-295,-364,-361,-337,-146,231,-126,-295,-214,-498,-399,-300,-275,-211,-440,-381,-293
+M13241_at,89,29,63,-82,80,-7,45,23,106,99,14,12,66,333,-12,36,149,43,-4,105,-2,75,9,75,16,79,-18,303,129,-16,-40,716,220,153,14,-1,109,9
+M13450_at,2149,1870,3234,2192,2172,1625,2409,1152,3796,1507,3109,829,1711,1866,2262,1466,3123,901,870,3566,1215,881,1417,3018,1658,1354,976,1633,1315,997,1333,1296,1728,920,1281,1144,1522,1769
+M13666_at,385,131,498,267,250,167,85,349,208,314,284,125,176,145,176,302,181,165,55,95,465,311,174,166,441,290,317,224,189,226,190,271,194,113,192,210,221,283
+M13699_at,-136,44,30,-34,37,-24,-194,17,-10,7,-64,51,-28,54,25,-136,-31,-41,32,-29,-159,-2,-32,-2,76,-10,4,111,141,-52,17,-87,-61,-141,71,-27,31,-4
+M13755_at,1136,494,643,638,669,234,243,499,957,493,388,494,440,690,833,952,-193,437,483,4103,34,307,359,196,1236,597,715,-120,-158,1353,5863,1189,228,74,367,722,387,4065
+M13792_at,3221,10954,16529,5364,2837,16135,6067,3103,15235,8982,8630,1695,4765,3529,9000,10227,8469,2091,2273,12217,2973,1743,12805,5981,2425,3323,2617,911,2551,1297,753,2708,2493,487,769,1614,4148,1446
+M13903_at,343,286,540,76,427,-97,-136,-314,143,370,270,133,-4,55,137,-217,133,353,53,610,338,307,273,135,396,168,-158,61,-81,295,317,160,424,150,53,278,316,510
+M13934_cds1_at,-190,-231,-320,-182,-115,-261,-238,-187,-176,-44,-229,-122,-173,-306,-153,-248,-48,-180,-134,-212,-72,-214,-214,-328,-253,-189,-297,-294,-259,-246,-303,-283,-231,-127,-311,-209,-260,-325
+M13934_cds2_at,14108,12913,16066,15496,15002,16775,17770,14010,16467,17688,17068,19078,13783,16001,14792,15912,9278,15967,17911,14520,3070,16169,17279,15575,15883,15301,16951,16149,17757,16993,17371,18181,16526,18979,15610,19473,11919,17069
+M13955_at,303,329,419,381,313,261,-65,-14,-528,-74,153,228,261,162,21,97,-205,480,285,691,157,256,70,140,36,369,599,266,62,271,479,563,369,245,271,287,0,704
+M13982_at,-475,-654,-572,-676,-280,-414,-613,-901,-673,-471,-111,-349,-286,-506,-247,-394,-493,-385,-383,-507,-199,-275,-621,-462,-338,-470,-927,-231,-322,-522,-639,-538,-425,-170,-557,-500,-714,-982
+M14016_at,339,329,711,375,379,286,438,409,572,446,343,171,349,365,331,427,335,274,474,691,232,211,362,425,510,290,398,481,415,356,2669,2030,940,773,379,659,483,862
+M14058_at,613,185,240,54,35,167,-28,74,206,121,91,149,324,128,218,38,411,187,272,396,465,108,37,412,340,425,37,573,492,310,41,11,568,129,37,154,106,768
+M14091_at,18,-39,-116,-13,-6,-40,36,-38,-10,26,-55,44,-25,-69,50,-8,-54,-109,77,44,116,68,-62,-139,-10,-123,240,-42,40,-57,-81,-44,-50,-11,35,-66,83,-250
+M14113_at,217,71,152,53,48,136,60,140,136,85,156,119,41,89,105,70,294,43,51,140,-29,44,136,60,123,-50,9,41,197,210,100,36,39,10,89,155,92,95
+M14123_xpt2_at,211,84,197,137,105,55,62,152,184,245,143,205,187,173,133,459,201,169,204,282,94,27,220,126,180,221,46,306,281,17,259,55,89,193,29,296,224,90
+M14123_xpt3_at,26,72,58,67,37,35,18,34,73,119,21,64,83,86,78,93,121,165,117,133,26,-6,-13,-32,-4,211,352,78,105,61,62,49,92,-1,75,121,96,63
+M14123_xpt4_at,-449,-127,-87,-316,-141,-14,-238,-368,-157,-45,-195,-239,6,-108,-143,-137,-170,-149,-125,-21,-139,56,-20,-159,-100,-110,-270,-111,-62,-251,-324,-109,-45,-99,-164,-94,-99,-121
+M14158_cds4_at,434,307,343,460,170,330,299,376,437,332,152,257,275,479,81,260,400,257,222,167,146,226,463,98,129,318,281,117,108,414,495,441,236,107,210,371,495,610
+M14159_cds2_at,-289,-386,-390,-411,-171,-85,-352,-470,-80,-200,-68,-194,-102,-47,-287,-280,-5,-206,-365,-800,-84,-115,-288,-59,-253,-217,-230,-533,-19,-359,-488,-445,-128,-95,-594,-285,-427,-299
+M14200_rna1_at,685,1629,1545,1434,2539,684,717,218,1762,1134,1138,1395,1167,513,2792,1019,702,1778,432,1252,3441,330,807,1733,794,402,899,392,682,924,881,-27,213,479,2882,655,853,267
+M14218_at,-667,-687,-1102,-463,-194,-650,-974,-598,-778,-612,-515,-346,-427,-566,-403,-384,-1077,-339,-571,-410,-547,-714,-737,-381,-572,-455,-879,-500,-644,-634,-794,-757,-861,-370,-279,-651,-765,-956
+M14219_at,147,238,161,221,483,101,139,130,342,117,487,112,478,230,279,244,575,110,285,724,211,139,119,239,149,109,64,174,151,191,128,108,170,326,239,150,310,184
+M14338_at,-65,-16,-120,-74,-92,-90,-105,-280,-110,-201,-114,33,-77,-104,-60,-111,-376,-96,-178,-212,-1,-137,-131,-81,-178,-34,-120,-129,-149,-141,-175,-199,-101,-91,-103,-32,-112,-304
+M14539_at,-106,80,82,2058,2673,-99,-16,-467,-70,83,14,104,912,-47,1008,22,-75,-160,36,553,39,2167,138,-53,56,-43,-117,386,19,642,124,105,-34,-21,813,4596,7,237
+M14565_at,54,76,114,412,173,145,-15,178,271,86,0,40,227,103,-42,221,42,268,124,-104,157,472,226,217,48,169,291,275,180,289,231,73,334,151,-33,15,115,339
+M14636_at,-44,52,-116,70,151,-14,18,-38,-46,16,-3,191,-4,14,35,-34,1214,10,76,-49,33,-3,24,15,161,37,20,305,238,220,67,-13,119,110,367,130,303,339
+M14648_at,-21,-41,-54,39,18,-81,-70,-28,-70,-12,-8,-8,1,2,-41,-37,10,-9,-6,-52,-62,-14,3,-71,-20,-28,32,-4,-52,-19,13,-11,-7,9,-4,-39,-18,26
+M14660_at,63,43,148,-55,41,-37,-144,-13,24,134,-24,-54,71,-13,36,31,77,60,7,339,47,18,24,17,108,164,109,-2,-81,2604,378,613,74,10,72,95,82,1146
+M14676_at,1864,1293,2951,965,618,1746,1458,1509,3170,1321,1843,1233,1899,2107,673,788,1507,594,1066,1524,1271,962,1968,1024,853,1894,1506,852,1060,1357,1418,1090,1067,558,932,958,1950,1308
+M14764_at,575,285,547,367,228,288,450,367,354,359,277,275,402,264,203,234,479,176,138,333,243,333,246,342,283,228,447,294,360,473,344,426,461,89,420,223,339,557
+M14949_at,31,0,-115,-267,167,-12,-21,-382,63,119,-97,-182,53,0,-163,-80,-140,19,-149,430,-53,-166,-83,-401,-235,461,-702,-4,98,233,274,-263,98,110,107,-279,-82,-126
+M15059_at,831,327,558,521,309,531,1053,694,537,408,212,317,152,479,287,305,533,1523,294,201,348,418,412,426,295,317,422,552,740,662,577,545,757,150,1239,500,874,884
+M15182_at,1491,845,1354,819,1209,967,947,698,1588,859,784,768,1055,1265,1369,938,1167,634,813,3497,1069,589,963,1310,687,1004,611,1415,1000,1741,1467,854,1031,1241,2606,2005,1055,765
+M15205_at,989,759,1614,1246,434,1100,1196,959,1760,1274,705,405,2144,743,1389,420,775,1264,824,1013,392,656,777,1001,842,974,707,983,1089,1718,2048,2001,2177,1233,826,1055,796,1888
+M15353_at,83,54,60,-15,77,28,-6,56,14,37,70,12,131,119,61,58,74,70,30,148,61,32,28,130,4,15,17,40,36,-17,26,112,-8,26,53,22,11,28
+M15517_cds5_at,-157,-156,-72,-100,-125,-119,77,-77,-229,-14,-190,-123,-42,-138,-19,-319,380,-91,-130,-199,-99,-155,-81,1,-27,173,-345,29,-40,-21,-218,25,-47,-89,-255,-95,-118,230
+M15656_at,-403,-985,-743,-554,-628,-309,-388,-1482,-1023,-82,-803,-356,-375,-835,-226,-838,-464,-653,-624,-861,-261,-448,-944,-690,-630,-519,-700,-1014,-829,-878,-248,-484,-1039,-79,-774,-19,-360,-660
+M15661_at,926,1646,1724,1407,1346,1477,1371,404,1891,1083,3407,1007,911,1467,1895,979,677,1294,977,2625,2020,672,1020,1829,659,759,693,1413,949,1302,2135,1255,1399,2159,1724,1489,1086,2450
+M15780_at,-109,-99,-189,-110,-87,-206,-107,-167,-231,-100,-171,-132,-102,-122,-128,-124,-290,-157,-92,-159,-176,-143,-153,-126,-311,-134,-100,-164,-163,-194,-66,-35,-79,-82,-207,-346,-209,-185
+M15796_at,479,430,934,186,344,590,147,139,1016,154,831,145,931,606,1025,137,582,561,221,545,1371,73,653,761,269,232,258,-69,141,178,374,126,348,378,-132,-91,-44,133
+M15841_at,362,851,688,143,437,184,149,172,796,280,572,122,600,384,794,346,324,119,144,1769,1621,452,341,679,644,180,200,138,257,218,189,133,339,251,-17,14,137,289
+M15856_at,66,119,130,154,60,46,26,112,51,-19,89,-11,33,146,27,70,82,59,89,-68,91,95,37,69,20,41,107,3,64,97,134,42,164,21,125,34,187,117
+M15881_at,215,-81,135,74,91,99,72,154,37,73,-64,34,113,8,92,159,0,198,123,-198,-81,155,203,183,-55,31,62,209,218,177,51,182,204,10,125,103,-27,270
+M15958_at,-958,-944,-1334,-876,-621,-732,-988,-1302,-969,-654,-687,-357,-612,-837,-553,-687,-351,-464,-286,-955,-438,-639,-841,-671,-745,-567,-1475,-820,-815,-911,-1146,-1106,-917,-475,-950,-986,-1209,-1174
+M15990_at,392,502,371,232,73,138,181,401,276,227,463,191,157,249,151,196,382,231,241,362,222,211,144,134,270,266,381,254,153,180,274,253,282,203,286,266,281,740
+M16038_at,365,624,108,873,686,302,325,244,273,144,34,399,281,589,854,289,534,540,44,616,447,239,9,515,50,268,483,1674,735,2727,2399,784,679,1305,2694,1028,2680,3223
+M16279_at,3079,10455,9378,1493,4742,8842,1063,-250,11741,12546,12682,3545,2459,2484,1709,5862,10698,642,9145,1085,708,-31,6562,2211,8156,8025,-794,2037,1587,1671,1579,5641,1991,3044,3982,7135,7657,2226
+M16282_at,410,198,569,392,217,270,430,463,317,305,223,152,260,323,227,442,483,311,281,288,249,402,353,435,382,460,455,425,322,419,303,399,361,126,292,355,466,627
+M16404_at,-83,-101,-130,-105,-80,-58,-11,-64,-87,-37,-27,-90,-83,-78,-21,-142,-101,-60,-37,-102,-19,-40,-62,-58,6,-48,-132,-88,-33,-92,-49,-17,-114,-69,-51,-26,-120,-30
+M16405_at,793,230,950,305,292,380,813,694,427,452,341,99,268,257,208,383,832,499,494,396,209,453,212,389,299,684,779,819,755,803,339,660,869,177,246,459,545,1030
+M16424_at,414,-223,-199,-205,170,81,865,-988,-88,-240,-303,76,-123,265,-45,11,-350,74,101,52,308,18,273,-259,109,78,-715,359,226,-106,-461,-274,144,973,471,826,262,8
+M16441_cds1_at,-390,-840,-391,-828,-337,-293,-413,-1040,-477,-611,-312,-268,-395,-287,-205,-340,-1136,204,-488,-427,-307,-357,-334,-603,-112,-664,-1021,-519,-793,-354,-924,-297,-409,-348,-1029,-388,-699,-670
+M16447_at,203,185,367,246,497,64,231,215,318,202,116,24,314,346,253,78,335,58,189,476,287,112,121,395,230,215,176,249,141,184,285,116,343,98,304,368,302,302
+M16505_at,-84,-67,-11,213,342,-19,126,-103,-36,-64,-94,-30,61,21,118,109,-74,-1,30,1,77,15,-37,-11,-5,76,-62,-20,-122,-1,-13,-110,-121,-19,-56,-57,-67,-90
+M16801_at,114,-27,-4,49,-12,49,36,26,43,10,1,35,51,68,24,-2,120,-1,39,22,-9,-13,0,68,60,57,25,63,-9,-4,42,-56,-1,-33,56,1,-8,90
+M16937_at,87,59,54,-26,87,-39,30,-23,23,-45,7,28,-14,21,58,-95,86,121,16,127,-17,64,-26,106,78,160,-68,256,26,106,56,63,3,263,196,153,17,72
+M16961_at,128,128,189,8,116,124,225,91,127,82,86,61,110,68,71,179,130,83,56,84,162,134,115,209,154,143,230,64,122,152,103,85,96,98,99,134,195,136
+M16967_at,-270,-24,-143,-114,-83,44,-122,-109,-160,-154,-111,-70,-109,-144,-60,-125,-134,-147,-121,-69,-11,-132,-127,-75,-117,-112,10,-83,-168,-77,-163,-258,-157,5,-33,-90,-154,-207
+M16973_at,253,-9,269,-153,-49,-165,-73,-136,37,14,-66,86,-327,102,-94,-260,-191,-248,32,-126,63,-26,89,75,-59,282,-214,322,139,-499,-110,82,21,-10,4,-221,-60,231
+M17219_at,70,40,85,-39,15,21,45,89,24,6,24,35,204,14,138,246,53,36,352,439,387,57,112,7,112,58,217,-49,9,4,20,73,74,55,44,10,490,98
+M17262_at,293,233,398,474,102,334,421,124,294,246,232,245,219,318,316,275,196,301,307,338,374,231,113,266,190,300,251,423,250,440,374,386,367,282,293,392,312,508
+M17316_at,-81,-329,-502,-396,-373,16,-18,158,-473,184,-117,-109,-118,-39,-69,-24,450,95,-33,-576,-146,-366,-421,-83,-149,-94,198,-391,-420,200,175,-494,150,11,548,83,199,143
+M17466_at,-45,-197,-126,-231,124,-179,-62,-116,26,-47,107,-94,-87,-83,-105,-105,-134,27,-32,-214,-27,81,81,-52,-153,-59,-228,26,-48,-26,-252,-279,-56,25,-18,-125,-187,1
+M17733_at,14223,17650,21798,15790,15470,29496,18805,17175,17827,21874,17789,25622,18530,14919,17499,19987,15084,23352,14423,14836,20840,10036,21444,18546,16072,14954,12987,13905,13424,17332,14387,15140,11444,10319,16802,14026,15939,17207
+M17754_at,371,133,216,372,179,231,248,427,332,184,304,11,320,254,232,411,247,237,248,343,1,342,288,349,269,258,6,419,125,378,44,11,307,182,6,-155,153,-232
+M17885_at,20663,23952,21873,23052,22863,27994,19901,26804,19765,28033,25524,28619,21474,23810,23891,25393,22141,26440,23297,15232,24694,23086,27159,23082,26232,23625,28296,23046,25310,23308,24572,22203,23447,30354,22417,28350,25093,22347
+M17886_at,14744,16712,16731,17036,16806,23456,16959,18213,16113,20922,19733,25213,18877,17723,16858,17858,15040,20832,20221,12945,17086,18918,22274,17151,19906,18341,23498,18291,27470,20499,17868,18830,16672,25141,15917,21941,17661,16653
+M18000_at,17748,21825,16891,19994,17680,19997,18972,15780,22225,21794,20866,22066,17259,22061,20365,21277,17557,23019,21412,19285,29485,17540,21018,19389,22679,20717,24399,22002,18847,16338,20226,20402,20910,23990,20413,21749,20722,18258
+M18079_at,21,83,47,-58,32,16,8,59,27,-13,-6,-21,10,-10,67,-18,155,40,-6,121,87,78,45,-17,31,32,-7,16,45,4,-4,-79,25,81,4,3,-9,-136
+M18185_at,-68,-147,-216,-161,-91,3,-57,-122,-45,-39,107,21,-12,-127,31,-135,-234,-45,3,0,-141,-205,34,-177,-142,-160,-75,-76,-214,-207,-123,101,-153,-31,-199,-45,-191,-295
+M18533_at,-27,25,7,-5,2,71,-33,143,-11,-10,12,-25,-21,64,31,-17,-55,115,-42,0,51,15,-17,-34,51,20,3,-16,0,-23,4,19,-34,17,-26,-27,-49,4
+M18728_at,-7,30,-60,-173,-13,-128,-72,-241,-26,-177,7,589,152,-68,15,-81,576,-60,465,-127,-159,113,-207,-73,292,444,-25,-164,-26,-41,-70,-29,-153,37,-234,-179,-77,-24
+M18731_at,-746,-598,-992,-885,-551,-645,-737,-1039,-680,-299,-532,-346,-328,-669,-504,-282,-885,-277,-327,-672,-361,-646,-602,-566,-525,-502,-873,-365,-634,-743,-741,-499,-414,-259,-608,-685,-764,-1089
+M18737_rna1_at,615,244,677,358,835,227,280,946,515,400,240,129,475,360,670,363,1108,416,212,462,3929,903,277,331,409,559,531,750,500,232,149,742,193,99,328,457,289,666
+M19159_at,1317,1266,1849,1156,706,1081,1534,535,1145,983,1031,855,1083,954,723,1063,1633,928,771,621,638,1437,1088,514,1310,670,1868,1859,1173,1833,280,565,1112,-85,1080,970,1138,805
+M19283_at,6284,14069,13354,10677,15517,6638,7852,7432,16358,9850,9459,3904,11615,7290,14695,11916,14838,14417,6941,16627,3575,11049,9888,10929,6534,10243,8759,7372,4453,10625,5345,5785,8749,11206,13621,8768,8030,6113
+M19301_at,152,106,86,56,95,55,70,128,80,99,57,10,58,32,41,79,89,106,-4,35,38,32,20,112,78,62,-10,27,67,53,-2,89,51,73,36,20,122,70
+M19481_at,-63,0,-307,-95,-67,7,-84,-83,-22,-118,-131,-44,-92,-52,-25,-159,-118,-112,-99,-63,-44,-164,-1,-157,-150,-89,31,-119,-72,-221,-90,-95,-170,-81,68,-68,-156,-98
+M19483_at,2810,5085,4601,3740,5879,2692,3137,2794,6235,4938,4055,2010,3427,4459,5142,3911,5052,1995,3632,8612,1585,2364,2365,5018,2456,2734,2296,3747,2308,3367,3105,3244,3606,3328,5139,3245,2260,2495
+M19507_at,56,-29,-109,-62,938,88,-78,-257,-35,392,16,1452,22,93,333,3562,1441,184,478,379,-64,51,-36,59,135,196,-93,6960,15791,2005,1003,5702,429,2204,353,11205,209,8072
+M19645_at,520,2171,646,371,1267,215,287,250,978,2404,2362,373,738,436,742,431,744,643,496,2581,1371,1947,271,969,3499,1163,779,1877,415,2817,1262,5186,1283,933,8991,1842,647,1792
+M19684_at,-41,-662,-550,71,-347,-216,23,-215,-923,-663,-395,-43,-312,-472,-388,-422,-352,-415,-547,10,96,-17,-68,-93,-450,-403,-164,117,226,-71,-120,-14,-379,47,70,-51,38,58
+M19720_rna1_at,329,205,475,316,205,325,347,326,261,235,242,273,250,256,206,197,281,254,247,269,221,223,300,351,283,251,350,359,336,288,235,392,328,142,342,316,384,471
+M19720_rna2_at,-232,-81,-165,-175,-105,-80,-215,-257,-322,-260,-176,-109,-156,-120,-233,-179,-462,-66,-128,-219,-82,-294,-74,-66,-184,-276,-497,-144,-283,-129,-259,-188,-125,-25,-299,-210,-420,-293
+M19722_at,1563,1007,2144,1558,973,1621,1169,1241,5812,1231,580,814,860,2278,919,1094,1102,681,649,792,236,969,976,940,721,715,902,1528,981,5004,2235,1298,880,571,4065,1359,2259,2268
+M19961_at,1120,1331,1669,1050,1981,519,966,562,1611,1969,690,832,1688,1211,2217,1975,1053,1297,1481,5812,2263,757,664,1041,942,1567,713,932,697,1568,770,795,918,1956,2369,1198,854,498
+M19989_cds1_at,-213,-100,-41,-222,-96,-206,-317,-347,-210,-160,-198,-133,-50,-189,-30,-79,-178,-76,-126,-141,41,-248,-275,-119,-75,-104,-386,-232,-293,-148,-114,-164,-183,-39,-36,-277,-251,-206
+M19989_cds2_at,205,176,87,187,254,-16,47,176,346,239,1468,340,539,93,1062,109,160,106,176,1203,633,502,77,666,78,256,15,172,79,-63,309,18,181,110,171,77,120,235
+M20137_at,197,100,269,24,65,85,168,139,77,123,73,56,97,170,79,133,89,116,108,197,157,27,178,69,103,72,428,250,125,95,156,72,124,18,175,10,283,229
+M20218_at,-90,74,-157,-103,45,-17,-89,-145,-54,-10,73,64,77,-80,-17,69,-250,169,56,-49,19,-11,245,4,60,5,-64,-91,-96,83,-132,24,-83,105,-61,-194,73,-189
+M20471_at,957,1357,796,1856,2698,969,1920,812,1789,992,524,651,1633,1376,2784,1438,1275,1426,1493,3982,3390,377,590,2173,427,543,941,1516,1238,1264,1209,728,1231,1324,1660,1725,851,780
+M20530_at,189,205,367,-4,119,42,194,155,138,90,143,15,191,85,100,192,94,162,64,187,19,2,207,220,118,111,206,384,105,214,110,65,235,83,266,77,101,35
+M20543_at,-11,59,-31,11,41,35,28,-64,12,60,7,60,58,11,11,90,228,55,-37,68,56,-11,77,-16,-33,33,56,9,117,-3,47,60,13,57,35,28,142,-16
+M20681_at,96,2580,418,-241,145,-49,102,446,541,309,348,919,270,182,105,154,884,283,309,1027,659,434,0,17,2780,985,-39,468,26,2425,1930,1292,2524,438,2202,149,452,3030
+M20777_at,-242,-339,-401,-393,-240,-352,-396,-385,-234,-76,-326,-194,-319,-103,-180,-183,-553,-243,-195,-339,-429,-312,-340,-520,-266,-119,-547,-258,-444,-286,-290,-558,-256,-5,-285,-262,-301,-382
+M20786_at,-790,-567,-867,-902,-243,-787,-1045,-1121,-545,-224,-443,-491,-530,-554,-412,-436,-1191,-786,-476,-575,-406,-515,-507,-865,-466,-835,-1312,-297,-988,-719,-1069,-813,-547,-159,-722,-850,-1190,-1177
+M20902_at,506,142,335,220,372,174,230,854,259,235,262,139,279,263,235,369,304,454,118,357,222,126,216,324,633,394,248,298,759,343,1190,1139,2258,961,233,179,289,764
+M20919_at,-178,-49,-107,-260,-94,-113,-147,-238,-99,-71,-131,-113,-109,-120,-68,-178,-173,-100,-100,-66,-76,-116,-210,-152,-56,-122,-208,-148,-204,-103,16,-105,-46,-83,-131,-184,-129,9
+M21005_at,147,1858,862,-50,1023,848,-299,-131,976,1099,99,2233,95,1654,77,129,-391,100,222,363,-14,-173,556,156,-76,400,79,414,4,10610,3234,-136,383,681,4129,998,1721,6421
+M21056_at,-236,-150,-173,-252,-46,-369,-327,-395,-213,-205,-186,-194,-245,-179,-133,-179,277,-206,-151,-92,-52,-205,-89,-234,-166,-66,-395,-224,-298,-371,-231,-322,-304,-79,-308,-431,-346,-299
+M21121_at,148,276,378,73,361,160,154,649,327,130,-50,107,215,82,311,120,246,214,-82,154,-114,253,112,247,214,252,120,930,293,1225,222,183,161,604,3278,431,152,271
+M21154_at,283,752,517,313,590,355,243,568,732,512,851,234,613,436,433,319,1503,382,559,894,520,465,488,590,419,235,384,1217,254,440,621,1085,1544,484,787,534,1508,731
+M21186_at,6312,4497,1397,7723,10675,1657,6601,2223,2593,2776,796,5458,8259,4217,11103,9569,11403,1535,7217,12317,-61,7434,528,7251,4692,6827,2722,7642,4881,15057,7895,743,3701,5297,12304,13685,5904,3416
+M21188_at,-52,49,150,-56,62,12,28,100,37,21,36,-5,-52,15,59,49,-94,-35,-2,34,14,56,36,45,41,3,86,-1,-69,91,60,66,42,-9,23,41,25,23
+M21259_at,1716,2421,3334,2284,3467,1435,1330,1895,3791,2337,3387,1158,1918,2747,3257,2795,2525,1517,2120,6651,6084,2078,1662,3034,1789,1720,1351,1642,1344,1213,1410,1570,2104,2056,1528,1429,1226,1058
+M21389_at,-442,132,-44,-101,123,-24,-312,238,-417,171,-532,0,225,120,175,316,220,-166,202,220,94,-154,-254,-307,-303,300,136,-225,-141,-362,-54,-57,-379,86,147,398,-38,-471
+M21494_at,-96,50,366,-188,45,-492,-191,-242,19,128,6,-130,104,-89,-63,50,248,264,77,-12,-177,-73,-26,57,41,118,-23,-206,-305,342,-809,-158,-22,138,237,-357,-603,-2
+M21551_rna1_at,178,336,345,374,321,44,359,364,333,271,267,-12,268,-40,64,160,363,333,279,117,152,265,-47,392,305,330,64,405,327,485,415,582,456,259,487,554,462,672
+M21574_at,75,53,-234,152,30,117,42,22,-116,184,79,86,-115,-40,-126,230,43,-30,124,2821,39,215,127,-61,67,-133,67,-84,-84,-43,174,174,67,121,14,265,178,37
+M21624_at,272,11799,182,11,89,94,-20,202,8426,269,103,24,61,8582,117,45,99,982,172,184,53,75,93,51,121,84,195,39,-79,125,62,173,87,11,55,-27,165,169
+M21812_at,893,622,1180,657,504,524,984,881,758,683,581,524,529,775,458,486,590,578,580,670,319,655,501,687,557,574,890,704,920,982,872,1145,905,358,608,728,1092,1297
+M21904_at,1461,2610,-618,-605,1984,-1424,327,256,1434,1603,821,-740,-657,-1557,-945,-863,616,-679,-797,810,-622,-198,-1472,-314,1102,-430,281,-95,-360,1568,3443,2848,2178,1021,2679,1512,3334,2244
+M21934_at,158,317,448,403,73,7,95,491,330,169,176,109,75,138,80,137,74,118,108,207,-302,168,220,169,162,131,330,255,223,334,264,172,129,57,268,295,267,421
+M21984_at,-454,680,-966,-926,-314,-428,-102,370,-370,-399,-143,-258,-60,-322,-278,-175,-187,-87,-156,-322,-14,-461,402,4,-155,-237,-744,-302,86,-295,78,-321,-196,290,-467,-664,-607,120
+M21985_at,411,217,621,306,230,240,257,421,193,131,144,122,212,260,175,211,429,245,89,335,107,215,353,149,177,196,460,381,305,262,226,324,356,93,270,213,217,283
+M22005_at,-100,-196,-213,-298,-180,-78,-203,-440,-73,-115,-172,-205,-105,-119,-78,-119,-212,-106,-153,-256,-254,-100,-34,-232,-56,-185,-345,-160,-367,-112,-202,-37,-227,-111,-319,-380,-325,-235
+M22092_at,-228,-183,-311,-166,-143,-216,-268,-287,-209,-207,-199,-127,-195,-156,-119,-156,-218,-188,-92,-242,-113,-240,-218,-277,-105,-225,-322,-385,-245,-116,-319,-295,-239,-133,-295,-328,-197,-334
+M22324_at,135,153,108,-47,107,-617,-171,455,-25,-285,56,31,19,106,-137,246,605,187,223,220,-189,143,-322,17,196,70,-910,893,538,386,533,565,837,712,38,-126,470,1719
+M22382_at,1683,1359,1890,2409,3099,1002,1900,1628,2016,2969,1960,1589,3023,3430,3388,2250,5159,2067,1756,7085,5634,919,1166,3983,4728,2121,2400,1634,1647,1279,1164,824,2786,1254,5526,1819,967,911
+M22430_at,417,275,161,225,150,104,117,436,205,198,200,133,179,323,106,63,602,160,232,49,84,185,163,166,369,195,411,56,211,331,309,210,336,-11,308,159,230,222
+M22489_at,106,-101,-119,-55,28,-113,-181,136,-105,-96,-37,370,540,-70,11,481,-98,-42,208,-80,103,-172,3,-81,2366,86,45,-163,-96,-74,-36,-20,-21,6,-93,-112,-25,-135
+M22490_at,1235,639,1520,1154,534,1068,764,1815,736,1289,480,947,431,927,695,871,1462,504,612,806,1030,570,1048,995,1263,970,1320,1224,1144,1042,1170,719,843,671,1060,1096,1399,1065
+M22538_at,704,4107,1010,905,2204,828,793,509,1721,952,1055,787,1647,1389,2337,1118,1980,3069,999,3065,719,844,782,1062,801,797,483,771,646,1249,2878,3480,1292,2136,2120,1164,623,620
+M22632_at,-370,21,-1,-236,470,147,-260,-20,691,543,309,-126,283,189,453,232,-281,279,444,627,302,-218,106,8,-126,-55,-312,-212,-233,5,104,-256,47,25,-6,-141,-277,-301
+M22638_at,552,131,-288,336,677,-26,349,305,-129,-26,-72,44,279,484,994,529,983,10,368,1194,103,-35,20,785,336,793,-53,607,245,177,451,378,393,696,216,134,247,157
+M22760_at,625,1594,1257,1122,2318,830,660,538,2175,1237,1528,827,859,2067,1998,982,1500,1790,695,2264,3610,604,824,1895,1023,955,341,1295,632,1396,678,707,1194,1224,1731,1421,1005,412
+M22877_at,275,557,585,244,941,195,278,344,734,402,504,148,330,452,335,286,309,159,258,882,338,133,328,602,276,225,276,305,223,267,227,130,575,182,301,163,227,334
+M22898_at,474,339,650,613,873,332,552,239,770,705,110,201,1465,990,915,484,1040,241,452,1872,409,-88,229,899,281,624,618,309,286,237,55,-13,437,107,122,257,199,-15
+M22919_rna2_at,332,1754,588,161,543,378,260,-53,1397,393,523,573,355,378,218,385,22,92,-178,330,68,962,423,449,1073,651,-305,951,1346,711,55,845,1073,422,1072,332,630,-168
+M22960_at,330,811,212,584,1018,206,655,-187,1176,100,164,446,196,1216,664,295,1080,327,228,1475,449,130,131,534,271,305,251,2501,1885,3927,1916,456,866,1092,4079,2179,1571,702
+M22976_at,369,379,578,487,436,232,485,443,699,304,338,123,863,148,1026,471,488,416,482,498,167,351,511,742,214,402,528,408,396,194,341,422,528,238,195,345,337,533
+M22995_at,424,609,214,245,559,58,176,182,409,154,179,91,359,334,273,431,892,836,255,471,369,58,9,276,141,187,186,238,233,283,323,183,411,384,423,95,291,430
+M23114_at,277,358,175,246,677,64,297,332,520,358,592,153,603,393,435,468,829,254,384,916,133,251,193,407,138,295,101,198,45,664,321,714,823,30,1052,265,297,641
+M23161_at,471,282,424,319,498,193,378,359,442,146,372,117,357,262,354,372,304,184,335,626,318,204,113,525,206,249,201,206,201,294,139,207,253,150,195,142,252,305
+M23197_at,261,101,309,288,395,58,84,251,155,167,140,287,152,145,81,202,286,141,155,180,139,124,108,102,203,128,84,1450,781,970,408,275,316,555,1130,1338,774,443
+M23254_at,775,553,1199,688,798,718,625,1200,1207,573,437,620,782,1819,361,433,652,521,378,1240,754,525,693,529,511,313,669,727,620,2222,1604,893,982,454,3225,953,1194,2041
+M23294_at,162,39,-52,503,654,3,445,-95,216,-67,-98,235,475,28,1167,55,572,181,711,1728,484,159,-32,1180,194,325,-167,63,-43,1929,442,205,94,130,1862,183,382,81
+M23379_at,272,-25,183,515,419,87,505,262,214,73,-19,-35,302,294,446,547,124,190,415,779,643,13,72,578,132,147,159,121,-7,95,-49,-5,98,-1,10,188,247,94
+M23533_at,-73,-369,-131,-204,-56,-272,-547,-548,-13,-193,61,-152,-86,-179,-230,-50,-836,-68,-217,-1419,-547,-179,-123,-144,-324,-18,-1525,-455,-353,-202,-385,-333,-288,-78,-403,-477,-503,-312
+M23613_at,9459,6073,12044,10292,12619,8241,7522,5162,14825,12022,11496,6711,7346,12217,13437,11935,6735,12231,15891,15987,17810,7746,9529,11729,6823,11032,10450,10453,6052,5878,5966,5310,11524,7992,9249,6758,7874,6366
+M23668_at,107,-32,111,-249,32,-158,139,-151,61,100,139,-102,88,-58,-28,157,-102,118,161,112,88,129,-91,14,-50,83,114,135,127,120,-118,-364,139,54,-154,61,245,153
+M24194_at,16944,14183,19370,20411,19924,19403,16666,19283,19459,23122,20742,15345,18349,20225,18596,22066,14005,24724,25926,17601,22233,21143,19002,18221,17281,21408,25800,19381,17933,16961,19774,21444,18678,22366,18294,22570,19255,19132
+M24248_at,1306,948,1884,1145,881,768,2075,1239,1086,1015,578,412,930,625,422,1238,613,1195,1440,2661,820,872,685,1072,1150,1198,1693,1472,1149,1206,1721,2369,1333,274,1114,1126,1186,3504
+M24351_cds2_at,-65,97,145,144,5,176,189,43,237,27,-2,38,-4,139,-1,141,18,16,108,28,39,-11,218,160,33,-21,192,144,-12,-28,126,116,3,85,209,160,110,131
+M24364_at,28,22,-20,0,19,-1,120,86,55,-1,8,-8,8,-39,-19,56,16,72,54,3,9,-30,-22,104,-18,-80,9,-15,-7,29,69,112,-13,33,-7,87,-23,63
+M24398_at,166,-416,-167,-1071,5,-693,-1253,-1739,1338,338,-179,-104,338,-1142,-262,19,-2399,-167,-104,-1538,86,-210,-1164,196,-224,421,-956,-861,-363,-1072,-839,350,-481,102,-1607,-884,-231,-905
+M24400_at,-173,-156,-312,-242,-77,-211,-206,-319,-245,-154,-246,-191,-125,-116,-290,-230,-493,-128,-274,-565,-144,-109,-254,-131,-181,-333,-298,-336,81,-43,-116,-29,-97,-78,-244,26,326,337
+M24439_at,444,1243,642,1028,223,579,280,1455,575,701,393,290,170,428,321,371,833,231,331,730,727,41,440,1286,713,241,292,872,1043,195,557,292,636,535,1032,1032,603,500
+M24461_at,126,156,78,79,-42,96,107,223,90,64,-28,11,-15,18,18,133,-107,130,18,44,-16,125,144,128,48,95,262,-7,-12,-29,-52,-104,133,0,283,-39,122,92
+M24470_at,441,237,525,287,199,291,688,1001,479,252,310,171,127,298,176,352,234,332,357,507,216,470,490,306,503,367,647,393,661,424,925,1245,521,464,239,224,563,683
+M24594_at,43,160,346,89,16,-94,25,83,321,96,124,51,70,116,-12,-15,375,110,20,1309,42,119,81,13,348,112,78,-56,144,419,1871,252,96,-43,156,64,48,1652
+M24899_at,-1091,-735,-1398,-974,-237,-638,-667,-1620,-819,-519,-415,-475,-559,-523,-217,-283,412,-663,-23,636,-73,-857,-609,-283,-406,-382,-951,-731,-726,-675,-810,-839,-698,-420,-359,-1215,-580,-1234
+M24902_at,5,56,-53,17,61,8,23,-59,0,24,32,4,-2,27,23,22,-111,20,41,57,43,-13,55,200,-31,40,46,28,33,128,5,42,0,59,77,30,19,65
+M25077_at,-96,122,36,260,67,179,-137,44,-36,-59,63,56,73,-14,237,-13,-295,-41,-143,167,214,23,53,131,23,27,-153,-44,-76,-2,1359,675,-71,880,-5,120,96,-281
+M25164_at,355,128,384,224,251,62,292,367,200,96,152,160,219,66,73,237,37,245,261,224,89,180,138,204,106,232,233,84,115,305,141,311,352,110,140,74,242,195
+M25269_at,376,184,683,414,335,432,453,484,457,297,259,301,289,359,229,221,771,144,249,169,122,589,459,358,249,249,312,364,379,337,508,373,489,238,462,397,259,382
+M25280_at,670,8521,3569,466,523,1322,848,1964,3371,1308,738,1465,195,2823,1159,990,15848,409,441,660,156,-49,117,268,1089,1496,320,1916,1644,2491,423,700,291,1240,551,595,6663,589
+M25322_at,257,159,112,126,185,42,104,28,135,54,52,113,162,154,89,219,261,99,110,-11,66,86,-22,68,59,203,339,322,134,186,165,160,351,142,179,125,201,227
+M25393_at,139,24,68,85,80,17,58,32,113,66,103,12,79,62,28,32,88,-16,36,79,76,60,66,123,-17,30,45,15,2,64,79,78,96,178,34,31,25,86
+M25629_at,139,87,109,11,63,7,38,121,12,66,-22,80,94,1,67,275,-16,277,-9,80,-23,109,102,123,88,99,-100,56,28,293,112,174,159,13,61,17,102,48
+M25753_at,265,21,240,297,287,80,107,199,221,95,175,-20,236,127,260,55,152,294,123,171,132,126,140,191,10,66,125,23,165,180,190,175,84,142,33,68,132,193
+M25756_at,119,74,45,73,119,71,28,79,128,49,116,103,56,89,38,70,49,125,65,-12,9,26,-20,95,150,59,86,23,-24,21,67,117,55,87,135,36,97,89
+M25809_at,274,343,128,385,212,264,23,128,607,297,137,334,-69,332,111,444,334,-7,242,318,304,145,340,103,401,212,291,458,620,162,402,733,554,203,196,375,569,891
+M25897_at,40,192,7,-58,119,-5,-94,17,5,-19,7,-11,-23,-6,-11,-95,-50,1,-18,-53,-46,2,24,-18,-58,-36,21,371,-100,258,3263,59,403,82,62,11,61,5
+M26061_at,64,76,281,100,72,-8,21,136,51,210,137,84,46,40,22,99,97,152,84,-52,144,146,134,224,17,57,226,139,129,50,210,147,52,57,-34,125,73,299
+M26062_at,-308,-124,-457,-383,-210,-106,-411,-230,-235,-176,-51,-390,-179,79,-300,39,-630,232,-132,-386,-8,-173,-165,-252,-292,-363,-580,-322,-50,-305,-542,-261,-235,-217,174,-211,-382,-8
+M26167_rna1_at,-17,32,2,-27,-29,23,-52,74,12,8,34,-17,3,21,-1,23,-47,-4,-13,17,24,13,5,-44,-32,29,28,-21,2,-21,37,9,-2,-7,17,-64,-52,9
+M26576_cds2_at,723,297,455,326,166,380,253,815,259,316,148,176,297,475,97,301,417,338,205,375,349,317,300,242,352,335,499,493,495,325,362,345,304,142,651,379,401,581
+M26602_at,-272,-194,-79,-300,-157,-202,-253,-272,-130,352,-184,349,-106,-169,-190,-264,-6,-143,-202,-256,-154,-129,-138,-32,-219,68,-438,760,-194,1563,-103,-360,-265,996,109,53,-154,4476
+M26679_at,-135,-48,-142,75,-87,-80,220,-50,-87,-24,-63,-79,-55,-57,-3,-42,0,-21,-19,-10,-38,-53,-5,323,-97,-28,35,86,-139,71,66,55,-32,384,128,286,247,-33
+M26682_at,-61,121,-33,170,168,337,283,0,408,57,195,238,305,344,282,100,115,26,136,507,144,-32,277,125,-16,59,-225,352,153,396,295,401,-85,355,313,-17,32,98
+M26683_at,395,315,512,355,239,455,604,608,330,196,336,314,265,263,260,379,647,277,346,328,223,402,419,346,367,321,389,516,428,535,430,396,407,213,437,461,584,729
+M26880_at,6594,10565,6969,2606,2716,3769,4891,7652,7799,4216,8740,4291,5386,4006,4326,4891,10093,4957,3131,13156,11336,6327,4443,4840,9570,8893,4047,7102,5076,7473,5120,5078,6999,3525,9141,4223,6259,6621
+M27160_at,236,167,323,177,-70,-48,99,-71,195,144,180,183,175,133,70,212,348,135,108,136,-151,139,203,-1,169,158,-104,73,168,180,-147,-3,89,10,44,192,235,221
+M27161_at,391,287,158,-280,81,53,411,259,419,187,-73,120,185,62,110,149,222,273,92,293,134,160,24,-70,131,-122,12,343,283,146,31,147,-72,-101,622,121,10,112
+M27281_at,-85,128,-29,109,-42,-33,13,34,-36,-44,43,20,-53,21,-5,-36,86,-39,-59,-123,89,-36,-62,-104,-67,-56,-183,48,151,68,80,27,151,33,100,-20,-63,159
+M27288_at,-1173,-278,-2052,-2066,-409,-1522,-2051,-2025,-1013,-539,-1146,-1076,-397,-1382,-276,-963,-1860,-672,-734,-779,-492,-1489,-1012,-570,-381,-629,-930,-884,-1305,-1412,-1721,-1481,-167,-335,-714,-1703,-1185,533
+M27492_at,-27,11,-26,-127,65,42,151,89,11,18,-48,14,11,226,109,163,-25,-17,-73,134,59,-102,-218,105,162,30,46,153,-21,3,156,24,21,38,6,-35,38,278
+M27543_at,95,101,122,59,165,39,26,92,136,53,124,60,122,78,98,70,85,98,65,182,93,62,81,145,53,141,148,62,67,214,105,57,119,71,91,40,81,42
+M27819_at,41,45,-34,-57,149,-69,35,233,64,138,41,-107,86,-5,61,89,60,128,121,266,38,167,32,131,346,111,62,96,492,-43,1485,1768,287,410,120,15,13,508
+M27826_at,23,-190,-481,-265,1,-398,398,-935,-308,114,-373,-68,-147,-32,224,461,-427,384,-260,738,398,24,-385,71,-275,609,409,-518,105,-334,-180,-114,-27,-37,-202,28,-133,-561
+M27878_at,-23,-87,-22,-28,34,-101,-5,-14,47,-143,20,-70,57,-57,20,-48,-133,-54,-1,39,0,0,39,2,-70,-107,-220,-92,-64,-171,17,-86,-28,55,-56,-27,5,-5
+M27891_at,303,1358,254,-304,-86,1168,-233,-247,336,498,-376,107,-97,820,76,36,375,22,-180,205,-124,-102,425,-205,-229,66,34,1537,1481,17863,13296,1661,1073,6962,14555,7238,12339,3654
+M28209_at,472,564,479,357,517,158,295,223,333,285,464,275,334,324,423,341,511,346,267,506,108,461,214,300,220,197,253,452,175,824,867,849,621,348,859,468,590,652
+M28210_at,-592,-300,-580,-1422,-183,-485,-722,-784,-481,-392,-276,-510,-337,-428,-377,-476,-555,-615,-132,-750,-368,-400,-545,-253,-198,-316,-1290,-404,-942,-428,-307,-309,-345,-508,-317,-778,-376,-517
+M28211_at,-126,50,70,-174,222,-103,-173,-256,387,55,187,-262,32,1,156,8,107,-38,-73,202,-127,211,-115,93,-115,-129,42,-111,-358,-88,-193,-109,-15,102,184,-81,81,-198
+M28212_at,190,84,142,102,199,23,188,122,190,119,118,133,121,85,146,76,158,65,53,158,24,79,5,157,54,61,54,3,98,126,74,128,162,151,109,166,195,227
+M28214_at,-258,-302,-358,-546,-137,-529,-510,-412,-339,-233,-259,-264,-137,-328,-190,-182,-80,-204,-312,-198,-183,-268,-283,-169,-219,-136,-214,-327,-425,-361,-694,-457,-289,-211,-427,-542,-645,-467
+M28215_at,207,245,242,147,87,67,225,239,183,282,178,93,189,176,144,212,307,79,189,210,76,105,102,172,-8,34,267,54,100,192,338,130,173,340,178,248,172,224
+M28219_at,-69,-40,-348,-276,-79,-16,-230,-725,-214,-82,-277,-51,-58,-114,-151,-44,-48,-100,-57,-198,-184,-34,-144,-35,-169,-197,-384,-141,-351,-809,-262,-214,-111,-81,-110,-175,-273,-50
+M28249_at,118,36,35,78,174,44,109,76,61,-22,-83,-10,30,14,-23,-38,-30,0,65,-4,2,91,94,-72,-1,-43,-79,51,-9,-79,16,35,84,54,11,17,-4,67
+M28713_at,923,1333,919,271,756,627,601,329,970,746,749,370,701,935,875,576,593,612,690,1525,884,596,319,773,391,685,496,785,384,1182,1428,1358,1215,619,1297,824,1996,1291
+M28825_at,553,359,783,-123,-71,-7,208,646,551,-10,489,155,146,314,27,100,134,200,22,-214,103,630,6075,162,484,114,333,587,509,117,576,9,529,18,-61,597,93,487
+M28826_at,-20,-84,8786,-62,-46,4957,42,-32,818,4255,2502,-5,-175,7,-60,-57,-4,-84,-23,-146,-3,-99,6583,-283,-170,-70,-123,-142,-40,-100,-54,-21,-95,-53,28,75,-18,87
+M28827_at,-331,-388,-880,-532,-198,-160,-383,-751,-264,-410,-333,107,-165,-289,-261,-354,-340,-237,-200,-225,-176,-239,-169,-201,759,-320,-751,-406,-348,-444,-393,-326,-580,-91,-455,-483,18,-758
+M28879_at,143,244,401,229,86,167,225,298,431,339,215,215,153,138,140,195,87,60,154,154,196,41,186,239,124,222,330,249,177,110,360,135,214,22,173,173,396,438
+M28983_at,180,180,337,103,134,188,181,274,160,224,155,150,206,149,142,145,145,103,102,208,123,100,131,217,141,168,298,267,192,215,151,125,211,111,189,190,160,272
+M29064_at,1513,2221,2239,1235,2008,1515,1450,1185,2347,2095,1388,911,3014,1858,2533,1977,3582,838,1503,4536,2601,244,1195,2688,1322,1645,1411,1182,1065,1787,657,631,1084,833,1409,969,1381,774
+M29194_at,-30,27,68,-6,-46,120,-70,-202,-47,-115,-61,-57,-136,-26,186,15,113,-187,-56,48,92,-86,-87,21,-92,-68,-115,-185,-139,-158,-114,-132,-120,-38,-121,-155,-154,-142
+M29204_at,178,239,278,130,156,238,164,250,322,124,179,126,204,432,171,464,426,131,334,543,455,171,229,196,195,297,206,305,199,209,189,151,213,34,92,207,249,281
+M29273_at,248,186,180,607,173,213,176,166,65,231,313,135,185,48,125,405,-77,334,209,23,248,260,39,307,122,139,541,410,379,349,36,194,246,181,128,351,163,344
+M29458_at,82,38,37,63,1,65,-57,100,33,89,-9,10,3,50,-3,30,21,46,56,-3,-27,19,24,16,35,21,161,151,79,-10,95,3,66,-18,53,54,81,106
+M29474_at,2187,6,5,123,95,51,221,85,-4,-35,-124,-80,351,-146,726,643,-260,-32,184,1762,11,23,66,48,18,111,70,-162,-24,-88,-93,-51,-64,2,-57,-61,18,15
+M29536_at,856,856,1186,1179,1496,608,814,755,1405,1029,801,434,895,1203,1786,1173,1465,1180,1095,2689,1661,549,594,907,947,654,849,508,509,586,840,712,590,524,919,631,750,843
+M29540_at,76,0,139,-30,138,-28,-136,-239,-46,60,-23,43,55,-2,34,18,197,21,-69,223,89,45,45,11,-26,47,29,-165,-91,-118,-118,-75,-96,-66,3,-73,-51,-157
+M29550_at,287,39,364,252,205,49,236,367,298,140,-1,18,73,175,101,184,274,123,147,237,118,241,41,170,147,177,339,191,206,110,204,240,59,75,180,162,110,232
+M29551_at,190,83,125,219,473,56,117,-119,137,10,-69,-10,491,100,457,196,166,114,257,478,167,-99,43,410,77,293,46,31,69,-113,-66,-95,-85,85,21,13,-44,-288
+M29580_at,-284,-192,-238,-186,-66,-24,-247,-130,7,0,-92,-192,35,-147,-48,-59,-74,-74,-32,-110,14,-61,-281,-237,-192,-148,-231,-31,-64,-176,-164,-90,-207,-22,-281,-98,-108,-79
+M29581_at,739,623,857,662,527,337,655,691,604,400,592,330,551,488,463,471,564,444,417,824,331,614,324,553,518,497,959,753,541,603,593,697,628,356,821,580,746,865
+M29696_at,3863,511,1952,6127,2547,1804,1129,1412,5817,769,1704,363,1515,3854,4436,2206,754,27,473,4409,1536,678,2103,1478,5653,2281,503,517,459,268,607,448,485,185,281,444,438,1068
+M29877_at,2987,130,303,345,502,257,494,253,293,279,610,132,894,336,610,271,568,553,348,898,515,481,155,542,200,386,352,347,420,300,240,407,185,275,507,574,645,230
+M29927_at,-21,238,333,7,378,24,126,28,125,157,173,57,615,458,442,-13,616,-46,86,710,460,-6,-3,-55,232,6,84,227,396,317,540,980,865,387,266,273,145,635
+M29960_at,296,95,190,269,212,177,235,70,131,198,281,189,144,260,301,200,146,159,204,294,264,176,167,221,52,67,104,284,146,116,161,175,150,145,89,113,274,38
+M29971_at,140,49,278,171,618,90,131,-95,342,113,74,28,221,5,555,227,53,115,171,575,113,197,144,365,339,698,9,98,194,63,-11,0,189,-38,-4,-121,-20,-154
+M30135_at,-241,-187,-361,-305,-206,-144,-273,-404,-224,-179,-186,-172,-186,-263,-120,-292,-311,-176,-187,-246,-193,-103,-222,-293,-217,-163,-388,-203,-293,-287,-371,-292,-272,-62,-176,-197,-366,-381
+M30185_at,201,76,203,107,62,-5,82,118,58,31,168,76,75,178,-152,-151,63,730,38,267,146,252,169,170,168,121,-90,115,74,317,165,167,108,141,-54,53,88,292
+M30269_at,206,193,303,-4,376,40,129,2,254,83,186,110,133,166,148,169,332,205,3,32,144,196,212,47,188,92,245,225,216,486,161,51,198,46,422,249,118,577
+M30496_at,97,224,232,189,342,42,154,17,233,85,185,33,74,336,330,183,-75,53,161,485,276,124,56,351,92,100,68,112,2,124,146,79,102,189,129,95,140,42
+M30773_at,-23,-4,74,-6,41,-46,13,-61,83,30,-16,31,52,25,42,-3,56,52,18,100,43,35,75,27,-1,3,79,8,12,38,33,70,14,-14,69,24,-18,28
+M30818_at,586,273,429,261,159,362,344,352,1322,178,350,171,325,383,99,250,113,143,216,1099,163,172,239,251,652,225,330,510,471,500,865,298,261,2,307,177,192,1844
+M30894_at,189,5569,1367,355,687,371,369,196,2827,502,178,350,202,10298,190,305,1272,28,208,182,138,95,284,799,281,114,225,693,456,578,338,1575,1419,1330,813,4376,265,2513
+M30938_at,1338,1230,2756,457,1917,1529,917,1089,2910,654,530,247,2141,1092,1321,1581,1692,837,802,4392,578,329,651,2298,563,780,661,641,723,547,747,716,895,387,423,920,485,803
+M31013_at,2676,2983,2172,2167,3648,1817,3703,1012,4193,1562,1825,1214,3047,2695,2638,1794,2407,2544,2095,3655,2800,1195,894,6132,1089,2474,1275,2055,1464,4737,1694,857,3711,1767,3971,3404,3170,1954
+M31153_at,-835,-409,-897,-316,-192,-785,-826,-1236,-794,-578,-631,-594,-382,-656,-485,-410,-1335,-554,-356,-648,-432,-609,-630,-582,-720,-572,-1084,-806,-764,-866,-444,-898,-719,-459,-872,-902,-1107,-1108
+M31158_at,296,157,214,87,79,94,13,125,97,109,42,171,441,116,140,66,54,128,75,138,13,103,151,58,237,47,139,168,163,246,455,420,323,298,556,224,173,219
+M31165_at,-13,33,183,62,30,74,-236,89,-7,39,-9,67,60,69,46,-25,76,20,50,69,31,92,9,72,93,50,103,83,88,358,55,-14,64,33,-22,66,78,185
+M31166_at,31,76,42,71,15,30,48,-22,20,45,16,70,-3,35,40,48,20,58,37,17,38,65,43,-19,74,29,31,198,-7,1851,451,260,312,115,712,91,174,512
+M31210_at,8,428,206,-11,-18,30,-52,-70,109,160,16,10,-2,189,60,17,47,58,-14,148,-56,107,-30,-4,43,60,-21,-49,-115,-67,17,-31,-17,1,-22,19,-11,-21
+M31303_rna1_at,3828,3021,7247,3780,3563,4890,3330,4213,7230,5052,3352,2290,4751,2346,3347,3207,6633,2143,2291,5933,2306,2131,4677,3182,2910,2648,2818,1647,2195,1885,1359,1291,2176,1486,730,3719,1985,1528
+M31328_at,888,429,1148,581,416,650,488,1060,815,724,559,291,623,592,319,788,723,499,509,570,422,584,708,487,493,644,1262,732,959,689,589,641,656,185,460,630,795,1077
+M31520_at,14924,18002,15290,17099,16011,8759,11004,15988,15834,12111,15533,12393,15036,19190,15093,16567,19793,15774,13578,17903,17917,16160,13726,15763,18816,15988,18569,19696,19109,15456,17814,19931,18030,14657,17670,14219,15815,18809
+M31525_at,1705,805,1196,1376,1272,817,1038,1439,1087,789,814,768,1248,1052,1293,1280,1198,1102,863,1973,678,1075,1071,1397,1182,988,968,1205,1029,1160,1044,722,1369,496,1073,1186,1318,1313
+M31606_at,-1096,-910,-1635,-1562,-710,-769,-687,-1890,-913,-769,-728,-891,-719,-739,-628,-1081,-1302,-878,-854,-1484,-317,-1557,-1075,-359,-814,-590,-2076,-808,-567,-1323,-1520,-1205,-1441,-616,-1443,-1054,-1248,-1885
+M31627_at,4971,8389,401,3377,4676,282,1604,2826,1910,946,1945,1470,8350,576,2955,1940,8972,1168,4430,5282,943,2040,207,3308,5754,4903,763,2651,937,2655,1505,1778,1335,1930,3287,3761,940,2211
+M31642_at,999,550,1110,904,1352,505,690,241,1608,1251,940,643,1567,562,1254,551,1367,933,483,1149,1096,249,486,1125,485,613,344,680,425,736,578,475,823,518,692,466,393,849
+M31651_at,196,37,320,87,29,133,90,199,60,35,146,61,-55,-39,-57,-26,33,32,-14,-62,324,70,161,51,170,132,120,8,103,95,43,37,71,-35,105,-88,62,157
+M31659_at,169,19,212,89,63,65,119,116,139,62,117,68,107,107,84,65,37,97,44,65,111,103,167,58,122,67,115,102,144,75,173,141,120,35,28,104,131,155
+M31661_at,-38,184,-63,-171,-36,-46,-67,-55,-31,-66,-70,-44,-60,-64,-47,-129,-149,-40,-84,-105,-49,-129,-58,-112,-23,-36,-37,-28,-57,3,-40,-104,-34,-51,-177,-141,-53,-52
+M31682_at,-1109,-699,-1338,-982,-613,-620,-856,-1136,-1073,-677,-563,-350,-597,-717,-513,-660,-999,-410,-678,-711,-578,-200,-678,-572,-611,-528,-1017,-728,-642,-1056,-1031,-792,-703,-462,-682,-939,-1153,-1309
+M31899_at,339,261,339,192,400,195,238,221,323,148,461,34,341,179,457,269,222,130,108,585,267,223,267,431,130,169,10,119,192,14,96,314,184,182,-63,5,142,2
+M31951_at,-859,-570,-954,-828,-261,-631,-838,-748,-968,-544,-527,-323,-352,-154,-254,-643,-663,-819,-449,-385,-127,-810,-628,-738,-379,-802,-594,-563,-637,-1001,-720,-774,-672,-443,-1051,-711,-880,-955
+M31994_at,428,313,473,316,222,103,450,227,311,283,224,68,193,252,196,165,337,236,187,208,133,311,256,307,282,372,467,354,336,390,723,505,356,1162,300,325,645,581
+M32011_at,652,135,134,296,160,-26,94,317,68,250,18,146,315,553,308,293,157,667,215,140,79,142,220,153,149,628,273,378,262,2450,357,12,181,135,1053,-54,202,577
+M32053_at,-60,3919,185,-19,399,-67,-11,-53,165,165,-41,-14,-119,107,-16,46,246,232,99,163,-73,0,55,122,76,14,219,503,151,128,282,181,244,26,240,-39,-32,288
+M32313_at,679,306,291,183,528,211,327,575,379,411,369,202,467,581,297,307,465,192,265,560,439,337,169,554,232,473,145,257,175,505,129,133,450,194,349,231,514,532
+M32315_at,752,691,761,621,474,725,772,340,555,394,358,602,702,567,483,326,463,396,660,321,439,385,471,483,596,931,603,534,396,1633,1769,379,835,672,1074,643,722,3371
+M32334_at,995,562,1581,886,1022,931,502,475,2634,1155,591,140,841,1934,1286,2453,707,144,601,1319,101,107,355,1200,348,1140,710,929,286,642,239,-2,434,74,577,366,425,524
+M32373_at,96,59,87,39,3,112,184,-52,89,78,83,51,-6,65,15,17,204,64,64,151,31,81,94,138,39,43,167,200,84,40,-79,51,37,121,14,109,-349,20
+M32402_at,-108,-164,-218,-35,-48,-21,-38,-388,-102,-172,-83,-136,-112,-137,-50,-42,-68,-142,-104,-109,-36,-45,32,-113,-141,-94,-328,-193,-153,-196,-242,-45,-133,-81,-138,-65,-144,-307
+M32405_at,6163,4830,6855,7942,8221,9394,6321,6499,8207,7419,8492,11768,6839,4844,9251,6595,3959,6315,8312,8338,11735,4416,7358,7415,8100,7582,4622,6615,7206,8037,8682,7628,6291,10267,4124,9645,6734,6644
+M32598_at,4,81,141,-94,55,-28,5,28,134,55,121,120,86,42,167,7,56,97,74,-49,-87,105,178,-10,208,135,-100,88,-12,15,128,136,173,15,-13,-147,59,106
+M32639_at,-94,-42,-46,-95,-14,-53,-142,-62,-148,-65,-27,-60,-64,0,-58,-63,-79,-135,-33,-68,-52,15,-81,-175,-130,-164,-18,-25,-98,-101,-47,-122,-88,-86,-51,-96,-225,-49
+M32886_at,236,251,75,185,275,-35,57,13,250,225,84,152,376,761,275,385,627,890,91,551,525,105,123,304,204,188,137,216,139,241,308,265,232,298,345,266,223,129
+M33195_at,98,822,223,109,409,264,5,-169,320,128,-1,524,-4,1361,132,90,184,35,-23,123,530,60,-30,6,-12,56,68,714,351,5095,2244,32,301,591,4073,889,2058,1011
+M33308_at,803,570,360,538,1019,302,366,547,382,192,55,847,632,791,630,993,1821,142,409,461,147,408,125,383,671,269,280,603,812,463,983,753,730,808,357,499,991,1017
+M33336_at,1801,781,1163,1192,2206,442,976,1286,1432,363,511,209,1781,1585,1685,1800,2754,1248,601,3971,497,1167,269,1597,653,720,747,519,262,500,187,171,341,654,540,651,956,481
+M33374_at,-255,-220,-132,-261,177,-96,-373,-524,-133,44,-8,-12,14,-143,167,93,-654,-176,-83,220,-12,-338,-186,93,-117,42,-461,-228,-254,-263,-394,-460,-417,30,-285,-223,-216,-632
+M33478_at,102,10,-6,-13,34,71,-30,77,52,27,-1,12,28,0,41,39,54,33,14,3,29,30,68,46,48,-4,62,52,-16,71,19,42,-12,17,36,36,95,98
+M33518_at,555,463,550,147,491,673,786,535,814,508,742,-12,1222,604,917,612,1584,191,417,407,256,292,613,919,347,584,68,658,423,571,425,620,610,254,233,638,985,623
+M33521_at,1516,1048,1489,797,1545,1004,1097,1401,1951,853,1794,377,2920,901,1526,1397,1920,758,685,3813,361,829,934,1517,700,1609,1092,1027,531,1241,953,997,848,697,1057,1177,1340,826
+M33552_at,635,2673,644,-7,1522,736,208,418,714,434,224,1560,2787,4649,1447,1694,4340,3168,292,977,62,-78,216,253,1546,1071,558,714,1817,1671,1192,351,2992,881,536,2435,4728,1927
+M33653_at,-41,-239,-286,-157,-200,-94,-154,-229,-148,-37,-117,-91,-128,-14,-90,-258,-213,-147,-195,-318,-27,-103,-150,-120,-191,-123,-200,-106,-110,-189,-212,-253,-177,-133,-167,-151,-281,-212
+M33680_at,5565,5318,2584,11689,10308,2647,9428,4742,5522,3093,4194,4101,7747,3076,10614,6737,4371,3990,4553,12747,11199,7910,4316,14682,3233,5779,7410,1467,1639,2040,2840,3589,3768,947,4576,2584,6414,3197
+M33764_at,2120,6041,3647,3078,3057,4073,2599,1715,3819,7913,1760,1767,1721,2630,4189,1984,3097,2080,2222,5396,5024,11077,3068,2840,2285,2433,2686,2756,1829,2494,3607,6272,2573,1324,3856,2733,2486,2730
+M33882_at,-158,607,-153,-171,21,-222,-332,7,192,357,-9,123,756,-48,258,97,0,-191,331,3849,-313,517,39,90,6639,-637,267,-586,-817,174,2401,193,198,231,2,317,434,5635
+M33987_at,199,87,142,13,7,69,124,67,172,129,88,53,119,127,50,38,92,100,16,159,67,35,77,91,107,117,122,106,153,97,6,85,149,69,51,130,117,268
+M34041_at,219,524,57,-158,-19,156,522,326,-321,-190,201,90,611,-10,580,212,410,643,345,326,56,125,127,240,461,556,-424,593,370,293,852,1107,611,356,-700,236,402,589
+M34057_at,-101,-61,-112,-123,90,-23,-95,-68,-65,-176,-17,-66,-15,-21,-55,-75,-68,-5,-86,-100,-8,-45,-49,32,-48,-40,-208,122,-91,-95,162,86,-42,126,-58,-176,-92,-156
+M34065_at,42,-22,-49,133,61,35,107,-47,49,-112,0,-96,55,-77,30,-15,-1,106,31,-62,-127,-15,125,7,27,-145,79,-5,-134,149,-96,-45,-27,50,-5,-54,-43,21
+M34079_at,1081,1380,1778,1006,643,1258,1169,670,1377,1478,1023,725,642,936,1093,1022,702,656,957,1591,948,685,896,912,676,979,766,730,764,936,1331,1051,988,611,753,1089,1043,863
+M34175_at,1128,755,1206,642,640,666,796,755,1321,597,662,191,763,807,509,532,912,390,579,1933,372,553,697,749,576,676,743,833,993,776,741,995,833,544,938,919,860,948
+M34181_at,248,223,939,295,992,158,325,244,329,195,195,99,61,504,398,378,996,93,255,977,127,35,132,662,66,202,-81,262,146,45,110,210,233,134,97,268,706,185
+M34182_at,2929,2392,2022,2688,2093,3686,3584,3174,2890,3117,2148,2218,2694,2200,2031,2743,2755,2258,2553,1101,2411,2010,3309,2674,1964,2580,3387,3668,3356,3193,1496,3407,2298,1832,1949,3637,2810,2507
+M34192_at,255,205,224,252,233,113,154,215,255,184,66,107,138,187,233,97,130,147,213,224,116,79,100,257,135,248,275,249,144,200,137,32,212,37,237,253,125,95
+M34309_at,49,34,21,-7,77,110,218,200,103,79,68,4,21,112,17,70,162,28,37,132,12,41,68,133,154,58,81,183,-4,79,39,147,64,13,65,73,122,123
+M34344_at,427,82,72,9,106,-108,-35,-79,-22,26,14,68,98,47,-5,624,189,155,72,769,652,138,159,5,105,348,835,400,341,80,398,162,685,783,88,-19,91,-3
+M34423_at,280,114,233,258,235,94,285,-14,395,48,136,30,270,479,296,253,1043,410,282,272,186,-54,170,252,271,224,192,373,512,715,167,66,208,326,640,483,179,209
+M34455_at,351,261,329,652,316,400,398,395,450,193,245,293,185,313,53,278,643,353,311,355,267,283,579,267,463,283,409,661,365,382,607,134,470,274,272,680,249,543
+M34539_at,1703,1845,339,435,1081,782,537,809,2253,983,1145,393,1249,766,1096,610,1657,699,60,4831,500,185,258,728,1543,1018,-75,289,271,1586,478,58,380,743,1946,1603,1616,-489
+M34667_at,553,382,645,325,260,64,458,586,456,341,296,209,258,547,285,360,726,345,316,414,217,333,558,441,398,361,474,468,406,427,400,557,437,270,335,304,474,523
+M34668_at,58,174,70,172,317,204,267,134,287,71,143,47,411,247,353,359,553,55,164,754,129,126,214,400,122,262,-21,137,-173,69,213,93,97,198,-3,88,168,-84
+M34677_at,687,971,427,-215,154,385,421,433,240,-111,629,51,1194,727,470,86,1425,192,149,922,-49,218,425,752,164,192,-170,-237,649,431,134,591,-1,344,352,706,945,367
+M35128_at,236,604,331,264,67,74,707,508,172,158,281,57,483,263,224,129,626,396,195,790,257,179,-87,283,398,437,788,-126,-33,380,127,364,350,318,418,129,608,611
+M35198_at,210,225,187,139,42,119,247,-62,153,82,98,60,-7,146,99,-17,0,15,-34,28,54,73,28,15,69,-33,222,83,-43,237,110,-143,187,-25,198,120,-15,298
+M35252_at,-6,6,42,13,-79,8,28,-94,-19,33,-55,35,-57,-27,36,-56,-1,8,14,229,-73,-17,34,-51,69,-70,46,20,-9,-74,45,5,-30,-21,-23,19,0,-4
+M35296_at,137,-99,152,-74,335,261,255,-70,395,-47,171,114,61,74,303,14,101,124,4,215,129,115,9,202,227,276,131,255,43,-15,27,102,276,158,147,30,220,360
+M35416_at,119,115,47,172,155,90,-78,230,-1,51,28,38,110,9,147,49,63,83,-25,161,38,34,89,196,76,79,6,143,-33,154,121,29,290,67,154,285,108,104
+M35531_at,244,-194,257,-187,139,181,418,-845,359,324,268,214,60,316,150,293,450,205,-153,199,206,201,110,189,-508,231,691,488,240,310,287,-150,302,209,507,351,380,-150
+M35878_at,527,17,1086,104,130,316,591,878,24,164,41,27,29,82,103,60,428,619,55,299,301,317,165,532,123,390,1020,840,529,164,41,148,77,269,112,558,855,726
+M36067_at,454,238,358,494,134,266,-95,257,630,880,608,377,307,360,677,78,700,305,30,192,88,3,148,388,172,426,120,323,319,424,133,-55,420,243,106,376,46,-159
+M36089_at,235,519,797,785,509,657,994,797,785,687,572,416,609,512,627,561,836,434,605,873,47,493,889,578,500,603,887,772,391,668,977,730,901,363,816,754,928,1048
+M36200_at,305,72,525,255,262,334,294,209,221,166,193,24,153,99,274,147,374,194,145,164,92,232,-45,302,201,144,14,295,298,273,117,320,213,93,284,392,326,467
+M36205_at,-8,109,-378,-354,-24,-597,-421,-220,-287,-114,-110,-287,-116,21,-128,-139,4,-167,-164,-221,26,-248,-227,-63,-153,40,-536,-203,-322,-184,-312,0,-254,-121,-692,-338,-272,-485
+M36341_at,775,954,954,689,835,339,675,614,1045,708,912,321,586,725,715,617,1082,515,650,2581,883,483,522,765,423,284,774,566,745,765,1038,1076,722,952,789,703,537,1355
+M36803_at,-22,68,164,212,29,190,292,-713,-112,183,74,-67,67,36,184,183,-41,-195,-101,-60,-158,57,-13,-57,95,68,-89,46,-312,15,-5,-304,266,27,-55,342,331,-38
+M37033_at,6095,3794,4758,5558,3868,2665,5292,4808,3739,1895,1559,1570,4313,4573,5622,5218,4451,2836,3735,12240,2033,2936,1065,5006,2630,2746,2149,1600,1870,5329,3049,2978,2480,1056,3948,2880,3777,4027
+M37104_at,712,1129,1717,803,1200,928,591,617,1311,1035,924,623,999,1214,1047,977,775,646,657,2055,1532,304,847,896,721,620,610,712,562,896,656,646,772,684,930,1030,854,424
+M37190_at,138,174,262,131,105,69,203,226,170,148,136,37,150,109,107,108,60,117,126,163,113,81,153,122,78,93,267,121,233,239,347,152,257,38,353,258,101,306
+M37197_at,294,376,522,364,526,154,233,131,288,282,157,103,355,212,300,336,290,235,255,427,388,158,26,408,81,169,140,108,170,192,280,327,263,213,155,187,199,291
+M37245_at,480,422,676,422,387,476,764,682,583,555,289,336,399,268,167,414,617,394,323,369,264,306,410,519,232,342,805,825,762,551,502,190,546,205,700,654,407,896
+M37400_at,70,98,-13,57,162,-149,-62,58,130,163,82,73,400,248,274,252,144,185,211,370,468,104,72,162,208,100,62,154,-242,189,104,151,107,123,138,70,145,178
+M37435_at,228,184,270,177,165,709,490,275,113,361,260,237,102,342,102,282,88,205,344,185,547,210,155,563,461,593,283,726,658,598,707,334,1036,623,525,460,395,481
+M37583_at,2030,2741,4260,1886,1977,3279,1376,1304,5366,3168,4218,1733,4231,2226,3327,1260,3065,2090,994,2978,4788,1199,4240,2538,1868,1428,1553,1657,1466,2495,2595,1471,2855,2137,2072,2209,824,1674
+M37721_at,245,124,231,273,255,110,218,442,157,101,132,107,77,129,92,115,315,122,86,437,309,58,195,364,157,207,159,208,346,182,209,166,200,49,202,126,169,210
+M37763_at,11,55,21,114,15,17,-8,205,110,32,66,14,44,61,-12,-5,92,22,-18,-10,3,18,24,133,52,64,18,73,115,104,47,39,61,99,35,-5,-2,50
+M37766_at,703,1781,1357,619,991,58,819,883,2010,902,1035,455,309,1200,2312,1993,2127,5194,380,1363,2411,767,644,1000,603,826,1846,439,759,722,394,392,1362,502,354,597,792,1378
+M37815_cds1_at,-43,53,153,-125,-50,74,-142,-230,128,142,54,-114,-86,91,-33,-39,-15,24,-71,-128,-112,-58,-24,-141,-52,-135,-70,-146,-69,-100,-65,-96,-64,-70,-21,-61,-101,-101
+M37825_at,-57,4,-100,-67,-33,-5,-42,56,-5,-8,-69,-10,19,17,-50,8,-66,-48,-79,-26,68,-64,174,14,-26,-30,20,-135,-14,-89,-84,-21,-77,-21,-27,-24,-93,-66
+M37984_rna1_at,772,833,1182,711,646,490,404,977,797,550,672,363,519,664,498,694,914,608,580,732,404,578,585,661,712,706,810,691,755,858,717,752,908,394,599,253,304,809
+M38591_at,575,223,858,768,3465,392,-169,374,6549,3419,564,-255,-223,1199,0,208,630,288,154,194,-133,-36,393,377,-246,39,829,447,-105,4057,1102,389,217,151,7105,262,634,1614
+M38690_at,405,0,-7,1203,1305,-7,30,1263,31,-8,-14,2043,6413,-53,457,4866,49,-1,4584,926,3461,2713,-66,489,2700,4873,1082,121,-72,17,-18,-70,625,319,18,-69,-96,1615
+M54927_at,30,64,104,15,18,23,72,127,42,65,-9,2,19,-5,23,48,83,68,16,13,-8,30,24,83,-15,-23,73,52,31,-14,28,40,8,-6,48,57,-38,73
+M54951_at,272,134,-213,157,92,277,250,115,71,221,165,68,6,19,105,213,-591,104,134,204,162,209,216,138,105,38,-420,135,50,109,307,90,136,135,185,210,158,260
+M54968_at,149,123,179,112,234,14,122,206,60,194,114,33,85,98,75,151,187,102,68,123,86,87,102,77,-7,124,161,92,14,105,88,130,30,59,95,45,125,136
+M54992_at,392,-116,53,1793,2801,65,1836,20,70,72,31,106,196,0,2182,192,-144,112,134,856,37,247,68,2925,108,175,140,-89,38,-49,-44,-52,89,7,-86,-13,43,142
+M54995_at,81,146,120,66,80,87,55,217,33,15,53,30,17,78,14,11,53,61,37,52,43,73,110,77,17,73,48,742,57,183,3777,167,1055,352,293,185,219,436
+M55040_at,425,318,463,514,331,339,530,625,412,385,301,261,288,371,370,365,404,285,327,349,182,290,302,259,358,296,593,405,557,465,653,680,480,238,546,415,478,696
+M55047_at,251,260,290,347,198,202,458,343,242,286,291,196,230,279,208,344,201,276,213,225,38,207,254,199,60,170,323,151,223,221,249,220,187,149,194,279,282,357
+M55067_at,592,852,345,1625,1234,497,2345,418,429,433,225,445,803,440,1587,1078,109,996,1154,352,228,413,313,1345,394,1470,420,387,343,3029,1060,314,429,242,3885,810,713,830
+M55131_at,403,39,514,134,70,71,398,440,276,111,169,33,141,74,92,146,183,207,44,176,143,188,117,36,-2,151,98,296,245,101,172,89,150,71,102,-34,120,225
+M55150_at,654,1283,1286,915,732,691,853,1238,822,885,680,412,548,1157,387,707,1822,738,907,860,92,686,803,803,842,514,561,1811,1406,1707,2072,1753,1929,1647,2112,1555,1514,2693
+M55153_at,280,275,50,115,193,147,26,-170,195,193,233,50,324,67,188,131,211,236,180,130,37,36,155,-144,82,265,197,-51,40,-64,58,283,241,99,93,105,354,-12
+M55172_at,-132,-122,-274,-434,-30,-142,-401,-151,-257,-182,-156,-268,-197,-119,-200,-87,-40,-105,-136,83,-177,-332,-214,-151,-195,-193,-253,-104,-105,-77,52,-312,-342,-29,-152,-313,-397,-209
+M55210_at,61,37,-254,-78,97,-78,23,34,-5,-42,-98,-17,153,-114,102,189,38,61,163,585,57,-43,51,-7,-50,-6,107,-69,-93,-228,-6,78,-19,-21,-155,-117,-74,8
+M55265_at,511,555,859,699,715,800,672,707,710,637,371,225,601,500,741,633,910,454,412,1224,11,278,355,661,333,210,517,437,437,311,602,805,790,496,581,639,604,858
+M55267_at,170,318,144,218,461,-110,213,55,111,76,24,5,264,143,227,145,89,155,44,308,79,-57,-26,329,66,44,261,20,14,167,137,65,31,139,329,57,30,89
+M55268_at,1366,792,1532,669,702,869,1058,1071,1177,701,957,454,913,808,865,913,1748,1081,605,1551,424,779,854,865,819,969,1326,1434,844,1423,519,969,1068,334,803,906,923,1182
+M55284_at,113,183,-84,-146,-21,40,-252,-430,-152,2,-38,-27,147,91,-297,-43,-450,-225,208,-112,-176,-107,-197,-309,-139,-118,-453,-193,-209,-112,-258,-368,9,-137,-193,-173,-80,177
+M55420_at,244,209,374,49,173,-8,310,265,282,239,206,70,132,174,118,249,150,249,59,262,237,150,-53,181,279,201,311,283,194,85,141,241,188,94,131,190,228,368
+M55531_at,434,13,124,142,449,62,168,358,16,-1,391,556,955,291,566,1433,621,439,3446,913,-47,167,290,555,657,2644,-82,486,346,397,412,423,3983,606,213,262,2549,675
+M55542_at,30,39,-7,-105,15,46,-43,-13,11,4,-13,-25,55,223,136,180,-42,-5,11,109,44,-32,13,-48,-9,20,-25,-23,-72,-28,9,16,30,5,-35,-88,-49,-103
+M55543_at,-1,42,-22,1,73,-24,-21,-94,71,19,3,100,30,106,145,11,111,154,19,27,83,1,32,33,31,89,-7,33,-52,274,236,105,196,65,91,32,55,462
+M55593_at,923,705,1150,675,329,339,724,1392,655,690,491,245,350,772,286,553,697,483,380,748,580,644,773,791,635,681,1099,636,887,614,867,1098,848,635,481,725,952,1290
+M55621_at,-336,-360,-1583,-128,-75,-208,-95,-1012,-793,-522,-637,-317,529,-381,35,-245,-615,-382,366,511,-247,-187,-493,197,-116,-148,-1109,-653,-218,-515,-612,-781,-1084,-235,-664,-452,-623,-454
+M55671_at,351,399,464,184,196,101,147,680,352,426,398,100,287,310,297,235,739,257,439,582,283,379,284,464,461,344,743,523,370,267,539,413,97,82,232,154,274,613
+M55905_at,82,143,239,231,392,213,253,44,271,167,157,110,283,343,445,193,190,95,160,360,-51,-17,94,283,132,57,170,185,36,114,0,56,178,25,130,113,201,36
+M57230_at,-121,-191,-260,-83,-70,-151,-110,-182,-133,-55,-117,-81,-80,-185,-80,-133,-178,-57,-179,-132,-74,-54,-157,-91,-166,-113,-71,-244,-125,-40,-110,-75,-61,-93,-151,-116,-144,-77
+M57293_at,71,100,180,158,-33,90,114,43,57,12,-14,45,3,22,48,159,134,23,58,21,-3,13,26,-16,26,-41,206,61,48,35,132,67,-4,13,110,39,153,21
+M57399_at,305,200,151,192,74,158,52,355,308,247,149,127,35,101,0,111,175,22,141,4,-56,159,224,130,-25,21,359,124,93,143,79,234,131,35,203,274,-18,202
+M57471_at,-24,-28,-58,42,-46,17,-122,-83,14,-13,-21,0,-31,-31,0,-40,-38,-45,-2,27,19,70,-5,-44,-67,0,-32,-86,-149,-22,-59,-34,39,7,-4,-36,-18,-64
+M57506_rna1_at,-273,-383,-222,-261,28,-193,-186,-479,11,-393,-109,7,-291,-166,4,-260,-727,-207,-99,-91,2,-261,-292,-212,-41,-188,-530,-406,-473,-162,-470,-411,-370,-87,-464,-260,-342,-602
+M57567_at,672,1265,1548,410,986,1061,482,70,1652,387,1101,553,767,568,1052,948,371,604,572,2337,322,255,841,751,952,986,92,416,334,1023,964,1049,573,748,896,912,1433,957
+M57609_at,193,126,372,271,223,140,887,-154,525,236,142,100,20,286,204,317,313,197,58,500,297,189,330,399,-170,195,439,314,-322,235,202,480,150,170,66,18,262,365
+M57710_at,-115,2171,-26,22,244,108,-45,674,103,252,9,988,-42,389,-46,-48,-83,944,343,950,64,88,-85,-96,560,43,-269,394,72,5940,6247,6530,159,5824,7142,499,1853,6704
+M57730_at,-167,-360,-444,-472,-50,-490,-482,-395,-451,-404,-361,-205,-39,-287,-86,-304,-53,-185,-120,339,-279,-146,-442,-208,-6,-54,-702,-324,-437,-168,-66,-455,-268,-179,-419,-213,-311,-632
+M57732_at,-285,-312,-270,-741,426,-487,-850,-59,307,-157,88,-333,101,-383,167,28,-319,-128,-161,-278,148,-1,94,-71,27,229,-458,-43,-259,-412,-599,-381,-343,18,-176,87,-390,-28
+M57763_at,320,794,184,13,464,128,178,218,454,423,414,191,713,274,334,249,597,305,415,667,32,329,131,133,99,456,84,-33,-21,1220,738,668,394,241,1353,497,679,829
+M57892_at,-133,79,-49,-103,-4,-138,-137,-125,-163,-48,-41,20,-68,-84,1,-74,-109,7,48,-1,-7,-142,-89,30,-36,4,-73,-76,-117,19,-20,-167,-34,-91,-195,-26,7,-123
+M58028_at,2450,2507,3854,2288,1983,2880,3824,3263,3546,2024,2163,1912,3814,3576,3386,1683,2511,1269,2168,3866,404,940,2663,2977,2119,3106,1364,1706,1495,3602,1321,1384,1707,662,2500,3934,1745,2370
+M58285_at,1917,1603,3200,1416,1749,1522,825,1845,1847,909,931,1013,722,1725,1138,1283,934,1173,733,1791,1176,1162,1016,1993,455,894,1207,1184,1464,1911,2172,2250,1044,695,2798,1238,1615,1639
+M58297_at,-253,-233,-596,-351,61,-476,-329,-376,-592,-245,-144,-189,-152,-254,-89,-302,-108,-173,-251,19,470,-54,-395,-153,-130,-70,-245,-329,-541,-421,-778,-504,-479,-412,-394,-456,-454,-942
+M58378_cds1_at,652,498,843,507,152,816,667,536,743,537,313,403,114,458,374,270,33,344,263,352,121,439,670,559,328,291,649,577,1161,469,686,275,655,-25,207,1083,653,1066
+M58459_at,2277,406,2890,1134,4,2672,10,82,4720,3033,2473,58,47,2458,20,3501,3057,2111,2090,8701,3378,1543,2467,2224,4437,40,104,-24,24,2086,70,3371,-14,-7,4068,90,3119,50
+M58583_at,236,267,277,204,148,103,105,215,329,76,145,116,86,182,105,231,285,168,107,264,193,209,174,224,194,240,273,118,113,195,82,226,196,102,368,286,227,179
+M58597_at,127,21,18,267,69,131,206,-98,54,-2,-1,125,-21,48,45,-135,227,-148,-33,22,236,-7,77,109,-25,-58,104,178,43,442,22,212,-93,146,412,274,-89,106
+M58600_rna1_at,-576,-396,-347,-823,-510,-199,-425,-455,-484,-305,-418,-311,-296,-422,-271,-268,-1012,-321,-194,-585,-338,-413,-165,-358,-429,-310,-708,-561,-461,-557,-468,-281,-384,-250,-402,-448,-308,-419
+M58603_at,503,438,247,1159,563,188,756,677,408,334,614,1004,568,810,946,342,131,567,337,583,183,1005,226,705,437,197,638,693,485,2084,3998,1008,1944,574,2167,835,528,3783
+M59371_at,431,-119,330,-197,101,-286,-468,-745,100,-204,-137,-217,-169,-30,-126,-172,-471,-160,-139,21,-147,-270,-305,-227,-328,-160,-993,-60,98,-265,-312,41,-352,-25,-291,-57,181,259
+M59465_at,800,4008,2339,633,541,627,371,1245,2102,1611,4038,3023,2285,447,1182,2525,873,2256,2165,2674,3586,3137,2129,405,5968,3541,937,1177,396,7549,3331,1623,3019,254,2284,702,1138,2672
+M59488_at,88,35,-93,-115,-28,-76,16,-139,-247,-42,-118,-34,53,-120,-70,138,74,91,143,48,-114,113,-75,-242,109,59,-120,23,363,31,-105,104,28,-183,-153,238,107,99
+M59499_at,61,52,110,13,24,-33,3,94,102,57,47,-20,53,163,0,38,417,21,20,64,63,47,43,34,53,33,54,32,52,-27,70,97,119,111,134,68,330,226
+M59807_at,2069,14463,7723,1731,1483,4111,1740,3779,3251,6344,1878,1179,1453,14288,1899,1705,3578,4016,1508,1427,822,1642,1721,1396,1563,1734,2364,2966,2053,1730,2750,1652,1642,1000,2089,1729,1901,2614
+M59815_at,952,662,1005,1241,506,590,900,1601,737,623,764,411,474,632,531,800,617,585,576,852,-156,758,782,-576,680,608,1023,1179,1118,729,1301,839,947,233,571,117,834,1112
+M59820_at,103,-84,-302,-137,137,-229,-263,-446,-235,67,-99,204,320,-89,-55,-87,600,-11,56,-149,-102,-107,-176,-130,1084,-34,-345,465,278,1060,-3,74,184,512,175,27,67,378
+M59829_at,145,129,724,164,205,160,126,199,75,340,70,100,236,187,134,249,194,206,130,176,-111,175,163,312,309,376,794,105,134,216,224,552,237,110,120,66,410,165
+M59830_at,206,270,301,143,111,112,127,289,288,3198,61,45,268,123,128,134,286,201,167,280,237,155,180,167,6755,232,359,206,103,180,181,346,328,123,1447,211,269,304
+M59911_at,176,205,582,273,190,65,457,296,347,97,108,120,137,-21,11,285,434,235,248,251,103,376,102,190,286,205,353,42,-12,77,385,361,314,26,141,202,421,689
+M59916_at,-880,-538,-1531,-1152,-459,-439,-468,-1610,-954,-221,-442,-258,-739,-542,-335,-810,-1428,-346,-259,-405,-513,-319,-784,-638,-427,-935,-649,-279,-262,-664,-473,-808,-749,-466,-213,-523,-544,-1434
+M59941_at,169,5,204,-127,49,-119,21,119,82,36,-17,-107,17,60,-148,21,-48,43,-99,-49,29,228,-13,112,-20,56,148,173,194,292,-27,-135,214,-257,-63,-151,34,195
+M59964_at,-69,-48,-109,-92,-21,-48,-112,-211,-57,-64,-87,-90,-100,-91,-20,-77,-121,-52,-53,-117,-3,-54,-100,-145,-112,-128,-45,-172,-149,-162,-158,-76,-103,-43,-49,-222,-137,-215
+M59979_at,-371,14,-650,-229,65,-126,-290,-518,-257,-177,-322,-130,-144,-325,-198,-270,-162,-207,-182,-274,-153,-311,-338,-112,-287,-321,-247,-295,-408,-277,-130,-344,-142,-17,12,-239,-267,-348
+M60047_at,-180,-228,-383,-302,-23,-216,-356,-217,-192,-128,-208,-212,-207,-47,-207,-110,-124,-137,-294,-6,-94,-185,-286,-73,-168,-139,-348,-147,-254,-120,-78,31,-179,-73,-127,-244,-221,-282
+M60052_at,-109,-473,-165,-91,-98,-44,-240,-296,-320,-620,-127,74,-119,-268,51,-62,-846,-1,-129,94,14,149,-305,-95,-106,-20,-785,-120,-185,109,-464,-241,130,-325,-582,-134,-789,-293
+M60091_at,565,418,588,575,441,480,497,646,497,422,324,139,302,482,490,447,327,286,503,516,437,427,560,801,440,378,389,519,560,427,476,500,317,13,293,447,563,439
+M60092_at,189,85,299,29,64,3,171,155,119,142,139,2,107,152,95,15,99,7,68,154,146,146,102,145,31,86,300,156,36,-61,121,213,177,-73,135,113,167,197
+M60094_rna1_at,-39,43,143,-134,105,12,25,-38,86,50,77,10,-57,43,43,55,39,-32,36,35,18,61,153,145,-35,-7,128,-16,36,100,63,-11,64,15,19,69,111,100
+M60165_cds1_at,499,519,1031,235,327,385,623,910,692,655,199,281,518,253,444,609,510,516,384,587,443,362,640,580,491,560,976,719,567,657,450,618,773,245,689,583,452,1074
+M60278_at,198,142,-236,35,512,-224,-199,626,-325,-212,-178,350,859,-193,335,30,-170,64,783,454,635,740,-131,247,184,1525,-298,-80,-88,177,238,-217,434,102,48,-71,-201,1891
+M60298_at,-127,55,1,36,-40,-64,18,-61,9,-38,-12,-22,32,-38,-5,99,62,5,81,361,14,6,-68,-19,106,-49,75,84,214,-69,466,675,11,478,91,145,59,386
+M60299_at,-743,-667,-861,-755,-196,-921,-1335,-1665,-592,-787,-311,-712,-298,-719,-703,-228,-298,-437,-272,519,243,-536,-581,-306,-542,-548,195,-270,-440,-1105,239,-294,-401,259,-1191,-690,-418,401
+M60314_at,-138,-122,-181,6,-32,-311,-109,-19,-134,-26,-87,-43,-44,-151,-46,-45,-260,-55,-12,-150,-16,-65,-30,-107,-119,-15,-239,-145,-122,-140,31,-165,-75,-17,-67,-11,-27,-122
+M60315_at,46,-75,-39,-63,-76,-163,218,197,-172,-41,-41,15,-84,90,-22,-5,-67,-122,-29,-165,69,-6,39,-28,-75,-10,-237,-34,-79,-191,-71,-135,42,-155,-127,0,-122,-67
+M60331_at,-44,-95,-161,-10,-32,-83,-179,-182,-120,-71,-106,-30,-23,-60,-43,-100,-129,-118,-4,-47,-8,23,1,34,-78,-73,-194,-21,-132,-31,-116,-145,-44,-25,-159,-17,-5,-155
+M60459_at,235,34,114,111,53,8,139,-121,28,-59,36,127,-69,-62,24,-75,-167,-15,68,-145,-17,56,47,38,105,-52,-1,-23,156,-47,426,290,104,283,-80,23,37,162
+M60527_at,363,156,339,261,557,174,131,176,423,186,246,47,703,475,365,518,727,136,374,894,314,149,121,412,281,141,244,108,125,68,130,139,87,170,33,53,238,140
+M60556_rna2_at,-454,-378,-533,-269,-346,-352,-668,-665,-595,-370,-357,-350,-431,-497,-152,-217,-643,-508,-416,-508,-401,-328,-321,-251,-358,-410,-499,-598,-315,-494,-459,-600,-472,-167,-460,-292,-179,-494
+M60626_at,-40,40,-127,59,14,-1,-11,26,-34,-9,6,18,-29,-10,20,-160,-252,-67,-13,-58,-107,2,-91,128,44,-28,31,20,113,-57,-63,-43,-51,-23,-58,-17,9,-104
+M60721_at,367,-320,-466,1110,626,-60,641,287,-7,-359,-292,155,920,-326,1054,76,-877,-333,568,1058,-138,-122,-397,1382,1835,1053,-517,-215,-444,2668,1094,66,825,-3,267,-172,449,858
+M60724_at,64,101,46,142,92,10,31,143,40,9,92,43,48,112,55,51,145,58,50,104,87,37,157,142,-50,7,67,78,9,-76,103,111,85,19,100,20,-29,106
+M60748_at,-193,109,-172,-221,11,-120,-270,-476,-57,59,-110,53,-110,-207,7,-196,-341,-5,-119,-27,306,40,-112,52,29,53,-317,-198,-177,-294,-189,63,-193,-27,370,-256,-104,-310
+M60749_at,-16,-65,-33,5,-2,14,0,-64,62,-71,-34,-37,-10,-59,-80,-70,-122,-9,-15,36,-3,-57,11,177,27,-23,-61,12,-156,-4,-4,-34,11,-5,-39,11,-88,-29
+M60752_at,55,980,-72,118,300,-186,73,-296,67,658,157,546,122,-82,196,150,299,-14,-4,375,1006,47,-176,1225,1304,312,-31,-51,-192,-21,-367,-25,286,-33,549,-155,352,-92
+M60830_at,506,599,142,693,591,-17,485,52,148,186,282,109,624,265,485,356,665,134,91,265,549,126,136,997,269,353,-28,228,139,1017,400,125,165,343,1350,298,173,225
+M60854_at,19478,20027,21623,19945,21763,23602,24851,18045,19985,22465,22499,22263,16824,20759,20157,20362,18573,21333,18830,17059,14235,22762,27396,21226,21323,19484,23315,19692,17212,19626,20245,20711,19749,22925,19146,22523,20006,20056
+M60858_rna1_at,5147,5821,6436,4864,7901,4891,3525,3802,8618,7418,5430,3311,6607,6523,6912,5975,8153,3015,6394,12612,3617,3524,4896,7172,4281,5602,3767,4354,3549,4882,4243,4027,5216,2767,4725,4791,4808,3529
+M60922_at,745,544,780,662,818,400,781,649,801,370,259,442,971,797,819,770,1033,1341,688,1355,94,384,406,816,477,2591,793,568,562,1562,772,779,674,439,707,1055,1490,668
+M61156_at,18,0,20,-40,5,76,-21,-97,-32,16,-17,-1,65,62,10,27,-31,-24,-31,-14,76,-39,43,-4,36,76,-132,39,-14,29,-6,-25,34,-3,-63,-17,15,65
+M61176_at,75,42,13,-45,40,69,92,0,162,42,14,57,5,40,75,35,158,36,19,42,74,-83,43,21,9,4,217,12,-115,-9,42,156,-12,-49,36,-37,11,9
+M61199_at,137,406,88,161,213,71,107,74,265,245,610,53,130,252,198,78,458,54,12,275,545,11,138,270,66,20,183,327,84,344,318,811,140,195,875,136,185,465
+M61733_at,1,4,76,-69,68,-16,5,23,71,-3,13,-31,-57,-76,97,-15,56,-36,-3,8,36,41,-94,39,23,35,-104,12,-19,-15,229,241,79,-5,7,-3,39,39
+M61764_at,-312,-185,33,-160,89,-156,-394,-706,161,64,-44,-337,259,-159,256,-148,-274,238,-34,12,111,-292,-207,131,-25,-57,-427,-113,129,-226,756,984,61,909,-386,-371,-454,117
+M61906_at,209,160,205,185,178,33,162,725,95,135,264,129,139,372,482,184,121,53,276,1585,483,379,68,407,157,339,203,117,259,141,204,405,277,480,120,295,225,398
+M61916_at,55,10,3,-5,3,58,20,50,24,-12,-40,-27,14,36,-12,36,1,4,7,29,-64,-14,60,-46,0,24,6,-28,-45,47,27,11,22,41,7,34,23,18
+M62302_at,160,135,288,201,118,104,341,383,220,230,152,68,183,200,101,132,109,199,120,-382,86,183,212,73,185,199,-391,108,259,382,348,52,275,179,65,362,182,652
+M62324_at,389,514,281,351,357,147,344,280,111,385,568,271,441,122,452,574,94,699,471,258,211,776,205,395,230,791,-7,187,2,583,996,625,981,490,426,53,234,1123
+M62397_at,118,27,42,26,6,76,-10,-77,99,-2,4,20,22,101,-13,8,26,29,57,33,4,22,104,23,-23,41,84,37,38,-2,35,12,24,33,10,14,8,50
+M62400_at,107,-82,-157,45,28,-12,-11,38,-46,72,32,-40,7,-6,-23,96,-176,-62,-59,-23,18,-52,26,-8,-6,-83,14,-84,-48,-101,-42,-89,-192,-11,16,-68,36,-103
+M62402_at,-3,318,44,94,8,46,58,64,-18,16,56,68,28,368,-4,39,-193,-13,9,-14,-38,141,-79,85,58,22,-132,43,-137,-46,-28,147,229,-41,27,120,130,-39
+M62424_at,30,73,53,69,16,42,11,121,48,19,17,11,10,49,13,-14,114,19,81,52,92,-7,34,1,23,45,59,117,43,63,-2,16,43,-6,21,11,163,51
+M62486_at,245,197,273,239,170,311,95,197,187,101,163,130,98,164,160,112,283,130,112,177,158,235,210,220,149,259,289,191,216,246,248,295,240,153,152,168,269,295
+M62505_at,-464,-36,-444,-415,-249,-216,-504,-358,-497,-196,-355,-139,-276,-268,-181,-222,-768,-285,-328,-414,-192,-109,-260,-278,-409,-253,-618,-338,-440,269,289,-444,-243,-79,-359,-466,-120,481
+M62762_at,835,3072,609,935,1665,499,764,1323,1741,1188,1870,1030,1482,892,1306,593,2376,542,809,2475,1514,1977,672,1235,933,1114,-9,3236,1125,4647,3808,3594,2702,1736,3553,3255,4249,1871
+M62783_at,453,423,692,536,375,69,204,440,492,344,284,40,287,415,392,447,931,442,263,520,177,357,131,554,329,467,941,499,495,840,302,401,378,173,654,306,491,601
+M62800_at,-496,-374,-647,-638,-389,-599,-961,-851,-750,-548,-631,-258,-185,-526,52,-452,-1285,-612,-631,-32,-54,-357,-653,-515,-628,-478,-844,-738,-329,-349,-740,-584,-830,-103,-611,-353,-477,-1134
+M62810_at,-67,67,-86,-71,165,12,-115,-208,-16,45,-34,-56,297,76,171,85,39,-66,10,634,472,-18,-24,129,-60,-40,7,-65,-100,-74,93,42,-79,19,-67,-83,-75,-47
+M62831_at,3035,7085,2072,2894,5189,1232,3584,2434,5143,5700,2135,1914,8166,2716,3521,1762,5280,2376,2105,8573,398,3296,575,4298,8453,7825,4287,3386,654,7779,2380,3251,10713,1839,3802,1447,4557,3790
+M62840_at,-757,-101,-437,-347,-336,-225,-270,-373,-172,-332,-418,-166,-204,486,-396,-420,-328,-340,-387,-333,-62,-30,-34,-489,-500,-289,-600,-288,-500,313,-511,-312,-480,-38,382,-24,-298,-771
+M62843_at,-541,-3,-799,-654,-329,-464,-593,-872,-490,-445,-408,-182,-293,-220,-102,-429,-934,-369,-220,-93,-112,-340,-93,-305,-183,-295,-566,-477,-389,-534,-794,-598,-179,-266,3,-561,-217,-281
+M62958_at,170,-105,140,-8,-50,211,131,-23,52,44,46,38,121,58,-58,23,183,124,-46,-339,69,35,62,-3,-130,-23,26,139,76,150,-162,-237,76,-159,120,-22,52,-7
+M62982_at,-269,-79,-190,-181,-105,-195,-171,-128,-141,-12,-110,-81,-69,-152,-34,-138,-90,-72,-115,-118,-143,-181,-176,-103,-69,4,-211,-41,24,-172,-57,-88,-31,26,-104,-100,-34,-97
+M62994_at,302,219,258,293,402,286,376,572,173,37,125,215,729,270,689,219,859,159,655,1438,224,75,125,410,247,338,228,189,221,274,88,189,279,3,294,272,428,330
+M63138_at,1410,2325,2789,1132,1269,1854,2735,1962,2900,1855,1471,1763,786,2337,2035,1910,4215,711,1346,2273,545,949,1297,1343,1371,1330,2127,5587,3909,12358,7125,2275,4214,2558,8793,4630,7373,2771
+M63154_at,-106,-61,-181,-172,-66,-64,-178,-86,-98,-80,-116,-37,-78,-35,-45,-93,-85,-84,-77,-79,-74,-78,-53,-150,-77,-112,-148,-40,-144,-45,-143,-72,-78,-23,-76,-39,-59,-101
+M63167_at,822,988,886,650,551,864,977,425,858,910,557,490,768,864,599,563,790,319,568,1435,106,553,533,870,582,592,381,823,651,1934,1121,1068,1042,587,902,889,1290,1295
+M63175_at,657,451,402,444,436,240,895,578,742,444,706,405,685,259,191,169,445,608,518,1404,416,175,298,251,222,246,664,590,218,540,779,476,580,431,589,612,1104,1161
+M63180_at,598,606,602,479,751,273,418,253,514,483,643,300,464,510,733,501,412,457,869,1343,510,329,193,454,298,469,463,313,281,270,502,423,486,404,331,323,475,463
+M63256_at,-204,-105,-231,-180,-41,-117,-184,-436,-117,-53,-26,-64,-100,-31,-72,-211,-86,-67,-69,-84,-1,-64,68,-165,-5,-119,-301,-125,-197,-148,-95,-83,-184,-62,-162,-201,-142,-370
+M63262_at,1307,1506,553,372,491,385,1253,323,242,243,145,787,626,1992,335,233,234,415,230,854,112,210,172,1047,515,601,373,195,98,3864,1851,312,249,476,4151,151,611,547
+M63379_at,435,286,623,409,216,279,586,335,516,288,312,298,263,377,179,353,311,193,171,215,262,313,391,374,305,140,433,1896,555,1037,1586,520,381,255,8769,659,480,680
+M63391_rna1_at,-251,-617,-144,-478,-68,263,-596,-260,-399,-164,-383,-267,-179,59,-305,-178,-140,-300,-34,-105,-38,-302,-235,-181,-164,-268,-264,-206,-57,-392,-265,-163,-500,-90,-83,-568,-473,-380
+M63483_at,910,1260,1646,1041,1326,1244,850,788,1408,1398,1046,671,1548,544,1383,1392,777,708,1465,994,815,710,1174,1701,962,436,1057,1245,586,993,770,502,1663,823,1523,1474,1146,1900
+M63488_at,102,-6,252,31,225,151,11,-28,343,-14,-40,12,185,309,341,-30,195,16,22,90,-122,-137,60,112,-31,-144,17,-72,-64,-28,-57,-19,-131,-89,-67,-39,-99,-147
+M63573_at,-1044,679,-1000,-814,959,-1157,-1387,-2419,1543,1509,1928,-202,850,-112,1053,1057,-896,210,459,3985,-1701,-262,-1056,224,-245,812,-2126,-443,-16,875,-450,-1417,-1041,1531,1567,453,-1008,-1923
+M63582_at,947,690,764,388,554,542,1729,895,423,421,539,334,642,610,994,640,1021,494,544,829,487,935,408,632,720,634,1303,782,1611,414,415,944,1973,198,403,927,607,2086
+M63589_at,-45,-3,218,40,65,110,-43,17,505,49,409,-48,68,123,19,108,-89,-10,45,178,91,60,-17,205,103,98,-21,-44,201,51,360,630,378,386,-99,-70,17,299
+M63603_at,152,77,207,99,-10,158,144,262,131,90,157,125,77,111,88,177,141,146,20,101,33,105,11,117,178,125,170,258,180,51,63,94,108,41,97,166,137,44
+M63623_at,80,157,138,85,42,51,87,176,102,118,72,38,78,44,78,96,82,144,24,42,84,51,170,117,26,94,70,105,62,71,24,86,102,65,76,45,10,182
+M63835_at,-152,-113,-183,-127,99,-72,-162,-268,-178,-121,-192,-96,-203,-99,-17,-166,-390,-216,-251,-164,-66,-219,-75,-130,-249,-278,-162,-91,-48,316,-83,-252,-212,23,449,-91,-219,-93
+M63896_at,-2,3,-41,-45,10,3,-75,-32,-4,32,-14,7,-58,19,32,-26,36,0,-51,-5,51,-52,-13,-33,-7,-23,-4,-45,26,-23,66,-33,-121,-82,28,7,7,-26
+M63904_at,658,7739,1603,1283,1071,1250,1191,1033,2811,791,6311,1615,1919,1326,3394,294,5415,469,1353,5898,109,1251,737,2132,1349,2158,-380,1464,822,872,2771,3036,4459,2081,-718,1154,1196,4149
+M63928_at,720,33,-187,-747,180,-8,-744,-1262,2492,-62,705,-109,-122,-220,-45,419,-42,-143,101,507,81,-345,-32,-263,771,1068,-621,-318,-723,-475,-973,440,255,-178,-346,-1062,-1279,-848
+M63959_at,468,1121,595,527,1125,538,554,608,1082,409,633,633,991,623,1079,651,2028,505,358,1239,1295,844,469,706,568,802,301,1401,533,2562,1266,934,816,1236,5464,2088,812,1009
+M63962_rna1_at,-134,-57,-158,-234,112,-202,-307,-688,-41,-129,-93,-120,69,-320,-22,-45,-261,58,-79,86,-6,-14,-36,-155,-44,-34,-281,44,-365,-286,-390,-22,-70,-49,-251,-136,-163,-60
+M63967_at,154,161,38,132,83,128,174,250,193,257,-28,132,35,204,46,275,145,46,54,61,52,-85,176,217,54,71,226,282,187,129,300,-70,-4,-7,284,230,239,173
+M64082_at,-69,-32,-139,-18,93,-40,-90,-23,-48,4,-22,27,-28,101,8,60,-7,-60,-91,-4,16,-112,-146,-15,-17,-40,-7,-45,-52,-59,-11,79,-52,65,-19,-44,-50,18
+M64098_at,694,782,393,1049,726,140,643,461,1318,199,835,629,522,874,1178,355,720,1183,603,1141,652,205,417,850,1019,858,669,719,509,857,458,828,734,343,759,636,347,232
+M64099_at,-217,-272,-335,-371,11,-357,-322,-85,-400,-124,-205,-265,101,-333,-11,426,-265,22,1,263,-147,-328,-264,-134,-118,454,-276,18,31,83,-21,-174,-141,177,551,-43,-109,-322
+M64108_at,553,491,602,537,142,428,909,928,336,618,451,398,94,616,229,395,440,187,457,159,33,235,587,408,300,254,816,705,961,348,961,469,577,187,690,770,970,1147
+M64174_at,588,511,419,386,442,268,425,548,462,266,254,260,330,749,472,379,561,242,453,584,22,283,104,476,335,268,453,283,290,473,392,337,412,218,262,286,822,572
+M64347_at,156,79,303,53,176,94,-8,100,206,211,168,18,219,156,156,79,32,172,51,77,-14,-9,197,131,186,129,200,83,156,74,212,133,111,59,31,-30,147,136
+M64358_at,82,-66,-69,-1,-43,-83,-60,44,-62,-19,-33,30,-21,14,33,-13,-114,13,-40,58,13,40,-47,-102,-56,-25,64,-92,-81,82,-41,-49,-64,-33,-42,-49,-8,-29
+M64497_at,363,186,315,126,95,48,-5,83,134,154,88,68,48,153,92,248,422,99,68,133,87,17,98,76,65,87,-14,107,214,190,75,170,163,22,305,66,58,119
+M64554_rna1_at,-35,32,-29,-72,-2,-23,-47,-5,-8,-10,-62,20,-4,-25,-18,-40,-57,-28,-15,-13,-23,-44,-39,-45,2,25,-61,-39,-88,13,1,-49,-21,-17,-9,-32,18,-8
+M64571_at,693,804,854,897,905,672,1137,754,695,669,839,308,469,571,776,579,517,712,475,903,268,328,507,1093,482,628,801,517,298,596,495,566,754,321,768,711,868,681
+M64572_at,-345,-399,447,566,-225,567,-223,148,-150,-144,-157,219,-394,-338,-169,-319,-449,68,-104,-327,-39,-156,269,-159,-117,-374,-114,-208,127,-333,-282,-264,-417,-73,-386,-375,293,-728
+M64590_at,190,120,190,122,126,48,142,322,83,143,99,126,133,405,181,134,99,394,107,1704,540,64,144,244,122,119,164,66,120,107,95,149,112,63,122,22,77,209
+M64595_at,439,1805,1756,1057,1519,1392,1161,41,1932,890,411,573,545,1322,1842,431,759,974,47,253,-9,-32,332,1161,503,256,-150,863,411,1270,469,32,731,342,1407,1256,1264,326
+M64673_at,251,655,358,325,719,257,507,181,745,315,939,191,664,151,649,301,502,304,365,372,229,479,440,939,245,397,-32,1118,-177,291,-177,195,191,334,643,562,579,209
+M64676_at,-115,-166,112,-45,-57,-99,-117,-29,-41,-137,-39,-126,-131,-83,-74,-150,0,-72,-133,-100,-3,-71,34,-218,-65,-72,118,-138,-76,-162,-108,-171,-18,66,-186,-209,-194,-147
+M64716_at,13008,13342,13861,13162,11780,17184,12190,13971,12719,12910,14737,18058,10624,13508,13174,12904,10753,15165,13284,11042,20770,15834,17106,11477,15308,13934,16606,14173,15307,13143,13532,13724,12671,17162,12088,15684,12557,12762
+M64788_at,-1354,-2218,-2170,-1856,-313,-1536,-2454,-2856,-2147,-613,-522,-1095,-758,-1781,-1653,-1571,-2041,-219,-698,-1361,249,-1307,-630,-1178,-1721,-1147,-2328,-1479,-868,-2205,-1731,-1333,-1862,79,-2069,-2885,-780,-2277
+M64925_at,1287,1416,1194,507,601,835,403,1178,1046,827,784,1138,3012,514,1373,978,2292,344,906,2136,687,527,446,685,1554,2059,807,809,923,1045,1940,2211,1209,1233,1206,732,837,1678
+M64929_at,114,358,-369,668,282,-138,487,584,155,251,484,162,724,369,693,316,1058,352,202,1214,450,652,66,184,161,-30,-677,344,-96,433,668,689,358,91,248,28,440,1004
+M64930_at,114,-7,96,41,21,83,107,70,49,32,-3,-50,-12,-75,15,-30,120,40,38,-15,-131,115,26,20,-43,4,15,94,31,33,-78,-83,19,-21,87,37,-124,93
+M64934_at,36,311,307,423,178,224,263,515,426,114,255,268,278,300,168,416,-173,207,200,390,179,236,476,286,345,258,391,398,541,256,1007,1150,314,440,188,270,91,548
+M64936_at,262,111,269,21,140,81,5,116,88,2,94,-34,60,77,58,93,367,95,58,258,126,40,155,120,104,201,234,5,-91,25,62,297,92,39,118,1,-15,60
+M64992_at,919,1276,1443,1055,1989,956,675,598,1899,1259,1543,652,1071,1151,1797,1344,1171,1042,852,2527,1555,690,809,1249,1081,510,475,855,569,989,1205,1370,1275,1712,1079,992,693,899
+M65066_at,210,611,1210,-193,-108,346,-512,-1027,376,-163,16,-17,84,297,57,44,71,106,-346,371,261,-265,530,-100,458,284,-455,500,238,456,-128,282,-119,66,-229,-57,30,430
+M65085_at,340,272,134,-138,175,92,-43,-170,58,283,218,204,184,165,-23,80,760,150,-12,-38,149,207,62,337,174,243,350,298,9,565,-67,-41,2,23,-43,19,-86,360
+M65131_rna1_at,252,182,258,126,251,144,131,251,196,214,54,83,221,256,253,194,348,173,198,383,182,134,176,250,156,159,231,153,134,150,268,282,238,137,109,139,209,193
+M65199_at,-1461,-889,-1338,-1651,-833,-974,-1308,-1841,-1292,-721,-798,-774,-820,-985,-699,-677,-1744,-528,-862,-1060,-665,-1124,-1024,-933,-834,-1102,-1693,-1126,-1238,-1017,-1592,-1982,-820,-566,-1225,-1263,-1031,-1499
+M65217_at,277,280,179,257,266,353,314,301,253,700,942,283,556,454,325,326,500,228,237,603,458,380,687,243,165,134,136,522,382,315,525,636,414,47,265,442,364,257
+M65254_at,352,199,586,302,260,307,418,439,355,328,300,176,245,308,237,315,507,610,250,359,214,205,294,289,241,474,763,287,312,294,336,287,294,158,227,410,350,463
+M65290_at,-22,2,29,-1,-14,14,40,7,35,73,42,43,51,42,46,58,-3,29,-15,17,41,44,34,129,33,40,57,61,69,-11,3,63,48,-18,67,-14,96,19
+M65291_at,-19,48,-27,-37,11,64,23,122,12,36,37,66,76,37,7,4,235,7,39,83,-3,-9,56,28,21,43,26,59,36,122,88,124,58,39,41,79,81,50
+M67439_at,-190,-607,-312,-531,-230,-209,-433,-563,-148,-479,-76,-261,-216,-132,-136,-62,-679,-163,-375,-171,-409,-432,-258,-688,-261,-171,-519,-341,-516,-398,-500,-851,-138,-185,-549,-372,-667,-731
+M68516_rna1_at,-31,-69,-239,-250,-79,-94,-188,-122,-89,-30,-85,-61,-151,-71,-175,-205,-164,-109,-57,-247,-66,-147,-218,-143,-50,-151,-276,-222,-115,-27,-65,-35,-253,-22,-177,-156,-94,-239
+M68520_at,569,557,391,335,590,243,141,19,614,560,541,158,691,705,568,485,703,527,445,956,316,66,279,689,381,508,251,404,266,39,401,241,718,326,293,65,406,265
+M68840_at,-21,-150,130,-15,-31,32,-89,80,24,186,-41,-2,-58,-90,-156,26,61,152,-102,-304,37,-192,-22,-48,-18,-57,278,131,-242,27,284,158,-51,83,-79,-44,-24,-355
+M68864_at,697,9,469,1473,990,357,188,988,1253,293,1044,406,540,417,1584,853,-150,950,841,2356,507,778,507,1621,199,922,453,645,399,292,69,264,71,374,-65,-204,-270,-655
+M68874_at,-14,-3,-45,84,52,-33,122,-25,-79,-24,-16,-50,-29,-23,17,-11,-32,5,-15,-25,-3,-34,49,31,13,-76,17,61,-7,86,53,-3,3,26,8,-13,-10,-41
+M68891_at,392,232,635,385,390,718,507,560,318,256,103,214,219,563,380,351,568,201,214,298,182,219,834,201,173,181,239,1286,367,384,1121,712,631,1200,143,875,737,785
+M68895_rna1_at,-214,43,346,147,43,147,300,265,210,222,235,188,176,220,198,252,106,188,156,32,61,256,265,-121,155,122,151,314,-33,285,342,207,296,67,224,291,295,430
+M68941_at,169,740,442,235,217,197,289,332,436,250,112,120,269,284,200,281,140,242,234,247,313,147,167,231,306,153,179,181,122,185,119,113,307,133,167,78,247,372
+M69023_at,332,387,362,496,553,327,559,217,618,187,139,127,831,200,583,374,582,248,381,621,371,193,172,817,246,255,217,314,271,148,201,102,319,171,485,262,216,144
+M69039_at,403,1063,859,709,1630,723,877,628,1452,1023,1328,646,872,1061,1582,1137,1582,451,769,2519,1897,513,811,1288,691,609,948,968,817,425,819,631,782,560,1049,1120,618,453
+M69043_at,1489,6084,2281,2178,1094,1513,2866,2129,3862,1974,2561,7901,3602,1204,2859,1259,2689,2753,815,2233,5193,1026,740,2785,14011,2381,569,13338,2306,21135,12115,5902,13895,1908,11990,9866,10899,14090
+M69066_at,6766,8229,6975,2771,4822,3639,2915,5196,9060,5328,7210,5542,9053,8407,4825,4219,13559,4453,2840,7960,1391,2350,2416,5840,4764,7277,1927,7420,3335,6535,3576,8956,6601,4066,9416,5744,6838,7247
+M69177_at,94,135,290,108,3,51,147,139,31,161,146,143,71,1,13,232,242,156,46,-96,43,143,30,89,7,148,378,293,235,203,-7,211,174,66,271,163,160,309
+M69225_at,-40,-10,-109,-85,-29,-65,-48,-121,-109,-42,34,-64,-51,-31,-79,-36,-245,-38,-32,-2,-44,-90,-34,-97,-69,-87,67,-72,-19,-77,6,19,-77,-47,-98,-122,-137,-149
+M69238_at,-84,98,79,215,228,-35,203,412,-3,55,-133,40,-17,92,209,181,246,-8,-39,56,92,53,13,39,101,26,-167,210,0,135,-112,130,25,163,224,58,127,142
+M73047_at,111,143,164,311,394,51,289,238,141,60,44,50,229,285,228,292,449,134,111,640,159,85,108,686,106,49,242,290,103,161,98,19,31,147,211,64,138,64
+M73077_at,-228,-227,216,-312,-231,-88,-171,-148,-362,-306,-193,-241,-228,-226,-256,-250,-485,-376,-92,-777,-28,35,-112,-299,-143,-113,-325,-117,-254,-350,-317,-500,-335,-139,-342,-115,-254,-541
+M73481_at,-339,-316,-522,-474,-171,-181,-341,-632,-420,-212,-288,-350,-294,-329,-417,-242,-706,-157,-103,-396,37,-320,-283,-167,-317,-280,-884,-94,-492,-75,-248,-321,-244,-21,-484,-592,-308,-763
+M73482_at,-185,-62,-315,-144,-10,-94,20,-149,-160,-31,-33,-15,-57,-87,-140,26,-75,-92,-34,-109,67,-120,-34,-40,-61,-29,-50,-51,-19,-88,-78,-78,-79,-29,-57,-78,-96,-143
+M73489_at,41,241,382,51,267,-40,13,13,-26,236,115,50,243,90,55,198,317,166,222,377,134,49,-28,272,112,303,394,81,50,-13,185,-49,-181,-1,420,-15,74,83
+M73547_at,777,90,169,508,614,78,816,359,247,175,23,90,970,484,635,604,517,219,557,998,569,180,49,486,115,323,259,184,84,340,74,90,128,166,-15,53,177,318
+M73720_at,278,168,376,390,205,247,420,545,360,246,188,102,139,233,74,322,881,304,193,118,132,154,292,242,116,239,292,617,259,291,351,958,98,616,127,499,661,493
+M73780_at,168,258,237,261,277,190,494,287,223,222,306,130,129,346,224,193,82,133,139,366,9,244,258,108,436,453,251,268,216,206,180,182,139,21,141,176,208,199
+M74002_at,1210,2149,1502,1107,1706,679,1606,962,1366,793,2790,698,1471,1749,1505,1043,2398,993,913,3848,3651,1730,938,1542,942,770,547,2445,1187,1354,1301,2869,1431,988,1176,922,1243,1064
+M74047_at,-161,-187,-269,-190,-170,-152,-265,-172,-202,-125,-66,-137,-143,-95,-91,-161,-302,-134,-91,-190,-168,-172,-205,-201,-212,-85,-209,-159,-103,-192,-191,-140,-183,-97,-114,-153,-138,-238
+M74089_at,63,101,573,68,294,368,186,155,745,204,657,43,7,268,123,132,584,230,145,497,371,92,94,299,112,72,-143,87,57,200,149,190,25,103,205,113,48,83
+M74091_at,49,62,90,69,48,28,43,34,60,57,57,17,60,19,17,22,45,28,59,93,58,31,125,75,26,-1,34,82,40,73,25,17,14,25,0,40,15,60
+M74093_at,-114,15,-106,-68,110,17,-38,-8,-89,7,-116,-45,-20,-55,21,63,136,205,56,30,127,-92,-53,48,-8,56,42,115,-57,56,142,214,-29,15,47,-506,-105,-31
+M74096_at,150,26,197,135,57,53,201,169,77,-1,123,43,28,118,92,139,-5,57,82,143,36,128,121,155,41,84,57,99,120,94,178,255,102,67,87,94,239,224
+M74099_at,335,537,410,172,210,307,223,619,504,108,444,84,131,286,476,179,160,87,168,647,257,304,273,377,137,148,312,278,189,391,347,233,343,221,154,180,655,221
+M74161_at,113,87,-5,-5,39,8,-15,-10,24,0,43,-22,17,48,53,183,100,43,-19,19,-48,-36,-39,51,-31,73,-70,121,-38,32,45,-28,11,65,69,10,73,73
+M74290_at,-730,-1073,-1429,-92,-187,-263,-441,-797,-224,-326,-682,-201,-285,-955,-533,-302,-820,-364,-190,-609,-124,-750,-385,-855,-540,-541,-544,-354,-170,-1072,-467,-662,-909,-71,-1154,-336,-474,-1403
+M74297_at,95,57,98,153,9,-10,278,-206,22,144,193,135,-14,113,21,106,9,175,-75,-205,44,218,216,70,-153,11,107,191,122,226,101,48,113,165,-47,-2,6,-26
+M74447_at,26,-51,-98,-189,-116,-74,-53,-128,-193,-18,-115,-125,56,-199,-3,55,-37,15,25,366,-73,-149,-93,-213,-167,-22,-100,79,-127,-46,-255,-201,-100,-123,-8,-41,-58,-81
+M74491_at,1815,1790,2660,1821,1870,1911,2690,2313,3347,1519,869,997,2188,986,1840,1990,2749,1080,2337,1693,1223,740,1069,3010,854,2061,2043,2916,1959,3338,1257,712,2451,1393,3111,3812,1632,2502
+M74524_at,857,330,439,94,517,142,191,71,423,260,238,76,1127,259,581,255,858,224,273,748,500,9,32,581,29,322,547,193,317,113,38,198,127,149,297,142,24,167
+M74525_at,131,68,149,7,77,76,52,317,148,61,107,83,89,145,151,114,257,49,90,167,179,-23,112,90,97,38,230,161,113,45,28,236,221,117,140,119,125,176
+M74542_at,-722,-697,-1005,-676,-147,-636,-549,-1027,-855,-556,-293,-597,-436,-612,-586,-134,-794,-26,-439,-311,-131,-353,-742,67,-670,-279,-35,-361,-317,-812,-995,-983,-552,-191,-931,-869,-942,-1200
+M74558_at,96,102,30,85,209,117,137,71,233,126,225,83,225,152,144,62,212,212,162,120,396,22,264,63,74,110,-17,85,129,126,78,191,231,74,82,102,107,49
+M74719_at,5452,96,191,521,601,53,349,3620,195,132,126,1261,4638,129,1559,1624,710,872,1472,6195,2447,8949,245,674,1775,2547,406,532,197,101,262,500,384,751,279,515,1269,974
+M74826_at,354,64,378,235,196,227,241,449,237,147,183,58,179,230,126,251,288,133,153,202,149,5,140,290,332,282,97,321,173,170,269,181,247,135,127,137,233,272
+M75099_at,827,563,561,702,1336,521,966,1052,1119,473,865,314,711,977,1170,928,1237,496,729,1397,182,453,583,1127,712,816,481,537,214,1064,991,669,478,775,1428,1183,814,254
+M75106_at,-132,-107,-175,-61,42,-88,35,26,-222,20,-91,-73,26,-23,-108,-62,-101,-61,46,-35,-59,-85,-138,25,-105,-17,136,-115,-2,-125,29,-124,-28,-6,-115,5,21,-5
+M75110_at,69,-14,163,93,16,-7,6,145,142,-10,74,-8,77,117,39,19,210,86,74,88,142,62,125,79,31,87,35,100,98,-33,148,12,34,66,-21,-28,-59,98
+M75126_at,574,753,1276,824,865,897,741,1217,1966,457,954,247,721,1722,929,672,1015,776,936,2390,898,546,435,722,1084,934,686,665,779,1081,2596,2155,1149,1149,1024,372,806,1611
+M76180_at,45,29,-150,-57,-46,-160,0,-160,-89,-32,-79,-73,-52,-104,-49,128,-126,-60,-90,-20,-82,-147,-106,-48,-107,-131,54,100,-28,-186,99,-118,-137,-98,7,-190,-160,-115
+M76231_at,-301,-329,-423,-262,-189,-289,-194,-443,-494,-247,-218,-277,-242,-282,-264,-338,-615,-248,-292,-206,-216,-303,-231,-299,-231,-244,-718,-466,-286,-396,-273,-201,-376,13,-437,-304,-476,-638
+M76378_at,114,675,861,530,598,364,719,635,769,506,331,-22,3,269,310,777,1098,231,386,1096,264,430,307,200,312,458,1084,774,360,1033,373,661,858,428,1687,770,958,895
+M76424_at,431,234,239,647,259,28,988,-415,550,518,437,107,473,179,335,438,-172,-10,230,-154,149,477,402,307,63,148,242,422,88,711,150,47,433,-19,415,1025,627,172
+M76446_at,-431,-235,-285,-85,-154,-344,-418,-161,-167,-173,-285,-66,-110,-174,-46,-190,-203,-195,-80,-126,-128,-180,-64,-137,-118,-219,-228,-260,-295,-380,-101,-387,-86,-62,-112,-455,-218,-175
+M76482_at,244,163,221,304,167,170,369,332,177,187,191,181,66,202,174,208,263,133,353,242,92,176,203,209,254,166,230,187,149,197,185,188,222,33,71,183,258,306
+M76558_at,-302,-55,-281,-158,-70,-190,-179,-152,-150,-171,-41,-153,-58,-151,-159,-166,-201,-81,-180,-43,-52,-205,-13,-222,-100,-270,-173,-125,-146,-313,-103,-273,-188,-114,-232,-66,-181,-190
+M76559_at,75,114,-13,119,35,10,84,256,32,177,43,143,69,59,-11,39,-14,-102,-23,-73,26,34,153,212,-29,34,54,186,262,15,95,33,100,35,147,74,124,-146
+M76665_at,50,96,99,74,131,71,62,167,21,88,126,-8,84,140,28,-30,-44,80,89,102,71,94,70,17,46,108,71,78,81,62,217,197,72,-26,1,6,159,136
+M76766_at,357,592,605,472,495,200,453,325,269,376,515,265,392,430,566,356,381,317,298,1148,792,466,442,342,260,184,278,310,165,438,670,525,526,648,416,315,436,622
+M77016_at,63,-15,-132,68,49,-8,87,113,5,51,14,-10,23,4,35,46,7,62,85,104,13,52,-5,96,82,-22,4,9,12,56,300,221,13,138,-14,-41,11,107
+M77140_at,64,-49,76,46,-95,-35,-85,148,-46,6,-34,-63,-39,22,-41,10,-52,3,163,98,-27,64,-110,-103,110,-2,-75,-93,2,47,381,195,-20,106,51,17,1,224
+M77142_at,296,164,317,225,243,40,137,289,152,115,102,-20,150,312,333,297,216,84,84,826,197,136,81,531,97,90,122,27,28,45,34,68,80,21,44,47,63,63
+M77232_rna1_at,13058,19729,10716,16647,18333,11254,16372,11832,18139,16914,12209,11965,14187,18532,17094,15409,10246,13516,14233,20041,19552,14010,15104,18481,13588,12487,9627,18298,16663,12386,17148,17646,17818,14374,17821,15095,17430,15683
+M77235_at,-229,-152,-220,-126,163,-234,-226,-512,-175,-165,-145,-250,-25,-262,-85,-64,-257,-71,-264,-55,-18,-95,-123,-203,-86,-75,-272,-396,-461,-197,-195,-149,-351,-134,-454,-412,-82,-221
+M77349_at,-6,490,270,321,156,215,220,244,263,22,161,-4,124,269,124,187,10,106,116,210,203,121,18,220,117,142,292,229,199,180,278,199,232,73,135,299,362,393
+M77698_at,709,1269,1184,709,1047,426,423,526,1377,570,369,188,1792,244,735,797,611,444,632,256,1011,139,321,1486,309,945,563,696,226,528,17,-63,561,384,695,383,509,499
+M77810_at,-404,-47,-401,-593,-92,-42,-188,-320,130,-152,-532,-307,7,-30,-327,-183,-639,-277,-259,-57,-251,-214,-385,-245,-347,-403,-560,-168,-156,-244,108,216,228,154,-416,-79,133,-209
+M77836_at,668,515,409,545,375,293,438,1674,572,415,462,252,365,417,333,683,707,646,1087,1168,329,400,512,510,873,768,1029,458,562,498,754,1177,680,591,549,380,899,1463
+M79462_at,40,109,99,91,76,126,115,464,210,167,44,25,339,333,337,142,412,112,313,460,43,189,13,168,234,343,328,174,264,117,421,533,103,279,253,170,505,579
+M80244_at,70,1122,1367,376,874,762,421,736,3490,1138,2185,560,1059,286,505,812,1893,347,1613,1264,199,697,140,699,1155,904,101,321,961,850,3003,1493,2040,887,1573,344,176,2919
+M80254_at,-88,109,-53,-111,139,46,-77,-214,94,45,40,267,70,136,135,18,184,10,-38,17,34,-23,30,209,13,19,-100,59,72,692,672,307,373,550,425,82,619,864
+M80333_at,885,593,1040,606,636,272,537,791,543,522,414,153,638,656,383,860,1098,573,477,828,216,468,431,476,509,527,711,536,346,525,590,859,687,340,438,529,412,1359
+M80335_at,427,469,331,462,490,318,220,167,856,134,242,140,192,1168,350,591,750,305,353,810,530,133,267,554,156,429,212,412,209,349,-67,457,342,346,113,117,269,74
+M80359_at,-18,-43,-231,23,353,30,-320,-100,-158,36,333,79,162,191,159,303,-131,0,191,680,176,-36,34,289,164,153,-269,232,103,-156,181,368,-131,110,348,-265,-279,74
+M80478_at,-2850,-2034,-3476,-2337,-1137,-3245,-3558,-4599,-2219,-1565,-1567,-1606,-573,-2067,-1783,-1482,-2080,-1388,-618,-789,-459,-2926,-2659,-1100,-1827,-1498,-4166,-3068,-1954,-2061,-2411,-2306,-1653,-1194,-1276,-3330,-2250,-2462
+M80482_at,395,210,437,378,254,87,332,334,276,259,159,156,160,310,131,292,519,213,206,242,93,315,212,252,161,253,394,352,329,277,161,313,302,165,265,154,266,433
+M80563_at,1510,1607,1198,2386,5347,394,331,256,4150,829,202,1618,452,3817,2179,1955,1441,1058,-6,322,768,187,275,1488,72,2999,1020,2472,836,7857,3397,766,416,3299,6915,3317,2268,2099
+M80629_at,477,368,453,829,400,524,502,1107,454,352,309,303,436,359,717,380,814,378,362,392,218,338,499,766,374,321,411,411,415,890,688,411,421,270,565,417,459,717
+M80647_at,-314,434,-320,-432,41,-42,-314,-1128,295,-260,-36,-329,-400,391,-185,-264,794,-276,-197,-317,-344,-493,-511,-399,-95,-173,-614,117,-79,489,-507,-412,338,62,30,1117,253,-394
+M80783_at,153,123,273,100,157,85,52,205,180,155,127,-1,188,83,130,116,197,119,44,192,146,61,112,205,80,116,300,147,132,152,114,74,114,0,44,-9,80,127
+M80899_at,609,329,599,1014,641,533,504,1031,957,206,244,215,106,322,58,334,516,21,158,68,419,323,423,517,265,195,316,861,807,1563,946,705,665,134,1643,1318,422,1111
+M81057_at,410,298,549,371,194,186,425,431,370,306,177,162,210,273,221,255,637,266,278,284,87,317,324,312,275,226,409,312,478,373,394,145,394,230,359,330,482,655
+M81118_at,51,130,239,87,190,170,164,106,176,143,38,-7,282,208,176,172,318,40,51,511,131,95,51,349,25,36,117,-59,-16,51,21,74,27,75,-104,86,184,122
+M81379_at,-42,-28,-94,-137,-31,24,-124,-140,-29,-135,-21,33,-5,7,-67,-24,-114,5,4,-9,-21,-60,-210,-59,-128,2,-151,-46,-177,-128,-111,76,-188,-15,-47,-167,-70,-272
+M81601_at,1467,2088,2087,1022,1279,1026,1268,800,2190,1164,1771,1097,2944,1608,1644,1733,2505,1252,1511,4255,2599,1098,1164,1354,971,791,965,799,759,1196,1553,1699,1359,875,832,1173,1679,1481
+M81637_at,67,49,27,35,83,-12,-1,31,37,31,-49,-17,48,65,76,42,223,47,18,75,17,79,-13,182,13,31,42,14,108,142,125,79,84,34,26,19,94,237
+M81750_at,-38,24,-47,11,123,8,-23,0,68,-45,23,-2,-7,158,6,11,119,17,27,48,-39,-11,47,25,-13,13,-46,24,-9,403,223,58,14,86,120,95,65,232
+M81757_at,19295,21939,18485,18865,21388,13146,13514,18831,21367,16008,19196,21376,18714,21071,23890,25832,19324,21979,22040,20522,13544,18009,14925,22750,21760,18762,14877,18342,18020,15251,19944,21063,20630,20787,18475,23095,23371,18835
+M81758_at,791,20,1085,188,452,613,914,1057,163,542,601,229,406,243,225,302,-106,490,319,734,154,469,283,232,625,194,-123,365,560,1019,975,808,845,346,650,892,791,1376
+M81780_cds3_at,263,120,80,225,118,273,231,-44,171,165,133,198,17,210,60,16,38,68,76,-34,34,223,77,57,139,110,-48,130,389,111,226,98,125,113,-18,190,250,253
+M81780_cds4_at,-144,-352,-382,-370,-235,-208,-420,-620,-212,-35,-270,-149,-62,-62,-93,-14,-141,-123,-134,-420,-21,-149,-94,-208,-194,-127,-359,-225,-396,-350,-527,-461,-272,-317,-454,-214,-107,-519
+M81780_cds5_at,769,227,987,392,545,793,638,821,778,372,48,110,528,449,198,571,413,167,333,440,279,432,406,921,-30,467,582,699,1389,697,100,233,365,309,1016,609,395,396
+M81829_at,279,299,330,294,210,264,84,317,247,113,168,201,234,185,162,437,276,263,95,412,119,239,195,255,122,104,23,376,214,134,52,159,229,138,248,309,165,123
+M81830_at,599,477,717,344,306,373,423,668,451,328,387,251,285,456,266,547,801,571,302,665,148,864,235,448,295,537,829,860,706,721,305,784,700,329,421,381,664,838
+M81882_at,81,20,54,75,22,44,84,-2,38,32,37,-7,22,63,33,15,74,-21,1,39,53,-10,102,11,9,24,100,13,-14,4,53,-5,-11,22,7,-14,76,12
+M81933_at,-240,-11,124,167,114,56,203,-86,124,89,46,44,192,77,96,120,98,89,82,120,161,111,22,-25,113,52,-203,179,214,179,330,407,313,243,229,132,230,282
+M82809_at,295,399,416,440,519,261,295,-16,205,207,137,160,256,44,337,434,836,238,186,400,357,156,226,250,195,242,472,451,406,195,257,248,514,-138,461,585,637,568
+M82882_at,313,1109,313,776,1180,129,1065,407,359,524,823,267,703,658,1159,896,1560,184,436,2027,737,704,340,1168,563,224,453,794,74,634,670,588,556,765,916,520,488,672
+M82919_at,24,76,9,56,-14,33,53,11,26,-3,17,8,-14,-3,-31,-32,4,1,2,7,64,34,91,-34,-7,-43,51,-35,26,17,79,24,5,-18,14,28,13,-21
+M82962_at,152,53,130,105,62,85,157,-19,-107,108,-56,18,93,0,-60,21,72,-73,-86,-79,-48,-170,155,7,105,134,139,85,55,20,48,101,97,23,38,60,119,-93
+M83088_at,1019,635,1252,853,701,933,482,1055,1846,718,773,616,1011,1365,1018,584,1187,846,303,1577,1372,408,955,611,360,611,1278,1288,322,834,600,534,584,390,1166,1398,784,619
+M83181_at,781,224,678,1016,451,572,530,656,825,276,534,465,408,903,411,495,748,396,167,622,799,687,193,396,578,589,646,577,476,612,374,538,479,480,453,528,380,814
+M83186_at,-103,-224,-385,-68,-122,-172,132,-398,-29,-86,-143,80,-186,9,-87,-88,-321,124,-77,-244,-161,-1,-117,225,-18,-117,-220,-172,67,83,-91,-265,-20,-149,-56,256,-123,-139
+M83221_at,753,1202,555,1484,897,810,1088,623,468,409,1508,793,454,642,671,481,631,978,202,422,364,1085,668,801,537,754,571,1342,815,3568,2465,1761,1701,591,2087,1330,749,2398
+M83233_at,31,137,263,379,302,122,356,244,698,-73,242,58,206,221,276,461,387,-5,180,1477,207,-156,32,667,-40,-6,79,-43,-197,-253,-3,-133,47,53,90,-39,-137,-53
+M83308_at,-1227,-1431,-1507,-798,-405,-745,-1500,-1082,-1236,-567,-1029,-569,-855,-1191,-818,-1284,-1973,-845,-1076,-1311,-744,-1191,-661,-904,-974,-1048,-1979,-781,-743,-1605,-1546,-1669,-1618,-512,-929,-1807,-1118,-1608
+M83363_at,182,68,130,-79,20,232,-122,25,196,-35,-13,106,-5,-5,14,-25,118,-100,32,70,43,-108,-34,-51,3,-101,-34,43,-180,-44,-89,29,62,7,44,168,-79,28
+M83554_at,-442,-265,-539,-315,-71,-320,-356,-595,-297,-323,-328,-137,-210,-298,-257,-379,-150,-22,-244,-394,-122,-213,-412,-307,-107,-158,-567,-264,-348,-376,-378,-442,-360,-170,-314,-266,-473,-479
+M83651_at,-619,-250,-466,-198,-175,-80,-488,-112,-269,-119,-68,-274,-138,-311,-302,-362,-155,-97,-176,-362,-181,-377,-167,-72,-289,-207,-355,-130,-379,-407,-554,-122,-187,-167,-197,-372,-448,-463
+M83738_at,16,66,233,-18,212,-14,77,-71,169,-18,42,-83,490,202,315,261,-337,30,116,507,1,136,-53,43,24,46,-37,150,-74,79,-117,16,60,-99,-87,94,140,-9
+M83751_at,554,1006,912,290,893,138,126,382,1752,1090,568,196,1140,367,890,518,924,393,574,2185,302,270,193,650,735,546,197,298,214,742,104,500,368,250,1173,650,196,398
+M83772_at,-181,-43,-190,-74,-60,-188,-183,-206,-49,-170,-77,-89,-139,-82,-89,-184,-254,-133,-90,-176,-131,-108,-197,-237,-134,-128,-212,-142,-93,-80,-66,-134,-91,-70,-139,-95,-187,-174
+M83822_at,-101,-18,21,-84,49,-64,-122,88,391,-41,550,2,203,359,56,-67,318,33,65,422,2,-112,-79,107,-119,-91,-114,47,-43,-166,-27,-87,117,63,-166,-104,199,-122
+M83941_at,-74,48,31,-67,44,-67,-67,-2,-4,-12,-39,-51,-5,26,10,-142,6,-80,-33,18,-11,-32,-94,-34,67,30,-34,79,-60,-106,-10,-95,21,0,-76,-2,35,-53
+M84332_at,3248,5401,5738,3042,2903,2791,2977,4907,6218,3525,4918,2592,2667,3245,2865,2850,3479,2480,2579,5268,1800,4676,2988,3514,2736,2349,2096,3520,1704,6129,4879,4840,5224,2875,4447,4218,6064,6358
+M84349_at,-102,-134,199,-157,-21,160,57,5,510,85,85,57,49,-62,-25,-34,-20,235,22,228,509,115,98,6,77,15,-42,-124,-187,-23,438,571,208,313,165,88,653,163
+M84526_at,-283,-65,-395,-367,290,-40,-366,-656,-231,-36,-152,41,-104,-140,-198,-102,-158,-76,-108,-58,-151,-243,-275,-263,-203,-53,-398,4830,-312,4573,6759,1569,-21,6569,7372,4833,141,2000
+M84605_at,67,66,109,51,74,96,15,86,79,37,96,83,-10,22,62,55,57,72,74,56,29,26,100,95,32,34,151,142,52,14,89,68,44,39,103,137,70,64
+M84711_at,15442,17789,19708,17589,17797,12827,15317,17450,18909,16337,11899,17088,18015,11890,14147,16668,12879,13208,16021,9865,22218,12208,13192,20515,11965,13846,19042,18547,17356,12363,4848,4863,18181,13555,16109,15030,13850,19490
+M84739_at,1627,5134,2478,1329,1483,2558,1624,742,3518,1329,2909,1192,1787,3107,2103,1405,5906,1829,1419,3362,-478,3085,894,2195,4161,1477,2440,3695,3568,4003,2229,3698,3116,1666,4367,6056,2980,2345
+M85085_at,-92,-103,-54,-15,18,48,-164,-224,-38,43,-155,-99,16,3,21,-126,-222,2,-65,52,-111,-37,-115,-23,-93,-86,87,-41,-86,-9,-19,-60,-33,14,-120,-149,-181,-67
+M85164_at,321,368,406,344,130,298,245,461,208,187,297,257,206,267,241,281,579,281,247,449,377,367,229,250,204,267,441,281,319,247,298,353,363,155,335,296,377,543
+M85165_at,134,65,231,67,115,46,40,-37,-29,109,5,12,182,-65,70,40,261,141,77,-23,17,115,53,73,207,192,-18,48,-105,10,65,93,113,436,-43,51,210,206
+M85169_at,222,532,1075,338,428,725,351,130,1210,356,818,287,884,384,676,596,138,591,657,935,678,273,-37,250,138,419,158,163,-9,476,373,72,346,101,446,36,174,152
+M85217_at,-174,12,-108,-92,-79,40,-127,-230,-10,-30,6,-64,-68,-60,-23,-161,-83,-203,-69,-131,33,-98,-214,-171,-137,-174,-150,-176,-139,29,-208,-240,-99,-133,-108,-99,-120,-221
+M85220_at,157,-9,-62,318,-336,92,191,-566,21,28,-446,285,-315,-47,162,-294,-635,-194,82,-403,-32,26,110,-299,-346,-338,-474,-263,235,-210,64,-375,-347,142,-82,291,151,-214
+M85247_at,654,452,758,578,316,346,537,736,485,490,412,306,385,344,405,620,712,432,510,413,258,449,379,456,454,458,572,702,589,600,474,490,493,129,328,442,657,757
+M85276_at,730,660,761,189,186,497,349,1040,919,414,719,311,430,3489,767,275,592,217,260,523,106,273,324,206,162,255,516,796,375,148,341,333,410,95,333,436,611,557
+M86400_at,6534,7503,9819,5832,6279,5395,4350,6610,11019,7652,6101,3417,11259,5407,6404,8023,9337,2797,5194,9913,3615,6739,4003,5995,4889,4125,3725,3432,1623,6668,4385,3189,5109,2978,10032,4763,5948,6927
+M86406_at,-175,-28,265,402,112,-21,220,-296,247,212,255,116,140,200,195,265,386,142,21,223,54,11,117,36,158,133,-48,-199,-204,-179,-23,-133,201,-14,-439,-317,-182,-287
+M86407_at,-162,-133,-138,-135,-15,-33,-72,-235,-96,-9,86,-109,-196,25,-25,-79,-64,-79,-39,12,-81,-53,-74,-174,-253,-74,-93,62,-69,-134,-59,164,28,-113,126,-6,-144,-74
+M86528_at,-9,93,-86,-52,115,-49,11,-97,-23,10,-64,-22,44,69,35,-32,213,91,2,52,-94,0,-79,-77,-87,-163,-87,-11,-64,-79,23,180,-74,65,104,184,-19,-69
+M86546_at,959,567,1137,935,582,695,989,809,700,532,540,475,594,676,355,723,599,543,572,1027,416,1264,661,437,648,849,1383,610,603,612,338,823,601,181,755,797,816,1116
+M86667_at,2283,2300,2501,2921,3814,1449,1648,808,3489,3490,4537,1748,2584,2475,3624,2729,4863,3079,2381,6413,9815,1460,2179,3494,1871,2221,1589,3368,1445,1497,1980,2102,2147,1521,2629,1594,2380,1939
+M86699_at,199,52,226,179,182,142,97,79,203,318,598,11,238,188,146,79,214,86,51,136,177,54,395,100,83,63,147,112,81,149,147,168,110,103,113,83,-25,88
+M86707_at,226,153,654,529,434,394,579,52,458,196,443,218,153,351,292,107,472,154,124,420,96,75,283,242,217,164,32,174,24,194,459,226,217,233,295,355,178,201
+M86737_at,732,689,1736,576,1456,1068,853,988,1962,1362,1446,267,971,851,1090,466,801,684,448,1283,573,496,818,1143,449,574,907,384,512,1116,748,900,584,388,1084,919,696,853
+M86752_at,294,-245,850,576,1966,689,-418,-746,799,909,486,586,1991,1236,1704,1037,763,445,1227,2439,460,35,632,1213,687,1961,-724,416,-192,-322,-258,650,-220,-83,685,-222,-327,-921
+M86808_at,75,19,55,7,-13,28,0,-41,36,37,-4,53,-15,32,12,13,3,15,16,26,23,138,39,-45,47,25,-12,50,57,47,17,-37,-7,37,-11,10,19,77
+M86826_at,-1587,-1068,-2226,-1507,-417,-1127,-1487,-1928,-1227,-735,-777,-300,-938,-924,-493,-655,-1056,-821,-636,-1506,-443,-1148,-1128,-1214,-944,-1234,-2085,-138,-379,-1245,-1192,-1586,-1069,-219,-1268,-958,-1473,-1822
+M86849_at,-131,49,-44,-191,-132,-129,-85,13,-10,4,-62,-35,-79,-94,4,-138,-71,-61,-98,190,-21,-98,-30,-141,-83,-85,-117,-182,-177,-138,-155,-194,-104,-15,-84,-141,-140,-16
+M86852_at,-56,213,244,45,263,-32,142,0,223,303,247,34,-26,344,183,243,205,336,-50,648,303,113,55,254,-32,-35,137,62,14,176,135,193,113,166,168,68,162,96
+M86868_at,-613,-593,-793,-722,-238,-492,-448,-1070,-238,-231,-323,-452,-579,-461,-364,-481,-433,-197,-285,-674,-299,-431,-720,-278,-394,-441,-700,-595,-783,-494,-504,-481,-365,-151,-731,-464,-305,-383
+M86917_at,128,65,206,204,157,144,154,269,264,165,381,198,102,166,220,95,208,124,88,127,103,252,151,187,127,86,114,302,151,327,196,198,286,142,263,149,191,470
+M86934_at,232,91,555,333,250,403,255,236,370,173,238,155,454,263,303,273,227,224,174,78,-6,150,174,282,49,196,301,307,276,264,179,71,242,55,120,273,264,317
+M87284_at,742,585,797,343,482,458,468,877,665,444,616,418,411,269,344,463,914,549,330,499,459,503,410,288,434,599,749,443,526,367,591,310,446,379,415,532,536,318
+M87338_at,154,45,22,-157,38,92,23,121,115,25,76,-15,110,26,227,25,25,193,75,105,-91,-82,119,194,24,-203,-50,-189,-105,-100,3,-41,61,109,138,-5,-50,-269
+M87339_at,308,291,610,222,249,579,210,367,658,216,113,83,557,294,565,224,817,378,270,433,817,217,349,417,226,237,70,250,103,206,392,421,259,271,132,222,170,120
+M87434_at,806,379,682,224,150,414,542,755,594,148,264,195,341,603,371,401,811,418,215,1696,168,452,330,607,494,386,616,503,418,364,476,367,484,102,489,481,444,1070
+M87499_at,19,-65,-99,-153,-104,30,-110,-10,-26,96,-93,-116,-38,-44,1,-147,-211,-66,-81,-135,-303,206,-205,-69,-27,-118,-84,192,4,23,-79,-74,-7,-21,-105,-9,-15,-51
+M87503_at,1619,1522,1504,1212,1157,759,954,1887,1110,670,721,472,1866,1522,2037,863,2196,870,626,4208,366,1214,1039,1420,2014,674,1062,1173,1312,2441,3712,3765,809,431,1562,1089,1480,4394
+M87860_at,-393,-281,-556,-503,-123,-179,-497,-565,-306,-101,-264,-245,-153,-160,-155,-245,-267,-106,-186,-281,16,-260,-222,-159,-254,-196,-450,-80,-343,335,-402,-336,-294,-117,789,-41,54,-443
+M88108_at,1988,2137,1782,1822,2202,1694,1361,1676,2825,1968,2964,744,2154,2519,2533,1744,3510,1457,1581,4824,2098,1519,1848,2575,1182,1533,1010,1724,1009,1139,1515,1191,1643,1691,1450,1676,2145,1443
+M88163_at,254,266,207,179,128,87,152,413,208,102,155,107,97,145,69,157,550,216,71,224,79,121,108,135,85,305,500,392,93,285,124,162,154,50,128,113,116,328
+M88279_at,1599,1763,2247,1309,1350,1312,971,1752,2655,1637,1290,372,1694,1396,919,530,5258,1549,728,2132,468,826,1117,1072,915,1382,1830,2703,1704,1241,753,1013,2044,364,1279,1185,1613,1462
+M88282_at,14,384,465,118,-34,101,258,-139,259,2,68,-50,-86,383,135,243,481,-118,160,855,565,18,222,338,-56,-81,90,12,327,-150,53,8,-31,87,97,235,-67,-139
+M88338_at,174,-22,315,182,170,428,277,425,377,7,74,343,-29,324,275,7,-270,-137,-53,224,36,207,423,309,214,190,-25,362,127,418,474,102,180,266,422,340,274,556
+M88458_at,554,275,401,380,765,202,285,481,656,240,375,199,539,393,970,599,1198,388,436,794,474,228,60,586,381,322,272,380,233,902,463,279,341,243,1145,315,525,394
+M88468_at,2605,1919,2948,2070,1920,2304,3090,2448,2419,2462,1686,1211,2046,1879,1029,2003,4245,1803,1067,2193,584,2292,1730,1966,1372,2529,3423,3250,2346,3075,1733,1461,2777,979,2779,2805,1927,2423
+M88579_at,70,120,181,134,59,152,250,28,111,53,13,34,131,41,139,129,241,152,22,118,2,-39,66,71,23,81,159,109,153,56,24,117,121,59,81,39,91,23
+M89473_at,554,197,198,226,278,337,366,527,123,346,272,143,173,232,145,193,365,264,207,199,46,232,207,264,221,297,305,471,387,262,277,311,334,199,216,153,291,465
+M89796_rna1_at,-45,-59,-93,-66,21,26,-82,109,-22,-56,-55,12,-24,24,-6,44,-60,8,-46,-86,-6,11,-53,77,16,-37,-142,-16,55,-67,-6,-41,37,18,42,-14,-103,-124
+M89955_at,-58,-153,-550,-642,-290,-476,-796,-875,0,-504,-155,-300,-138,-372,-261,-60,-880,-200,-480,-497,-268,-383,-264,-227,-50,-203,-907,-53,-468,-416,-623,-126,-423,-57,-318,-578,-792,-495
+M89957_at,2150,-512,-1046,1624,2986,-508,1198,1797,-597,-521,-565,676,2827,-472,2748,2335,-660,800,1869,6169,-268,397,-518,1652,727,3837,563,-248,-560,-691,-145,-128,-533,-66,-653,-669,-493,-1034
+M90299_at,756,393,654,797,601,640,1198,1166,849,620,530,573,491,375,461,611,946,106,629,544,328,572,324,300,624,275,780,541,418,843,900,1074,878,10,870,686,971,1291
+M90359_at,-188,-202,-731,-212,-137,-257,-228,-388,-278,-113,-162,-73,-78,-153,0,-125,-277,-57,-161,-108,-207,-228,-220,-267,-66,-134,-475,-123,-428,-120,-105,-267,-138,26,-208,-247,-228,-498
+M90366_at,279,250,278,472,256,368,282,359,234,134,213,135,158,322,206,227,410,167,221,369,212,245,292,413,258,367,294,367,238,304,407,333,317,135,215,201,418,361
+M90516_at,122,65,88,155,176,3,58,11,105,49,150,15,98,77,129,37,154,111,51,175,84,53,45,137,9,56,117,78,43,75,66,105,78,9,145,65,19,15
+M90656_at,239,311,184,107,275,492,687,383,523,160,258,77,194,340,256,671,357,141,784,1148,372,43,433,382,531,595,442,434,307,1195,651,581,250,725,201,75,316,334
+M90657_at,35,-85,-144,-58,-107,-152,-267,-413,-153,-134,-117,-87,-6,-44,-28,-39,-213,-67,-57,-132,128,-139,-167,-134,-80,-25,-312,-86,-242,-191,-152,-176,-147,-54,-1,-320,-195,16
+M90696_at,186,577,125,52,296,167,297,94,65,60,19,31,155,275,303,67,30,125,82,286,151,57,34,217,106,143,172,250,50,424,189,91,133,125,432,342,353,204
+M90820_at,8,-115,-96,-154,-19,-129,-68,-34,-53,-33,-95,-143,-73,-176,-118,-32,-202,-65,-114,-57,-87,-154,-106,-9,16,-95,-183,7,-103,-129,-154,-173,-110,-26,-175,-125,-64,-220
+M91029_cds2_at,485,1056,631,786,946,659,472,773,790,299,602,599,542,674,1014,689,1374,509,346,1748,628,687,503,1232,962,718,774,882,644,928,438,668,1493,333,598,35,645,1035
+M91036_rna1_at,7,1405,-33,6418,2139,-74,2377,3817,191,-10,278,80,59,1439,212,-17,1060,102,1060,15643,8,1498,298,200,12226,506,142,807,11527,782,1729,24744,3074,6879,989,1050,2964,18773
+M91083_at,486,653,639,710,391,705,825,830,484,449,267,603,382,525,952,749,463,465,503,809,187,495,723,-19,724,811,757,563,485,695,539,810,431,331,552,570,861,638
+M91196_at,-538,-482,-631,10,280,-85,-435,-629,-136,-113,-300,17,174,-487,640,-159,-491,346,-16,-13,-1,17,-463,58,394,109,-303,-479,-36,344,116,139,-494,30,243,48,798,290
+M91432_at,767,814,1547,831,1423,430,764,752,1777,426,472,76,920,606,1417,869,2031,954,532,3192,896,70,321,992,363,636,419,263,226,87,183,111,323,125,158,295,368,110
+M91438_at,165,504,54,250,171,39,1305,124,103,-18,97,415,82,646,99,112,5300,72,54,995,470,51,89,1101,902,188,-18,4849,533,20,2647,949,4038,2497,363,2801,13238,436
+M91467_at,268,209,371,250,166,151,238,346,243,202,182,178,186,216,168,175,229,198,329,169,81,300,68,277,289,269,436,185,230,267,311,329,288,159,250,217,327,430
+M91585_at,507,413,656,907,889,465,1213,686,636,634,665,323,321,1115,1363,851,955,466,736,1614,921,708,429,1069,693,905,594,778,379,616,1240,1443,409,827,690,422,926,940
+M91592_at,701,419,682,352,598,433,413,508,496,388,372,172,567,702,579,558,778,412,483,867,186,477,488,580,635,547,413,466,430,529,405,703,315,219,330,391,514,645
+M91670_at,485,1549,1244,700,1009,704,653,842,1522,2344,1204,334,711,810,1185,276,112,431,713,1155,104,627,457,327,871,408,406,692,259,1141,1464,1242,1643,664,794,639,704,1064
+M92287_at,4778,2700,4926,5403,3440,3179,3978,3293,7324,2676,6134,2056,10669,1912,9211,3345,2360,1316,2492,6464,524,3253,3796,4093,1689,5204,2581,498,165,1309,852,1484,1283,1525,811,1032,1024,1827
+M92303_at,592,364,1117,591,302,517,873,1356,730,658,603,214,481,692,364,712,554,562,585,370,590,323,615,503,509,757,749,906,711,580,704,540,678,302,519,583,674,1142
+M92357_at,132,306,108,86,-126,133,186,124,74,130,103,68,47,-71,-5,94,-325,186,-177,59,29,342,-85,-130,35,74,106,346,-2,2264,401,67,-84,41,2525,146,368,621
+M92424_at,230,134,401,328,155,110,339,482,258,111,98,139,62,203,191,39,272,133,95,149,92,98,216,215,212,158,422,187,177,135,242,338,170,111,157,292,167,206
+M92432_at,-288,-358,-205,-40,-156,113,78,-23,-141,-321,-52,-4,-463,-379,-349,-511,-710,-169,-295,-862,-299,-218,-286,-389,-259,-753,-375,-388,-151,-317,104,132,3,-55,-501,202,-187,134
+M92439_at,176,255,283,267,587,140,225,383,440,251,306,109,434,299,460,307,611,193,342,1138,167,184,212,441,134,281,215,239,194,95,102,90,159,114,196,139,172,199
+M92449_at,337,400,476,99,303,247,423,470,687,413,141,316,286,916,210,373,453,893,261,620,176,71,311,208,279,509,988,302,473,565,231,256,293,-5,493,313,445,443
+M92934_at,1722,62,132,800,647,46,9105,275,96,71,54,125,3185,77,795,121,21,34,1799,8,54,177,-24,6543,1322,215,131,75,168,293,89,40,274,57,103,104,83,261
+M93036_at,170,155,195,239,151,120,173,403,131,150,162,61,153,151,176,195,112,157,205,209,176,150,37,294,238,177,92,251,189,219,141,206,498,166,175,269,168,368
+M93056_at,83,921,58,483,1385,-3,488,-142,1240,254,851,712,409,88,789,367,3786,225,413,337,198,47,-93,908,366,129,-143,2365,560,2310,1178,222,940,2422,2364,1315,925,2968
+M93107_at,859,479,1142,435,705,341,858,509,764,576,569,195,548,337,605,570,582,548,456,1028,-103,524,693,641,556,420,829,600,271,692,732,581,664,215,429,395,922,989
+M93119_at,51,83,28,85,53,74,10,55,57,36,74,56,38,3,53,83,29,52,37,99,34,69,32,69,12,40,129,87,-12,94,50,54,124,17,96,102,84,76
+M93221_at,82,82,126,13,26,99,82,89,37,-13,108,5,356,76,46,161,-15,1,111,66,47,20,94,133,87,52,62,37,12,79,65,-22,30,22,1204,35,80,61
+M93283_at,891,631,1358,807,295,563,863,1580,854,396,684,521,269,1064,572,489,306,843,320,288,650,702,860,664,686,568,907,852,584,1042,1330,1381,912,202,683,936,974,1304
+M93284_at,177,143,412,117,167,227,238,545,290,78,221,11,132,230,141,172,146,247,90,212,187,239,258,217,184,134,391,236,214,353,145,295,392,62,180,91,165,518
+M93405_at,1042,713,1593,1280,750,686,841,1268,728,566,523,451,932,772,826,586,845,523,165,240,174,661,248,731,754,576,1139,699,360,1052,318,337,1160,522,1096,1353,1138,1096
+M93415_at,85,145,101,-33,38,30,65,101,81,-2,-6,-2,42,5,0,105,39,100,22,92,52,47,191,39,29,48,7,110,163,459,1,6,69,-9,-5,14,-54,111
+M93425_at,151,190,51,34,266,17,90,77,1,-6,41,406,399,22,115,165,305,134,229,535,133,296,150,192,269,89,115,190,38,257,360,326,285,387,401,159,139,387
+M93426_at,119,65,60,26,45,51,89,184,121,66,79,76,62,70,49,55,162,79,28,107,1347,60,112,103,89,91,1109,84,146,81,38,98,61,23,92,56,70,31
+M93650_at,434,236,766,536,286,601,651,865,588,363,387,415,460,451,385,444,1115,610,337,482,371,383,638,256,249,386,829,675,541,746,536,617,586,364,653,584,681,682
+M93718_at,1044,1298,1002,1642,792,1218,2070,2449,1277,1018,1153,1097,618,1162,1214,1381,608,385,993,898,398,1613,1430,1277,1566,710,2695,1713,1418,1484,1145,1520,509,590,1407,1703,2029,1184
+M94065_at,232,96,382,235,258,172,184,452,223,117,107,79,127,282,104,252,66,232,204,301,208,160,300,266,168,255,114,262,158,112,202,152,199,35,61,222,125,104
+M94077_at,-782,15,-336,-412,-121,-49,-142,-34,-259,-140,-472,-113,-189,82,-147,-141,-18,-225,-3,-539,233,-336,-153,-155,37,-152,-472,-211,-430,-137,210,182,-180,-157,-64,-158,-291,126
+M94151_at,-45,-23,57,-34,-81,-28,-80,19,-52,-21,-3,-40,-33,11,-15,-31,-7,-54,-32,-119,-37,-95,43,-53,-8,6,-78,-48,-62,-47,-23,-42,-31,-18,-58,-60,-121,-55
+M94167_at,-359,-918,-248,304,-80,585,-72,-155,-619,-93,-440,125,-184,-369,-174,-146,-637,-507,79,-409,-148,-260,-205,-696,-505,-71,-859,106,156,-340,376,-705,349,49,212,-238,169,-156
+M94250_at,2652,208,195,-199,-55,23,-178,1296,3,353,-34,182,2189,-127,879,845,97,96,597,1244,197,1936,-1,-141,630,68,1508,106,-271,13,694,34,844,-74,389,126,869,-373
+M94345_at,152,4563,3595,3054,2721,1783,3101,-70,4452,1909,2560,524,921,2400,2808,1557,1618,685,340,225,38,133,759,4133,1088,967,81,1322,1291,3531,1348,63,715,836,5438,2026,4172,1099
+M94362_at,949,1020,1468,1593,1131,1074,1661,1340,2222,909,1154,389,908,989,1249,846,1754,1186,776,1169,401,770,1039,1315,868,992,688,843,699,1127,953,895,1189,342,739,1056,949,1122
+M94547_at,-87,-419,-271,-592,1,-609,-902,-289,-38,-305,-108,-219,-84,63,28,-291,-156,-22,-518,-225,-28,-181,-188,-79,38,-23,-741,-166,-774,21,-1030,-225,-364,-71,-130,-481,-890,-1206
+M94556_at,814,943,1608,987,1958,629,566,526,1792,1047,682,227,1280,1366,1241,990,1684,711,741,3119,2577,264,849,990,754,1189,602,924,745,852,635,517,804,729,860,715,859,644
+M94630_at,3364,2491,3022,2583,2747,3367,3108,1739,5096,2671,2408,1460,3016,2623,3151,2175,4528,1533,2228,4869,1730,1535,2369,2826,1792,1454,854,2375,2084,2891,3019,2531,3143,1615,2503,2814,2152,1549
+M94633_at,287,-26,262,676,509,240,571,565,177,303,-77,30,177,3,600,222,-24,138,172,1828,187,-40,157,638,73,210,220,89,-175,59,-32,108,80,22,39,74,-20,100
+M94856_at,363,1049,2027,888,2064,709,719,488,1716,1221,772,429,2163,1411,1359,809,1043,419,458,2701,833,260,894,1773,573,452,650,591,577,815,520,247,955,129,1346,473,606,1049
+M94893_at,-507,-176,-733,-151,-470,46,-188,-170,-161,-172,-349,-22,-379,-459,-144,-512,-948,-400,-339,-819,17,-210,-104,-371,-416,-448,-225,-405,-223,-685,-99,-540,-689,-63,53,-105,-267,-849
+M95167_at,-91,95,-201,99,-7,64,65,68,25,-101,-29,40,-173,-172,-97,-71,-342,54,-40,-12,81,-137,68,115,-30,-168,-70,-71,-55,-147,37,-72,6,83,-75,85,-16,48
+M95178_at,254,68,685,444,250,362,90,512,241,-43,148,313,295,347,221,187,376,197,-89,15,17,226,303,355,256,252,-100,458,129,905,719,258,664,419,751,636,1012,382
+M95549_at,666,298,729,588,326,569,688,700,442,533,363,360,331,466,180,289,495,318,375,215,102,408,296,292,473,262,239,403,526,603,573,466,404,207,331,636,735,950
+M95610_at,182,598,318,434,422,167,655,880,708,465,178,469,364,508,338,501,515,643,193,416,383,177,186,447,412,491,704,688,466,839,312,734,719,370,1330,773,934,1737
+M95623_cds1_at,433,413,639,601,231,547,541,658,361,408,371,340,206,1209,300,398,177,200,644,704,283,296,621,339,777,355,236,431,1144,229,3108,2354,545,1475,359,380,426,808
+M95627_at,1228,1054,1927,1095,1197,1241,1883,1836,1660,1123,1144,744,1500,1450,1332,1294,1621,970,1216,2462,537,894,1039,1483,990,1227,1605,1275,1113,1565,1436,1676,1309,695,1381,1748,1467,1802
+M95678_at,1275,1876,864,917,1333,946,1159,2985,1749,1193,506,455,965,2125,1312,1270,1747,742,1562,3383,822,596,512,1044,1563,1253,1569,3670,3623,2939,2613,2699,2292,1354,2445,1569,1942,4832
+M95712_at,871,348,1286,601,605,604,633,1590,904,462,390,317,450,395,402,125,292,365,164,522,485,674,752,505,419,491,613,905,637,813,524,205,556,93,545,758,494,1119
+M95724_at,90,107,153,246,94,92,99,166,52,119,158,38,74,71,155,175,29,71,91,67,139,43,102,215,101,109,97,96,139,142,47,4,119,113,83,113,107,220
+M95767_at,72,267,173,154,172,71,38,62,133,121,110,33,128,130,83,87,369,165,42,85,103,-2,-53,271,161,117,190,192,134,325,5,35,144,106,311,91,99,198
+M95787_at,111,109,278,-230,-24,163,-89,-338,18,-91,102,-116,73,58,222,359,205,249,222,61,602,139,-163,415,166,244,291,459,447,573,-228,91,581,291,363,-217,-20,348
+M95809_at,149,-84,94,114,240,-23,75,98,111,49,-44,48,124,252,325,77,371,110,58,397,83,-13,178,353,81,57,31,6,-24,55,8,143,8,61,-28,136,75,-81
+M95925_at,-178,-152,-206,-381,-212,-481,-715,-217,-373,-205,-257,-135,-167,-379,-222,-75,-193,-85,-86,125,-98,-379,-486,-346,-203,-98,-158,-236,-204,-341,-174,-381,-549,30,-148,-357,-35,-333
+M95929_at,-9,-377,-294,237,337,-186,226,61,262,114,318,-14,47,-75,124,455,-382,-277,476,286,74,219,-191,178,-179,333,-580,221,-153,340,-236,-73,105,372,468,-70,-38,600
+M96326_rna1_at,782,368,1268,882,949,910,826,1302,1337,82,737,1296,160,838,520,478,7,-144,45,-862,343,678,1177,734,502,29,176,13464,1233,7955,9933,2676,548,19615,9994,7791,976,4108
+M96684_at,-292,-310,-398,-238,-10,-154,-299,-407,-277,-173,-217,-214,-113,-262,-46,-187,-906,-412,-165,179,-213,-521,-231,-316,-213,-109,-596,-288,-235,70,-208,-474,-407,-147,-322,-283,-307,-504
+M96739_at,1008,636,1065,708,699,549,966,680,810,510,1156,819,563,733,479,1010,916,847,434,799,469,689,733,627,574,780,1103,482,413,922,498,373,799,420,281,588,992,1079
+M96740_at,50,51,-36,42,23,-23,82,145,49,-4,59,7,30,93,-20,-2,222,118,27,76,152,49,108,34,78,222,117,54,4,61,52,24,87,47,38,-28,101,56
+M96759_rna1_at,135,148,47,135,87,58,73,101,156,183,-28,28,16,84,253,122,135,98,41,95,108,-103,199,-34,55,57,248,80,420,-15,79,155,193,350,156,47,180,71
+M96789_at,-601,-271,-570,-462,-105,-135,-240,-691,-249,-414,-142,-40,-307,34,-275,-289,-714,-323,-296,-557,-93,-385,-30,-257,-242,-291,-270,-392,-418,-396,93,-429,-414,5,-306,-75,-139,-734
+M96803_at,1805,771,3423,1619,1223,1956,1240,4532,3332,1199,2199,909,1533,1283,1205,2102,1377,852,1732,3691,202,1450,889,1122,778,1343,1411,1038,810,745,774,657,1041,315,781,731,1687,1080
+M96859_at,490,113,834,472,284,56,225,598,154,332,172,81,385,319,212,437,491,287,311,411,158,472,404,412,390,133,661,674,372,368,393,649,410,58,287,53,360,931
+M96944_at,179,-83,-169,-57,6,-85,194,155,18,-31,-76,-117,-8,-150,-70,-11,-167,34,-56,-39,-71,30,-241,-29,-18,-54,183,-271,-33,-31,-310,-195,-36,-34,-185,-95,-89,204
+M96980_at,160,10,374,169,222,275,257,353,267,295,224,123,234,279,-15,284,-61,250,120,-200,394,171,303,215,162,104,39,316,158,495,358,437,314,74,-207,125,185,452
+M96982_at,1772,3305,3001,1441,2518,1378,1880,1016,3894,2652,2705,536,4161,1623,2438,2284,4299,1219,2097,6790,3333,1582,1916,1901,589,2282,1090,1940,1086,1872,2544,1940,2569,1590,2129,1831,2254,2804
+M97287_at,1122,3212,1882,1083,534,1111,1796,2138,1179,949,997,688,1003,653,2771,1701,2637,271,1263,4035,1476,605,1413,1732,1849,964,1125,1315,841,767,1071,1178,1861,1170,1034,1157,2744,1208
+M97388_at,199,468,294,238,403,85,176,269,317,146,359,86,182,305,261,262,355,110,220,451,259,133,262,221,166,118,170,183,108,329,255,238,384,238,291,193,276,253
+M97496_at,333,249,575,223,189,35,247,202,310,236,2,-33,-14,-140,-254,228,390,2,195,263,-69,185,-119,-40,153,84,452,-135,-122,401,175,368,377,-17,341,196,-138,598
+M97639_at,-107,-142,-745,-219,-114,-227,-247,-62,-209,-204,-91,-204,-198,-216,-216,-102,-649,-108,-80,-174,-118,-95,-245,-251,-186,-265,-607,-201,-189,-168,-412,-272,-184,-214,-309,-137,-198,-244
+M97675_at,-119,11,-78,-91,-69,-58,-186,-196,-76,-149,-43,-33,-71,-122,13,-30,-118,-57,-57,-20,46,-120,-34,-55,-94,-66,-54,-181,-113,-88,47,-41,-115,23,9,-132,-144,-174
+M97815_at,645,104,737,659,110,369,851,812,359,452,417,238,30,197,166,566,555,269,221,169,308,175,512,540,299,297,635,629,586,213,345,604,638,171,303,517,571,999
+M97856_at,1174,958,2018,977,1184,1235,1023,814,1548,855,1401,580,883,868,1566,747,1273,850,484,1587,510,247,1132,1234,621,728,453,684,822,1051,806,530,1040,562,586,982,708,352
+M97925_rna1_at,793,512,919,232,295,739,961,1064,515,735,580,142,404,533,294,536,665,516,484,622,239,513,127,474,352,448,859,710,860,745,823,672,739,151,717,261,625,1122
+M97936_at,-646,-694,-407,-815,-326,-608,-1275,-1128,-657,-558,-595,-419,-91,-139,1039,-752,-900,-383,-436,71,111,-209,-39,-600,-369,-531,-1467,-754,194,126,1779,163,-858,-157,-1150,-929,-934,392
+M98045_at,493,155,358,850,618,275,831,508,185,375,262,109,1376,37,1556,682,97,345,965,1120,239,912,98,1271,564,959,680,313,177,259,-123,134,199,77,163,625,507,335
+M98343_at,-218,-284,-361,-76,-117,-273,-176,-181,-234,-201,-183,-143,-151,-267,5,-294,-185,-140,-158,0,-439,-172,-144,-473,-94,-173,-470,-698,-666,-321,-62,-50,-83,-133,-305,-294,-132,-253
+M98447_rna1_at,422,167,75,270,14,337,349,538,371,132,133,277,221,107,105,345,80,209,132,62,219,240,254,221,43,117,104,327,497,374,33,20,47,214,-17,378,155,464
+M98528_at,-57,-3,-87,93,25,-49,-36,154,49,51,-72,-140,-103,-14,-21,-79,-84,-47,1,-74,-89,10,-26,-6,-31,10,-120,-117,69,46,-41,-29,-136,97,-115,-117,-206,-128
+M98539_at,643,385,848,301,280,430,665,841,668,367,460,353,485,338,238,629,852,587,465,494,267,419,514,456,446,482,948,828,795,752,615,1005,831,334,584,575,1485,1097
+M98776_rna1_at,880,653,1141,608,434,353,944,1352,1288,265,367,452,438,1606,390,668,1481,551,414,901,247,549,556,671,706,631,1317,566,593,516,550,1016,708,348,347,817,585,1210
+M98833_at,463,160,177,506,672,53,384,377,371,82,86,67,373,532,831,605,710,219,320,2370,562,160,68,835,116,279,494,218,125,87,141,98,114,99,108,119,322,181
+M99063_at,504,107,144,184,143,144,292,91,214,276,92,107,256,237,31,483,704,352,189,512,156,107,186,216,328,432,328,63,226,-192,314,474,152,33,362,398,137,550
+M99487_at,-87,-2,-132,-37,-62,-53,-45,-193,-33,-84,-78,-133,-40,-24,-80,-54,1,-39,-33,-72,-107,-133,-91,-22,-89,-71,-234,-114,-67,-132,-101,-96,-95,-7,-72,-78,-103,-164
+M99564_at,-165,-66,-261,-161,-56,-197,-94,-91,-46,-112,-44,-99,-218,-20,-35,-158,-173,-41,-59,-157,-103,-98,-260,-90,-86,-259,-237,-62,-199,-128,-33,-122,-136,-53,-100,-52,-130,-163
+M99701_at,1404,383,843,770,944,437,665,1021,447,458,282,411,1338,457,531,864,2050,456,473,1282,883,584,495,503,598,505,1433,1094,692,604,169,407,567,333,992,631,814,494
+S34389_at,113,-41,-904,-134,230,-654,428,76,-717,-125,-117,160,210,-24,98,312,-872,-204,151,137,-157,57,-427,333,17,336,-223,144,180,141,195,91,52,117,-59,10,178,149
+S39329_at,-14,-10,-108,38,-52,-24,-3,-95,0,-106,19,-31,-121,-86,-79,-39,36,-86,121,-121,-73,13,39,-113,-64,-132,-204,-96,-67,-214,-73,-67,-153,-23,-86,-98,-41,-110
+S42303_at,-74,-30,363,29,-7,44,-31,88,130,27,376,4,-43,-2,-23,65,-10,-13,-34,356,173,-40,24,-30,19,-15,68,-63,-76,-93,0,49,-29,-18,-20,-39,89,-49
+S42457_at,12,-24,-12,-69,7,-7,-53,-8,-9,14,12,5,-25,-5,-38,-25,33,3,12,-39,29,-27,-64,39,-39,-47,3,-23,33,-15,34,-49,3,34,-3,-23,-59,-81
+S43646_at,702,560,870,591,290,286,534,557,573,272,433,316,187,562,328,534,573,444,459,326,223,405,349,363,350,353,740,489,367,555,483,525,736,49,559,282,647,836
+S45630_at,480,309,480,471,120,106,566,715,294,200,311,321,136,149,126,200,274,206,159,240,163,240,448,119,254,93,305,282,360,471,597,381,424,81,321,532,476,862
+S46622_at,394,194,261,297,344,76,169,221,263,109,213,122,586,148,426,210,91,118,241,454,221,168,151,486,303,392,136,47,134,170,105,31,119,59,145,163,235,165
+S48983_at,-161,-51,-80,-38,-28,-42,-42,-71,-101,36,-99,-11,-37,-29,-49,-21,-96,-21,-24,-35,-61,-43,-81,-69,-54,-37,-103,-150,0,-64,-64,-114,15,6,-70,-181,-37,-129
+S50223_at,268,346,804,452,476,256,208,310,640,152,441,90,545,570,571,235,352,-65,84,867,323,241,493,502,301,101,20,56,168,-73,-53,62,107,150,-1,31,210,-94
+S53911_at,777,576,1165,1061,1630,513,803,10911,608,568,506,1667,1835,644,4576,503,4628,537,3070,12261,353,677,478,836,1268,1316,935,682,2825,594,672,781,5528,551,702,765,5796,2479
+S55606_at,160,103,92,47,17,5,-55,11,27,2,32,45,33,121,65,36,73,-32,-7,37,44,19,32,205,19,63,67,-18,14,-13,27,50,6,-33,47,100,78,39
+S57235_at,-2825,-2482,-4098,-3628,-1600,-2036,-2955,-4767,-2774,-2416,-2189,-2075,-2037,-2416,-2001,-1739,-3163,-1670,-1980,-2616,-692,-2382,-2836,-1990,-2168,-1595,-3130,-2572,-2818,-2101,-2387,-3220,-2732,-1016,-794,-2282,-3818,-4185
+S57887_at,62,78,95,63,18,33,26,101,91,33,43,-45,15,101,-2,63,35,8,32,8,28,34,83,-7,30,21,82,7,60,13,91,-12,48,55,-5,65,26,18
+S58544_at,93,114,96,47,32,58,95,121,61,66,87,67,43,89,34,32,44,26,14,50,108,74,51,149,29,57,40,63,36,95,72,54,82,14,86,129,102,177
+S58733_at,301,257,305,152,181,-208,283,-46,-57,26,76,-27,228,242,-11,238,447,368,203,639,149,-6,-150,6,271,315,381,-48,137,158,166,459,354,-106,474,-323,365,309
+S59049_at,267,1797,92,47,161,74,67,860,129,227,123,79,227,48,457,513,210,1119,308,2326,366,184,81,43,614,71,311,191,40,245,681,149,1056,3,198,103,367,694
+S59184_at,149,38,96,73,8,49,-11,1,148,-45,-14,-12,112,78,2,3,156,19,40,60,24,65,64,7,55,22,-3,110,31,92,28,73,83,102,162,14,68,65
+S61953_at,161,152,61,-35,132,225,164,52,94,207,152,-90,69,177,116,-51,342,138,19,156,27,323,-3,-47,194,-8,1038,249,-88,172,-34,75,217,14,212,375,211,252
+S62539_at,-31,61,66,-42,-24,-3,-10,-14,35,41,32,12,19,40,37,36,207,-22,16,202,386,-1,94,-9,-56,9,237,32,-21,-32,16,-29,-59,-15,11,17,34,9
+S63912_at,483,552,659,201,675,709,235,613,723,312,214,166,578,446,801,582,519,140,461,945,77,388,493,870,340,94,505,250,365,485,303,807,586,412,376,555,399,851
+S65583_rna1_at,659,905,1182,725,392,453,910,1325,647,437,678,515,365,371,663,425,1279,615,596,629,227,469,835,525,740,320,1358,589,694,572,1109,1046,1071,407,653,609,1153,910
+S65738_at,288,2986,605,132,294,561,319,199,1988,763,1720,155,98,612,-7,308,1779,104,32,1467,1689,1054,860,453,121,16,269,401,391,307,596,692,1406,364,1238,876,1007,360
+S66431_at,268,406,71,295,284,170,146,43,249,93,616,20,452,695,627,323,483,212,199,1438,158,302,77,433,-19,357,194,-69,21,19,201,60,128,211,-14,-32,184,199
+S66793_at,253,-29,85,248,-208,286,183,281,333,236,-157,162,-104,-112,-259,-260,263,-133,-292,-147,-29,-71,108,-450,-459,-345,323,-10,-327,-161,-22,235,366,-182,186,268,351,367
+S67070_at,521,759,745,1056,457,1017,1250,211,364,484,247,679,564,425,627,1052,-511,599,489,318,371,455,1018,130,879,686,833,326,218,340,528,314,399,604,367,1217,1479,733
+S67156_at,16,59,-36,63,77,113,-5,34,-59,-19,25,10,-17,41,91,-53,125,-76,-29,-32,132,-5,210,53,-7,-48,-18,-47,4,47,-66,9,-13,-11,-17,-34,-53,-39
+S67325_at,206,445,355,265,387,204,188,299,259,212,154,199,153,420,407,178,434,385,246,923,264,244,258,364,303,240,136,227,428,150,513,597,326,205,263,309,195,252
+S67798_at,54,89,84,119,26,96,45,280,74,72,21,73,43,115,19,183,6,79,77,123,78,31,113,97,26,34,112,84,43,85,68,101,174,45,120,53,115,-25
+S67970_at,46,-39,101,14,66,85,40,-49,56,0,22,25,50,-15,87,-25,-37,3,24,83,-48,19,115,-2,90,36,65,108,-28,-75,37,12,-44,77,21,-37,21,-27
+S68616_at,1351,454,1042,1098,722,569,1077,955,824,663,635,567,713,566,910,1150,38,836,961,1435,574,953,858,828,817,866,694,1514,983,630,1063,1392,786,436,1357,1548,848,2606
+S69115_at,887,627,436,820,1576,119,520,577,737,288,334,939,1585,2069,986,1065,-558,80,433,357,14,285,1,1075,703,970,-236,603,129,340,585,375,535,321,370,251,750,479
+S69189_at,138,87,203,176,163,83,139,71,135,124,84,-4,103,121,93,114,201,49,59,149,82,117,93,196,105,150,70,41,197,105,66,106,167,55,79,68,84,150
+S69232_at,17,33,-190,-141,11,-24,-62,-260,-26,-114,-31,-83,17,21,10,-27,17,-33,-30,-32,21,-28,-41,-56,-26,-79,-137,-81,-62,-125,-87,20,-84,-82,-67,-36,-109,-25
+S69790_at,82,-38,-87,10,46,-23,33,-10,-42,3,-39,-15,78,-13,33,-50,44,-223,-46,52,84,43,-153,92,-13,61,-126,-43,-81,-65,-28,-11,10,-39,-66,-40,-51,-77
+S69965_at,-202,-294,-245,-458,-264,-483,-267,-461,-265,-79,-89,-99,-95,-279,-173,-212,-343,-99,-213,-296,-54,-303,-182,-107,-173,-170,-444,-172,-461,-342,-180,-112,-250,-167,-434,-227,-261,-586
+S70004_at,-45,-122,-14,-4,-7,-44,6,-80,-53,-70,-55,33,-42,-96,-17,-22,-130,-55,-92,-93,-4,-78,93,8,-20,-55,-206,-12,-12,-8,-32,-39,29,-14,-101,73,-35,-200
+S70348_at,175,196,155,128,178,103,241,259,267,193,124,172,187,149,151,156,193,159,179,246,99,183,51,219,217,248,159,112,247,98,181,482,207,45,239,179,273,338
+S70585_rna1_at,-125,-153,-184,-226,-81,-302,-213,-254,-152,-88,-88,-132,-43,-51,-86,-87,-138,-64,-132,-118,-87,-136,-115,-294,-20,3,-162,-120,-7,-103,-236,-63,-35,-118,-130,-362,-242,-147
+S70609_at,465,358,687,330,121,286,532,481,455,-42,278,271,272,190,434,73,-9,327,222,537,74,487,153,242,492,407,630,303,-33,424,732,914,458,78,73,289,478,910
+S71018_at,-121,-124,-327,-157,-157,-149,-201,-197,-180,-171,-163,-74,-93,-175,-122,-178,-271,-136,-160,-169,-97,-163,-34,-117,-152,-156,-240,-218,-170,-206,-154,-167,-157,-111,-94,-213,-238,-327
+S71129_at,77,98,323,47,-2,115,144,236,87,45,103,-22,8,126,6,-44,340,68,141,106,92,243,136,64,190,74,284,144,91,14,112,261,35,43,38,285,73,296
+S71824_at,400,258,499,508,236,344,448,406,378,422,227,239,264,237,280,326,204,184,211,330,212,277,357,350,247,331,419,343,129,413,266,448,571,106,19,351,596,786
+S72008_at,1569,2501,2200,1354,1513,876,645,964,2692,1003,1082,612,1746,1714,1678,1430,1816,870,1020,2355,2068,810,1231,2040,616,837,705,625,608,630,596,420,930,1393,810,894,1013,919
+S72370_at,-51,-225,-39,1,-37,-24,-68,-316,-274,-8,-78,10,-112,-183,-157,-96,-17,-173,-135,-84,58,-83,-74,-20,86,-52,23,-6,16,-40,48,-126,-194,-178,-338,13,-39,-470
+S72487_at,398,472,500,426,207,408,307,554,470,434,324,357,142,188,329,227,-143,77,298,149,29,207,283,350,362,38,355,519,324,529,803,443,472,327,236,528,422,745
+S72869_at,93,0,27,-27,96,26,57,92,89,24,87,38,49,89,47,40,78,157,62,85,82,86,53,91,14,67,54,55,14,132,57,211,167,31,102,83,213,84
+S72904_at,285,124,249,105,67,65,136,227,140,64,93,120,192,82,108,86,178,125,77,193,92,120,161,171,78,147,151,164,144,166,31,114,83,2,106,47,167,83
+S73149_at,1237,1203,1757,787,804,819,1103,1800,1013,882,829,820,1213,1243,1018,1291,2563,1185,991,1898,812,1183,678,1070,838,1416,1763,1496,1560,1539,1513,1744,1223,603,949,1440,1884,2233
+S73205_at,28,0,-35,21,-22,16,38,44,17,28,12,10,-34,-19,-6,-11,3,62,10,-6,91,-58,24,-52,-5,30,4,61,19,8,65,39,37,3,-20,30,-17,67
+S73591_at,9564,2174,11482,4112,3787,6328,3832,6217,5881,542,3427,860,9004,8365,5774,6176,12218,4752,7751,13039,1978,1520,4259,4265,1693,5172,2769,6133,6386,6334,6207,15019,4458,2377,718,4475,5387,2012
+S73813_at,97,116,244,132,179,190,-52,-47,-50,126,-32,179,140,104,143,85,334,418,53,162,24,71,210,23,179,196,220,289,98,116,209,83,27,67,132,205,272,101
+S74017_at,64,674,-51,254,364,-26,275,160,115,118,141,349,340,378,471,372,903,185,798,480,337,456,-37,508,96,252,-26,158,-4,612,529,110,650,1162,197,74,731,996
+S74221_at,409,318,489,558,663,284,342,382,681,479,597,209,509,622,808,420,486,286,596,1155,939,326,366,619,453,361,416,456,223,420,413,511,327,435,669,265,268,243
+S74445_at,701,193,342,350,-37,506,614,304,530,368,253,185,-33,368,302,239,516,336,185,-25,-66,606,528,367,254,508,445,351,562,-70,576,178,1096,30,410,238,-69,826
+S74683_at,212,156,180,135,161,104,156,166,41,132,137,173,69,135,27,-89,102,-53,68,-175,67,83,-85,167,24,153,62,-16,141,263,388,-14,155,37,234,213,103,322
+S74728_at,192,66,210,241,305,5,99,215,323,140,179,48,249,125,207,89,164,216,146,308,124,210,121,228,130,140,236,178,199,109,104,133,247,27,43,196,142,159
+S75168_rna1_at,509,416,849,965,899,334,924,581,563,392,334,571,509,1988,700,578,1403,435,541,1000,71,672,397,787,725,720,779,846,954,812,514,828,1065,460,428,786,1627,1608
+S75174_at,-545,-379,-769,-440,-183,-704,-512,-721,-429,-458,-308,-441,-331,-400,65,-470,-771,-264,-737,-656,-203,-939,-628,-313,-1080,-472,-539,-966,-533,-465,-1213,-1322,-1467,-279,-157,-495,-998,-1377
+S75295_at,184,234,68,102,255,83,3,106,150,143,101,73,291,157,187,84,284,115,76,281,164,91,-26,42,135,162,17,-110,163,101,213,206,190,117,208,90,118,265
+S75313_at,2,-7,-23,-13,-18,28,-1,0,-9,-10,-24,-8,28,17,-4,-21,-19,11,15,-71,44,-6,-36,-18,15,0,-25,52,-45,10,-52,8,-6,-49,-22,17,30,-90
+S75463_at,1102,1722,1473,1860,2806,1187,1608,908,3821,2253,1913,1411,1751,1973,3576,1846,1855,1195,1762,5553,201,957,1426,2173,990,1588,710,1465,872,1844,2012,705,1575,1539,2297,2617,1310,-197
+S75989_at,290,72,408,323,205,273,359,-32,200,301,212,178,162,89,142,333,195,166,196,326,107,226,178,105,288,281,370,221,69,141,333,89,195,106,154,189,322,138
+S76067_at,115,-5,-13,-25,-19,-3,16,-50,-88,-95,22,-48,4,133,-20,-146,25,-48,-39,-68,-127,-3,-24,-137,-17,-66,9,-34,-76,-22,-145,27,43,-33,16,-34,-43,-23
+S76475_at,220,98,281,206,115,42,87,55,213,73,161,106,146,154,140,251,323,77,67,145,126,138,189,162,186,252,231,160,-9,-4,228,195,231,41,313,168,182,334
+S76617_at,-219,-317,-116,1440,2370,-165,1312,-214,487,-231,-410,-60,1122,421,1481,1101,-292,263,207,1380,9,1268,-205,605,3,26,-477,-330,-262,-401,-200,-97,-267,-62,-413,-302,-442,-279
+S76965_at,199,194,764,286,217,350,129,35,632,310,229,12,31,226,151,118,47,190,46,523,289,125,203,131,90,70,255,59,64,52,83,80,125,25,39,107,95,157
+S76992_at,824,276,897,661,313,-44,756,614,253,590,264,94,365,266,409,797,-164,179,304,281,-14,847,450,523,384,593,488,602,67,395,438,317,421,-49,198,375,384,458
+S77094_at,-527,-634,-598,-584,-292,-549,-625,-94,-535,-518,-485,-285,-500,-714,-404,-373,-599,-285,-138,-229,-199,-451,-723,-619,-167,-301,-710,-558,-153,-395,-944,-635,-769,-342,-267,-665,-767,-360
+S77356_at,1376,1835,2034,1129,1193,1676,1097,3781,1881,3238,887,830,1451,4067,1161,1364,311,1455,2533,2270,906,1493,1734,3089,925,936,1741,7193,1565,4162,3157,3488,2840,947,6896,1828,2203,2438
+S77361_at,73,88,164,40,25,28,42,122,116,38,72,-15,-19,111,58,72,56,62,36,45,-57,44,119,73,65,6,117,123,84,123,1,93,84,25,77,15,63,164
+S77393_at,-91,-29,-217,-78,-32,-78,-80,-50,-184,-65,-170,-68,-77,-73,11,-8,68,-96,15,-15,-18,-14,3,5,-35,-1,-176,-106,-74,-17,-8,-75,-42,103,59,-187,-91,18
+S77415_at,221,207,367,39,102,160,250,391,250,100,111,244,152,159,128,137,286,190,161,370,163,224,332,316,221,113,433,230,76,118,132,206,215,95,45,251,166,393
+S77575_at,17,-90,63,-12,-22,-8,11,-19,1,-14,6,-50,13,-56,-18,9,20,-35,5,-54,46,52,-13,30,51,-41,-31,-55,-93,-86,-10,-47,8,-19,-100,-7,-70,-29
+S77576_at,337,203,518,216,181,200,238,584,290,222,248,196,177,217,141,243,751,286,295,213,288,368,260,341,260,272,483,517,339,295,256,315,327,102,240,364,210,479
+S77583_at,96,80,-76,23,-8,17,-107,52,10,-24,19,57,-35,0,-31,-66,383,-67,6,-78,-1,68,-15,-34,39,18,190,-9,-115,-10,19,62,0,-67,7,11,-59,-1
+S77763_at,127,334,295,301,254,165,436,632,211,-3,175,206,339,1604,311,236,4640,263,265,623,-19,282,62,421,862,213,582,672,567,113,462,1186,468,643,104,313,304,866
+S77812_at,489,301,939,290,327,494,670,1067,345,561,594,283,258,366,238,668,611,573,448,541,323,848,602,684,541,545,704,717,649,168,201,818,614,117,484,476,720,1134
+S78085_at,804,-302,966,499,177,407,677,1054,-229,323,405,278,369,469,-116,426,692,296,-239,98,203,588,281,647,-310,296,874,373,560,422,-526,-525,430,-171,476,366,484,531
+S78187_at,350,507,1596,355,259,1267,420,620,3445,1169,1137,201,778,2014,782,384,1127,537,290,87,444,315,1668,272,249,460,345,920,242,679,40,255,436,311,-36,393,381,313
+S78203_at,402,256,228,524,298,87,415,481,318,200,185,149,139,130,405,251,511,99,238,255,52,177,229,393,306,251,203,291,312,317,311,276,309,162,359,306,463,266
+S78296_at,500,308,510,415,179,366,262,773,485,152,308,196,222,418,191,349,768,391,287,444,268,300,254,255,299,291,557,334,223,463,357,588,361,129,155,309,478,698
+S78432_xpt1_at,-219,-84,164,27,233,90,110,-4,61,186,158,40,346,205,144,141,424,279,102,389,177,285,197,-176,181,223,-1,266,-394,244,174,263,241,-13,-369,85,252,300
+S78569_at,17,32,-7,-6,16,-7,40,-20,-17,4,11,64,22,0,7,3,-26,-11,12,13,-27,-7,-13,22,-6,50,34,21,60,-7,-47,36,-61,-17,38,-9,41,-5
+S78653_at,152,123,131,164,144,120,201,221,170,94,136,153,120,139,120,117,299,97,77,73,63,125,226,101,149,79,247,178,264,129,212,153,167,74,180,281,180,252
+S78723_rna2_at,-57,55,33,-24,-31,40,-10,13,50,114,40,40,-1,56,-39,33,29,38,-24,26,-88,-15,-32,3,-17,12,128,-57,-24,86,-25,91,82,11,22,73,153,-28
+S79048_at,277,131,123,213,52,200,10,259,234,95,223,159,41,226,90,92,-75,43,82,167,67,-18,172,213,-99,53,-59,-53,-36,107,-31,-43,201,-29,-56,108,205,129
+S79267_at,342,227,297,262,238,190,283,412,230,231,200,120,312,169,145,229,370,209,255,251,117,187,193,205,198,258,450,257,271,268,287,271,307,113,156,238,250,449
+S79281_at,6,48,-11,-7,2,-5,80,-140,14,-7,6,30,-84,-18,-45,-80,113,4,-84,-50,4,-73,-66,-167,-120,86,6,-49,-86,-59,53,-21,-12,50,98,22,-103,-43
+S79522_at,14205,15373,15172,11692,16152,10269,13311,14573,14373,12134,15329,11853,12943,15848,13888,14027,14701,12768,13978,17910,19835,12524,15316,15752,15527,14697,10910,15300,15379,12997,14451,17141,14340,12572,14645,10235,14806,15554
+S79639_at,446,517,693,209,260,501,463,407,468,367,278,333,421,474,373,335,381,527,290,546,94,342,248,137,254,195,356,490,432,451,338,224,457,13,241,126,523,528
+S79781_at,130,32,12,-24,192,55,-53,95,-3,26,-17,-93,-33,73,-70,-86,192,65,98,68,89,52,15,47,122,124,64,-37,48,53,20,250,23,209,119,-112,-18,62
+S79854_at,-299,-565,-614,-750,-319,-604,-596,-734,-611,-471,-493,-454,-257,-363,-356,-379,-451,-263,-431,-405,-294,-485,-414,-430,-323,-264,-700,-269,-646,-601,-717,-618,-631,-226,-702,-833,-779,-948
+S80050_at,235,187,352,123,116,-17,144,496,108,39,131,70,109,221,25,126,449,146,213,370,154,406,157,169,191,73,50,328,55,111,439,292,129,81,121,19,183,598
+S80335_at,139,173,236,62,83,-3,95,-223,-77,159,-51,176,68,1145,67,771,-32,351,312,80,-177,32,134,-117,55,252,-158,-124,-201,107,384,43,150,182,901,465,238,186
+S80343_at,62,-131,-25,-31,277,133,-13,-143,-24,-149,8,-21,53,158,114,125,133,28,23,536,214,3,-96,44,-3,-41,-123,-10,60,65,-130,275,-189,-30,-31,-167,-228,-134
+S80562_at,10,-11,123,12,23,7,-52,-58,273,202,25,67,283,52,-31,-47,-27,144,63,396,47,-2,119,-45,26,-22,-67,-39,28,10,-28,-34,80,-31,42,-28,-56,-75
+S81003_at,1020,1526,1656,994,1323,771,687,578,1852,1073,2436,426,586,1119,1066,626,228,513,389,541,635,622,706,1249,657,608,373,799,610,966,922,577,1177,1437,1797,1768,699,1243
+S81083_cds1_at,55,49,153,-29,96,140,89,113,-13,106,448,126,96,101,73,91,-27,11,200,136,-51,98,169,63,329,119,156,148,315,148,357,482,258,322,187,-145,51,381
+S81221_at,-463,-344,-534,-312,-285,-384,-551,-584,-466,-80,-309,-143,-233,-183,-290,-240,-863,-327,-159,-16,-118,-328,-36,-529,-314,-303,-721,-491,-343,-548,-113,4,-439,-298,-548,-528,-513,-579
+S81294_at,157,169,174,217,36,177,211,262,119,-22,154,130,-31,134,7,22,-14,117,-11,-5,39,175,11,-63,174,5,283,-31,182,138,216,280,255,-57,135,190,263,270
+S81419_at,330,139,174,96,127,247,319,499,233,205,162,145,139,169,138,193,315,226,88,222,141,245,359,352,235,246,389,284,348,167,148,235,212,46,193,341,142,338
+S81439_at,233,268,287,51,240,106,80,182,138,109,171,150,573,105,285,157,200,217,528,238,378,523,102,137,210,876,261,540,449,237,267,653,555,117,463,317,897,511
+S81578_at,-60,-102,-330,-124,-122,-211,18,-187,-105,-54,-102,-232,-33,-47,-101,-90,263,-84,-29,0,-78,-209,-43,-254,-130,-179,-211,-42,-161,-107,-148,-147,-123,-135,-174,-94,-106,-259
+S81893_at,268,33,111,126,203,131,63,49,229,196,177,112,138,150,172,263,362,204,138,132,174,197,132,309,210,227,156,285,117,154,135,181,217,51,63,134,309,242
+S81914_at,-111,219,-18,-222,-83,-5,-208,-370,124,71,23,196,26,-101,-120,-179,-77,-57,-81,571,88,-139,-113,-42,710,-65,-287,15,-122,3023,3033,-24,293,-37,961,-91,-98,1815
+S81916_at,13,95,65,38,16,21,126,193,61,95,98,123,66,49,84,67,133,61,28,14,108,91,144,110,43,81,106,142,120,62,74,31,112,107,93,49,123,84
+S81944_at,-182,-103,-65,-160,-85,-112,-124,-151,-121,-88,-14,-126,-78,-83,-41,-60,-202,-57,-55,-101,-108,-156,-64,-105,-121,-104,-256,-107,-216,-106,-145,-159,-215,-83,-101,-30,-90,-196
+S81957_at,62,-115,-116,-56,77,-21,277,-137,-114,42,-81,-17,-34,-98,-22,178,38,16,-32,21,6,14,-56,-128,-31,-11,398,-157,-96,-31,-10,-106,68,-57,-30,49,65,104
+S82024_at,236,196,181,209,104,55,235,149,205,169,149,51,102,113,209,182,197,111,151,61,103,136,176,94,146,169,261,138,100,124,36,209,169,138,186,143,227,309
+S82075_at,-315,-175,-272,-315,-198,-234,-315,-818,-261,-108,-187,-208,-23,-346,-53,-55,-660,-85,-128,-170,-271,-119,-254,-35,-70,-113,-294,-131,-456,-146,-441,-1058,-112,-133,-395,-345,-130,-563
+S82185_at,92,37,155,57,38,101,87,86,58,89,-19,48,34,57,42,67,53,72,-39,-14,-46,-65,13,121,-58,42,101,-228,-137,-19,-272,-122,-63,-66,-38,7,137,-20
+S82198_at,2029,1624,1230,1558,1004,1747,1470,1253,1075,1702,1196,1552,1193,1634,993,1259,2306,998,1124,1798,723,1301,1698,1124,1359,1621,1365,1462,2303,1976,1267,2369,1581,965,2070,2252,1482,1690
+S82240_at,-89,-11,-91,-126,-106,0,38,65,-79,19,-59,-53,-46,-46,-35,-4,-166,-68,-9,-38,-28,-44,-15,-68,28,-31,-78,-89,72,-35,49,109,36,-91,-59,-82,62,19
+S82470_at,958,926,812,907,1447,677,951,967,1052,1250,872,1093,1075,553,1057,871,5157,581,894,1868,684,623,530,1333,1070,1408,979,2775,1752,1282,1036,1653,1959,1218,1862,2925,3869,2442
+S82472_at,-65,-56,-7,-72,-37,-48,-15,-58,-46,28,-87,-38,-46,-45,22,-32,-78,-22,-3,-6,-12,-14,-13,-29,-42,-8,42,-74,-76,-40,-103,-47,-73,-26,-46,-62,-29,-98
+S82592_at,1,70,103,53,39,55,18,98,56,43,50,5,14,52,28,22,56,51,20,-4,-24,-35,37,46,-5,7,64,69,33,23,3,22,64,70,15,23,27,104
+S83198_at,-892,-420,-745,-910,-338,-376,-707,-980,-505,-440,-441,-451,-460,-422,-246,-286,-973,-321,-436,-376,-139,-707,-383,-636,-397,-302,-902,-539,-471,-523,-504,-417,-455,-269,-658,-1029,-608,-787
+S83249_at,-87,-90,-9,-59,-39,30,-62,10,-16,-39,-46,-104,-111,-11,15,24,-62,-54,-94,-141,-163,-57,-81,-150,-6,-59,-68,-55,-26,-2,1,-240,13,-5,-21,-22,-25,-48
+S83308_at,63,5,31,-23,26,-32,45,40,-16,18,-14,-11,48,11,53,58,49,67,-12,76,23,-35,56,-52,5,63,125,80,31,-2,-1,12,-1,33,116,-56,-21,31
+S83364_at,134,743,652,448,844,446,312,290,835,167,1045,436,222,715,847,216,154,369,100,897,192,179,647,535,215,350,392,574,197,612,722,489,524,832,1199,397,638,348
+S83365_at,-755,-588,-707,-347,-29,-487,-702,-847,-580,-586,-610,-455,-365,-480,-140,-307,-440,-395,-348,-639,-386,-686,-613,-315,-478,-523,-680,-644,-706,-604,-673,-716,-706,-297,-483,-431,-668,-1137
+S83366_cds1_at,197,81,239,131,111,188,36,173,181,89,175,41,141,172,134,89,105,156,66,81,27,112,66,130,21,131,103,186,293,158,110,55,188,85,143,206,144,142
+S83366_cds3_at,9,66,132,-25,44,-10,-73,-115,0,43,12,41,84,78,83,17,-60,71,152,72,33,-26,37,6,9,91,98,107,60,92,-1,82,12,55,33,-68,74,97
+S83549_at,-393,-219,-241,-417,-205,-462,-470,-637,-283,-520,-154,-313,-212,-382,-245,-315,-149,-343,-268,-212,-68,-326,-452,-465,-288,-303,-582,-530,-490,-156,-331,-438,-522,-181,-201,-635,-464,-668
+S85655_at,173,372,384,-215,894,645,-300,-833,620,477,240,280,1131,399,655,607,61,61,72,1144,-14,-342,24,205,525,229,303,-22,-226,131,-52,-140,131,-41,366,491,134,-934
+S85963_at,301,-210,-393,-4,-57,71,-154,259,-5,-136,-130,64,-50,-221,-84,-89,-124,17,-109,129,-64,-2,-334,1,186,76,-550,-46,74,85,49,-72,-2,-83,-266,-214,-251,-41
+S87759_at,357,813,418,336,242,117,359,461,344,222,1281,215,311,397,267,314,450,187,283,735,302,383,429,246,295,194,267,346,214,196,576,698,295,274,345,396,374,548
+S90469_at,652,512,555,372,483,410,567,547,390,332,336,255,427,322,463,483,439,560,251,630,44,490,440,388,531,480,475,408,567,563,386,652,582,391,368,473,544,618
+S94421_at,-752,-798,-799,-895,-587,-641,-614,-770,-897,-529,-629,-590,-531,-815,-608,-592,-1473,-694,-485,-767,-207,-610,-742,-580,-543,-486,-1099,-806,-697,-576,-792,-780,-763,-579,-1329,-804,-1237,-825
+S95936_at,-62,-79,-281,-152,-26,14,43,-113,-140,25,-49,-73,12,43,-155,-134,-414,-76,-5,-59,59,-74,-121,175,-46,-9,-156,186,24,33,-78,-80,-8,-37,-186,166,-37,61
+U00115_at,37,438,86,5,77,40,-1,-4,148,747,159,390,44,48,208,240,203,103,94,32,1462,209,49,110,230,165,70,28,-84,1678,302,198,220,117,1009,0,722,539
+U00238_rna1_at,51,137,92,342,206,48,199,80,131,216,-2,38,242,329,172,53,290,103,37,444,117,-44,170,92,201,41,356,186,177,22,127,-65,60,65,65,30,-39,64
+U00672_at,-20,292,200,137,288,88,100,298,57,78,4,87,121,411,179,179,-680,293,49,203,111,125,-36,95,77,244,262,126,158,728,441,-27,313,122,272,88,367,448
+U00921_at,1656,2629,282,106,395,117,36,-26,369,295,275,93,467,2042,293,411,3232,66,115,110,-46,-15,68,80,508,2047,50,497,283,881,282,-13,511,440,1047,779,1197,146
+U00930_at,371,389,155,496,274,279,502,562,421,228,213,149,121,424,86,392,541,279,412,259,148,96,45,366,308,292,502,538,466,216,131,21,80,157,302,380,169,493
+U00943_at,482,438,507,368,282,222,322,472,385,338,372,179,222,343,233,366,849,285,237,320,246,409,338,266,320,226,449,400,459,416,406,441,489,125,318,346,461,568
+U00944_at,73,109,192,155,56,-5,70,94,30,84,22,-20,128,93,54,98,239,42,74,148,14,-58,60,129,6,41,100,36,48,62,195,119,-15,41,2,70,150,212
+U00946_at,-194,-194,-108,-100,-66,-26,31,-136,-139,-163,-118,-139,-149,-150,26,-59,-236,-176,-37,-173,-37,-130,-188,-160,72,-82,-331,-171,-84,-81,-63,-82,-142,87,-233,-71,-122,-219
+U00951_at,-208,-335,-158,-36,-318,-64,-73,98,-316,-181,-309,-204,-451,-246,-477,-161,-194,-516,-233,-428,-191,-75,-127,-252,-140,-256,-122,-264,-40,-509,-89,87,-233,-62,-465,-196,-194,-99
+U00952_at,1319,1172,867,636,793,473,611,1464,1202,864,1016,298,662,592,479,705,1337,280,968,1563,-83,1753,623,660,724,1620,578,641,702,464,295,356,695,162,495,587,3629,490
+U00954_at,-375,-319,-476,-385,-176,-403,-455,-479,-345,-259,-251,-211,-191,-273,-201,-233,-362,-238,-211,-258,-219,-325,-338,-224,-270,-233,-516,-299,-327,-241,-343,-361,-253,-143,-294,-255,-408,-482
+U00957_at,-81,-28,-60,-24,73,-64,43,-130,-49,-62,-59,-45,49,46,10,-5,-49,-2,-47,37,52,-74,-26,71,-66,-62,-93,-149,57,-45,-35,-63,-98,18,-67,-56,-84,-130
+U00968_at,702,1621,985,660,552,673,725,721,1495,1432,933,363,1112,532,761,924,1914,864,777,666,582,659,695,518,1007,889,75,1409,617,1160,1217,924,1629,729,2901,998,1233,1700
+U01038_at,1265,716,1642,1645,889,748,1697,1082,1451,1097,1176,648,1074,839,943,1000,1070,870,748,876,322,785,1166,895,763,806,996,1038,1276,1401,1750,1308,1199,440,1198,950,1347,1694
+U01062_at,17,56,30,-88,-322,128,-268,-230,314,57,-129,-129,-124,87,-115,-120,377,55,-127,-184,214,-37,-189,-308,-282,-13,-289,-185,-247,-328,-303,-286,-286,-207,-112,-129,-365,-44
+U01102_at,-201,-130,-256,-86,-46,-144,-97,-491,-101,-280,-74,-199,-198,-236,-74,-107,-208,-180,-38,-134,-91,-185,-199,-213,-149,-244,-175,-245,-238,-158,-201,-232,-157,-113,-194,-167,-140,-188
+U01120_at,155,191,276,211,113,197,151,164,155,263,131,-4,93,196,74,197,149,140,340,157,89,65,157,55,55,45,289,268,418,94,185,147,65,114,371,444,165,254
+U01147_at,363,383,252,495,347,519,515,386,292,274,146,192,331,302,521,369,29,247,246,503,216,300,393,641,241,227,280,57,216,413,376,315,379,195,382,324,597,472
+U01157_at,180,38,241,329,105,206,238,238,180,144,61,142,129,95,65,165,127,153,82,140,-46,206,328,61,95,106,25,366,57,253,130,275,171,178,-91,137,235,329
+U01160_at,276,116,114,175,251,305,211,223,183,108,46,47,191,206,206,79,106,-51,173,176,137,15,87,194,140,156,70,157,137,74,9,55,138,86,154,105,153,13
+U01212_at,822,1528,1843,388,851,860,678,2009,1286,1444,63,501,1551,1744,1005,1515,463,839,1128,962,259,1296,547,1313,1483,1053,815,1203,1642,1354,1083,1666,1714,892,398,1561,1860,1683
+U01317_cds1_at,-444,-236,-563,-796,-148,-473,-403,-643,-51,-507,-62,-67,-384,-444,-352,-387,-561,-426,-241,-253,-329,-353,-397,-214,-117,-326,-1099,-172,-269,-249,-157,521,-325,-179,-374,-912,-710,-670
+U01317_cds6_at,78,80,3,-67,45,-56,230,305,284,-8,126,2,29,0,-16,191,320,34,379,630,-56,62,125,13,657,171,28,55,79,11,2692,3995,155,1100,301,-68,115,1611
+U01824_at,649,198,476,302,69,348,566,490,511,361,348,214,503,134,256,157,203,198,173,233,472,312,440,705,423,430,614,528,555,198,406,574,-1,226,187,443,341,309
+U01833_at,102,-85,-57,-142,128,-112,-5,-215,27,24,80,-135,264,34,46,114,82,271,85,215,186,-146,32,85,7,-40,-67,-26,-252,22,-175,121,-75,173,70,-248,-81,-250
+U01877_at,236,357,96,89,529,122,87,239,248,57,360,61,105,199,419,81,161,127,29,354,-92,170,229,333,130,128,70,115,62,286,353,487,218,299,179,62,265,389
+U01922_at,-229,-203,-307,-209,-168,-291,-122,-257,-338,-202,-160,-136,-122,-178,-198,-167,-417,-122,-91,-180,-148,-130,-245,-320,-208,-91,-181,-412,-428,-188,-142,-442,-227,-278,-189,-94,-223,-563
+U01923_at,810,519,195,371,474,96,173,365,276,349,229,479,1110,678,515,546,585,154,184,768,307,209,271,318,211,147,265,70,170,204,170,355,360,454,233,281,299,306
+U02019_at,73,-49,33,44,69,177,-97,-98,93,137,83,68,98,-7,-36,131,436,104,-269,-3,8,-211,-18,41,-47,47,325,61,-177,126,-49,-124,-12,34,79,52,-33,-540
+U02020_at,176,1140,115,68,217,-16,63,89,89,315,289,344,242,168,193,188,333,293,100,343,362,202,49,52,199,37,115,606,69,6163,5287,984,2019,524,1155,401,762,5789
+U02031_at,-118,225,273,-169,194,259,-391,-305,710,471,775,-50,157,280,114,21,-13,425,-57,-174,-102,-359,-37,140,-324,62,-808,-561,-889,280,-59,25,-65,62,-180,-189,465,-421
+U02081_at,23,638,90,4,84,30,115,149,160,148,297,34,300,102,22,29,259,142,101,219,37,74,195,52,109,24,28,128,139,129,361,1112,410,279,107,65,37,174
+U02082_at,81,62,223,75,51,60,16,158,133,49,161,31,111,172,37,88,27,155,77,97,58,85,45,96,143,130,54,120,60,177,117,140,171,67,69,71,86,188
+U02310_at,500,180,383,213,138,126,75,646,133,193,207,96,223,216,244,361,380,200,246,423,138,442,89,233,163,179,517,170,218,300,188,240,248,94,317,241,174,420
+U02493_at,6944,5941,8794,5557,5972,6141,5939,5656,12087,5852,7936,5453,6550,5630,5794,4226,9016,3245,2798,8924,5539,5061,6955,6328,3664,2996,3157,4418,3368,5130,4145,3996,5078,2199,4955,5190,4560,4896
+U02556_at,805,678,491,280,152,197,297,305,550,562,386,458,777,199,180,401,915,233,173,754,749,230,191,333,664,381,123,318,115,421,422,276,620,161,337,175,331,322
+U02570_at,2027,1753,1540,1266,1235,785,1265,1403,1481,744,791,569,1122,1338,1055,1046,2177,762,333,1188,610,644,809,1742,720,1286,1304,847,1411,2163,648,596,1135,618,1258,1909,1401,1265
+U02609_at,-514,-443,-716,-402,-123,-311,-450,-778,-363,-359,-376,-468,-192,-286,6,-134,-346,-229,-134,-80,-159,-419,-480,-96,-428,-64,-1106,-452,-271,-458,-657,-498,-437,-404,-749,-723,-818,-854
+U02619_at,383,715,463,960,627,592,1184,1322,691,601,659,336,-60,687,861,788,417,707,1096,1112,187,876,490,599,682,677,600,634,771,1039,497,-546,236,242,566,962,435,1277
+U02632_at,281,219,453,298,172,231,277,305,266,286,258,222,241,269,179,262,458,290,191,261,102,223,205,378,178,295,427,250,293,342,247,222,305,135,307,289,378,316
+U02680_at,101,188,190,54,159,8,-3,88,83,90,277,44,61,98,163,105,20,87,55,297,344,119,60,141,62,35,81,99,100,116,118,127,56,47,101,65,152,53
+U02687_at,-91,-128,-512,1515,1288,-307,2644,-203,-384,-293,-185,67,1235,-95,2202,-145,573,-147,73,100,87,-133,-311,4235,626,-117,71,358,88,383,-147,-58,335,0,646,735,1467,-185
+U03056_at,-123,-15,-204,-25,-58,-99,-166,-370,-247,-93,-171,-64,-13,-74,-63,-44,-246,-140,20,-108,-251,-35,-102,-89,-104,-96,-289,-31,-153,-188,-71,-164,-110,-162,57,-164,-78,-307
+U03057_at,1018,1667,1749,931,1419,112,398,1890,5915,916,3394,395,2875,511,1315,550,898,4066,1731,1619,1409,77,182,1684,-20,2088,-450,4788,812,1407,1850,3311,3138,2129,2889,766,4293,1844
+U03090_at,-179,33,-492,43,-170,193,-52,-260,-14,14,48,-123,-94,1,138,59,157,168,160,114,96,61,157,-100,23,-114,208,-169,125,303,447,234,-149,151,57,79,-210,803
+U03100_at,356,131,46,255,156,108,90,236,149,60,112,44,368,111,270,225,83,157,214,359,448,368,-55,307,104,205,156,146,-4,306,267,186,136,62,213,170,106,329
+U03105_at,546,1138,480,482,532,216,504,821,596,378,553,217,1197,643,605,559,922,494,487,832,1183,519,163,874,585,763,671,684,266,1060,171,381,938,390,408,340,640,1037
+U03187_at,-262,-668,-547,-706,-256,-451,-426,-958,-652,-404,-803,-224,-496,-280,-437,-511,-213,-370,-468,-919,-239,-312,-533,-122,-519,-418,-1154,-323,-543,-415,-866,-858,-684,-331,-377,-565,-528,-978
+U03270_at,357,252,329,317,224,353,687,797,326,269,319,303,198,340,239,428,1318,296,351,286,662,397,366,417,390,379,629,473,363,513,423,567,484,262,428,456,571,630
+U03272_at,906,125,334,201,187,280,294,211,350,177,238,209,124,214,133,330,282,248,171,115,216,166,288,200,204,217,438,294,228,398,226,311,235,209,212,316,356,311
+U03274_at,-1038,-884,-1135,-896,-518,-857,-972,-1515,-970,-670,-742,-740,-470,-826,-690,-691,-1613,-573,-356,-1030,-1048,-822,-796,-983,-735,-551,-1403,-557,-904,-960,-898,-959,-801,-376,-1155,-999,-880,-1156
+U03398_at,720,499,991,853,255,846,964,1424,906,268,413,615,197,533,406,467,157,604,230,271,607,574,670,572,534,282,480,488,706,741,713,835,624,203,502,711,580,772
+U03399_at,72,-283,-92,-261,-362,48,-105,-34,12,-322,-119,-136,-418,-415,-133,-301,-522,-104,-152,-186,-77,-19,-37,94,20,98,-32,-508,-293,-2,128,4,243,255,-551,-166,-246,-103
+U03486_at,355,267,485,578,335,321,403,493,329,288,215,204,286,284,136,382,628,280,379,413,264,337,271,515,394,344,456,447,283,285,370,350,381,343,272,466,519,527
+U03634_at,316,270,322,499,158,323,472,520,314,56,131,350,73,346,177,30,333,-70,182,222,142,366,378,301,133,54,342,186,293,117,360,368,279,50,238,286,336,210
+U03642_at,1234,695,1389,1726,817,1196,796,775,1151,936,810,344,675,899,801,1230,275,732,714,1095,495,823,1356,909,887,843,1234,1274,459,1032,773,921,1234,422,897,855,1186,1374
+U03644_at,215,235,102,151,218,103,100,251,185,65,229,11,98,253,223,188,204,110,123,361,197,192,256,181,158,95,-95,268,16,250,387,291,332,198,167,92,217,196
+U03688_at,-38,9,-9,6,23,24,18,0,9,-9,-11,2,22,52,-9,-37,15,30,18,-55,-11,-13,-13,27,25,18,7,-10,19,31,105,27,18,-26,48,17,25,73
+U03851_at,345,345,158,192,479,200,231,368,460,217,110,232,669,240,508,819,535,364,186,1254,510,142,123,391,236,493,291,264,105,438,447,292,280,194,247,289,250,555
+U03877_at,-154,-31,-209,-90,-33,-181,-189,-290,-32,-66,36,-27,-137,-59,-60,-65,-56,-87,2,-70,-122,-170,-60,-21,-70,-141,-23,-88,-96,-79,-125,-114,-14,-26,-87,-156,-227,-121
+U03886_at,119,66,131,154,60,28,156,148,130,131,40,54,67,82,49,146,193,91,65,27,94,99,117,108,59,71,228,129,45,92,96,58,95,11,112,41,82,135
+U03891_at,416,21,344,136,81,321,460,583,307,228,130,168,6,460,137,261,37,1363,104,160,383,-98,395,324,32,104,386,242,161,689,1356,321,60,443,120,780,169,451
+U03905_at,-521,-391,-663,-498,-288,-385,-537,-400,-294,-456,-388,-293,-363,-380,-221,-553,-706,-369,-347,-343,-202,-351,-425,-391,-298,-384,-613,-543,-281,-528,-472,-410,-467,-234,-272,-456,-589,-688
+U03911_at,-22,-12,62,-91,228,-26,0,-140,277,22,52,-25,213,127,238,100,204,66,-15,238,282,-102,-119,114,4,-34,-78,28,-120,-171,-85,-89,-43,-11,-60,-205,-103,-174
+U04209_at,226,122,124,255,177,69,147,28,79,32,61,73,68,238,229,153,230,175,92,220,116,81,189,175,72,52,151,-84,-31,125,83,133,127,69,56,14,122,211
+U04270_at,84,-66,-62,-54,5,14,166,-295,-61,208,-62,-346,207,62,20,325,412,-28,282,390,-42,-14,-172,-18,138,244,-61,-274,-177,-259,147,242,82,290,25,-13,146,-293
+U04313_at,-126,-113,-101,-18,-114,-90,-171,-70,-100,-182,-106,-104,-98,-33,-105,-146,-82,-97,-44,-127,-59,-71,-83,-56,-75,-91,-151,26,-79,-162,-90,-113,-92,31,-3,-103,-295,-231
+U04325_cds3_at,181,42,158,-22,68,48,132,190,90,83,82,35,61,105,17,23,26,76,40,30,49,141,75,70,84,102,176,22,62,51,82,94,132,-42,-137,22,63,6
+U04343_at,103,133,257,156,110,96,201,118,94,211,143,74,104,136,52,174,149,191,67,169,217,137,89,151,144,164,280,171,211,262,293,309,140,67,253,213,277,304
+U04520_at,167,29,184,149,38,92,164,40,118,120,152,68,92,65,26,95,127,48,6,85,-47,134,70,-7,18,74,248,224,180,101,259,243,165,165,104,60,88,299
+U04735_at,4,151,14,20,50,-103,60,47,48,28,174,31,186,70,57,38,22,42,23,95,141,78,70,55,-20,53,45,43,7,37,125,71,120,75,176,36,53,147
+U04810_at,-207,-289,-309,-164,-143,-120,-142,-472,-77,-173,-139,-48,-8,-219,-92,-169,-76,-232,-238,-279,0,-160,-210,-181,-173,-199,-336,-344,-278,-8,-220,-206,-291,-187,-485,-300,-276,-106
+U04811_at,355,395,455,292,149,439,336,428,613,307,522,181,437,236,123,172,194,131,182,475,198,222,505,255,230,204,496,307,288,209,180,276,286,75,174,363,474,449
+U04840_at,193,153,282,93,147,209,136,305,142,112,116,7,103,179,101,221,61,55,109,73,76,145,189,219,96,150,264,122,108,76,57,96,167,50,62,137,144,214
+U04847_at,-30,82,216,123,18,5,168,-257,130,149,259,-12,174,108,204,54,378,16,81,430,-27,151,3,222,61,126,-39,-23,64,-210,-101,37,56,-58,-54,69,149,109
+U04898_at,9,491,-28,-60,-58,0,-181,-25,-37,51,80,66,11,636,-67,-2,-180,-64,7,-29,43,-60,45,-106,-48,-38,-153,8,16,-26,11,33,-42,-63,-238,-60,18,-9
+U05040_at,833,658,980,891,856,576,730,418,891,561,544,334,472,464,1179,492,1343,527,852,1390,810,783,763,527,722,776,1134,675,512,407,509,1211,967,443,458,756,416,1019
+U05227_at,-43,-31,-158,-38,30,8,28,-35,-35,-96,-23,-10,-60,-20,21,-13,107,-19,-40,-83,-8,-58,-51,67,-83,-73,-103,-81,-149,-81,1,22,-28,0,12,0,-1,-88
+U05237_at,940,977,1097,635,886,855,759,851,1026,274,2233,262,721,1630,1336,516,900,395,298,1622,1129,842,423,1486,641,740,389,713,567,103,212,723,336,299,173,224,1042,361
+U05259_rna1_at,9326,895,628,5314,5354,282,5146,4048,423,585,147,2504,5075,155,5767,3649,218,3339,2696,8148,2805,5397,870,5955,5070,8219,4184,711,654,-14,218,251,-2,412,343,272,306,19
+U05291_at,733,472,704,763,461,449,631,743,567,439,477,326,578,563,328,481,465,467,343,664,392,532,400,543,519,489,891,629,476,552,473,611,597,313,535,477,671,701
+U05321_at,-154,-237,-234,-69,-36,-51,-131,-284,-106,-169,-34,-71,38,-139,-52,-142,-432,-108,57,-97,47,-121,-100,-175,-139,-130,-147,-196,-230,-147,-156,-165,-166,-117,-204,-128,-220,-304
+U05340_at,661,207,699,1470,1461,695,542,-136,1391,839,530,99,1625,307,1851,670,1077,1586,738,935,404,385,657,1118,405,948,378,776,-28,1473,248,941,557,576,415,20,311,221
+U05589_at,-172,-151,-163,-116,-78,-108,-95,-220,-93,-112,-82,-90,-60,-153,-96,-147,-257,-97,-41,-99,-128,-177,-144,-122,-194,-127,-194,-153,-137,-71,-126,-162,-87,-49,-102,-170,-148,-207
+U05659_at,1273,796,1273,1451,693,832,1283,1811,1045,508,774,686,613,813,658,918,1623,729,1206,1392,490,1033,811,671,1240,812,912,1134,1096,1081,2449,2253,1374,1020,1155,1058,1553,2883
+U05875_at,323,1011,256,1326,208,401,455,469,351,634,-112,949,527,153,770,791,1163,746,-76,1568,363,473,820,77,546,654,905,197,153,1663,1816,-184,558,376,1988,198,967,1300
+U06088_at,409,2,326,-83,472,-120,-243,379,160,89,229,35,137,181,360,53,345,111,91,339,48,469,231,419,208,200,-10,270,117,687,-259,253,330,75,105,102,38,119
+U06233_at,77,71,107,79,42,80,84,119,76,20,39,5,48,63,35,24,117,42,48,34,67,75,24,63,90,50,125,57,110,124,59,124,68,30,41,71,68,99
+U06452_at,322,128,273,263,277,106,89,265,209,119,173,235,182,138,116,175,472,121,222,230,148,188,98,166,244,230,375,141,161,137,176,183,198,49,249,83,187,230
+U06454_at,-3,-18,-88,-88,-33,-19,-139,-131,-60,-71,1,-34,-47,-59,24,-55,-61,-41,-25,0,-11,-26,-26,-21,-14,-36,-164,-96,-108,-79,-44,-43,-78,45,-31,-7,-51,-198
+U06631_at,400,651,473,418,910,209,480,727,778,233,585,10,1153,548,637,782,1794,263,811,2007,22,238,606,954,541,951,54,514,315,62,394,683,563,352,147,150,728,531
+U06632_at,44,37,-23,-13,130,23,-45,5,-46,-56,70,-20,238,38,25,-60,170,20,89,223,123,-23,39,26,-75,19,-1,-24,-48,99,29,116,30,47,-3,115,141,-39
+U06681_at,243,245,435,369,237,220,366,377,383,304,28,153,148,225,173,202,313,192,233,99,241,200,480,280,75,231,386,344,163,674,580,404,372,105,605,179,379,637
+U06698_at,-19,-24,-86,-30,33,-110,-97,-166,-212,-117,-119,40,-96,71,-30,-129,-131,-102,-20,-159,-126,-171,-134,-144,2,-74,-67,-234,-139,-150,-59,31,-97,-21,-43,52,-68,4
+U06863_at,274,579,534,186,234,442,294,67,747,358,147,331,375,278,17,300,634,-84,374,382,454,408,319,-47,204,310,580,290,9,356,207,244,526,153,740,282,-45,1219
+U07000_cds4_at,61,370,168,471,228,64,127,322,50,143,295,148,144,26,337,145,188,160,83,241,-8,228,476,336,333,147,-7,309,269,125,287,314,401,11,217,324,283,82
+U07132_at,1158,1210,1742,1029,778,748,1468,1724,1334,833,972,1212,1175,770,877,1116,1554,289,1124,1403,276,1154,862,978,920,579,1344,1464,1086,2119,2668,2270,1834,840,1327,1484,1913,2314
+U07151_at,159,27,342,90,146,120,332,-59,313,160,2,24,254,245,181,158,8,117,79,119,303,6,-13,162,81,130,53,86,60,22,-23,36,137,154,48,71,101,38
+U07158_at,491,532,540,282,327,355,525,625,439,334,402,229,623,583,513,413,259,292,307,953,22,197,132,452,408,406,474,1107,408,689,495,467,719,289,1021,592,739,968
+U07223_at,496,416,767,126,223,348,110,532,321,695,440,-24,331,350,244,298,-148,66,256,354,106,364,400,147,329,546,327,354,74,309,11,288,406,187,458,341,453,781
+U07225_at,-170,-88,-87,-37,-28,-60,38,-259,-19,-18,-65,-45,-121,-121,-128,-124,-99,-109,-48,10,42,-68,-75,-298,39,-92,-123,-74,-74,10,35,-125,-73,3,13,-62,31,294
+U07231_at,25,80,-29,-4,111,83,90,-134,307,143,117,0,52,69,64,69,65,57,-20,255,289,-79,-51,187,-58,72,20,-91,-122,-61,44,-26,5,-13,-34,-113,72,-31
+U07349_at,-359,-829,-1187,-1148,-194,-812,-1300,-1655,-1112,-564,-621,-906,-422,-561,23,-46,-1168,-264,12,-726,453,-659,-651,-229,-357,-273,-1840,-927,-581,-594,-1056,-1059,-399,-273,-809,-1141,-1383,-989
+U07358_at,534,270,648,207,150,832,855,767,790,315,682,393,266,432,205,779,235,281,206,361,376,438,393,596,177,82,364,569,64,200,123,397,515,27,190,567,255,783
+U07418_at,541,456,580,507,536,487,460,460,816,385,506,188,522,490,747,456,1281,656,389,875,518,234,412,896,469,253,427,356,437,261,397,450,413,314,294,439,361,470
+U07424_at,664,610,442,643,1065,560,537,409,738,422,268,294,977,966,964,856,3254,706,555,2472,366,287,378,1143,598,892,738,574,601,184,209,99,531,386,485,528,332,439
+U07550_at,218,441,266,408,2292,30,188,163,381,543,148,143,632,689,1270,565,999,326,184,1203,577,87,359,616,876,409,477,277,137,98,128,230,200,309,1064,218,311,127
+U07559_at,258,84,228,467,129,184,430,151,122,118,117,196,156,152,114,131,310,150,82,206,164,156,161,182,165,132,245,139,149,144,251,179,191,66,66,185,259,203
+U07563_cds1_at,-276,46,-124,88,578,256,-21,-589,-124,-78,-26,-21,224,291,630,59,-181,-230,197,138,-113,104,370,216,59,95,261,50,-264,-483,-249,-456,189,122,-414,-180,-79,-557
+U07620_at,255,-31,1,250,218,-188,60,-10,-226,221,-17,-27,160,-192,-32,285,-153,163,191,70,77,99,-172,41,128,197,15,18,-141,-92,143,83,71,-33,-47,20,63,117
+U07664_at,582,130,659,521,393,510,650,1001,636,493,431,307,784,222,407,1017,290,621,708,493,1165,1332,590,688,1544,912,1378,1022,1284,1232,149,898,982,135,-147,994,654,790
+U07681_at,366,464,481,516,411,229,201,457,438,224,455,202,311,485,389,227,1123,381,305,638,123,194,273,477,401,165,409,275,266,403,243,430,322,199,354,319,362,318
+U07695_at,1360,1011,1076,1239,1056,1017,1508,1851,309,1218,612,734,1598,624,856,782,1158,622,819,1733,444,903,455,681,886,1005,700,868,904,1165,1071,1247,1260,438,938,1217,1222,1610
+U07794_cds2_at,-81,-9,-98,-156,-85,-103,-137,13,74,-129,-66,-27,-31,-92,-61,-104,-16,-85,-101,-154,-46,-20,-62,-108,-88,-100,-40,-119,-72,-231,115,-49,-74,-15,154,-92,-122,-188
+U07802_at,2557,2364,772,1425,2717,762,1945,1520,2030,1147,1697,1402,4304,1091,3016,1829,4790,77,3110,3260,2063,2432,161,2091,2106,2315,924,860,480,1379,1060,1811,3114,1050,995,817,1443,805
+U07807_at,269,-6,140,39,96,174,305,-154,98,91,173,5,75,170,106,-42,108,26,-15,-39,39,173,41,-9,155,77,15,198,175,197,179,80,287,-2,73,184,152,408
+U07856_at,-18,-37,45,-50,-51,40,-42,-50,-60,-56,-7,14,-2,-11,20,-38,8,-108,-7,-37,-22,-53,-93,-47,-28,-49,-75,-36,45,11,-148,-3,-118,-29,-37,-34,43,-54
+U07857_at,3237,6639,5943,2711,3597,2372,1549,2440,5325,3745,5604,1747,2693,2738,2984,3485,5207,1661,1921,8811,3556,3081,2029,2932,3280,1949,1696,2413,1680,2238,3335,3047,3488,2245,3687,2507,4121,2902
+U07882_at,-48,-180,-117,-199,-14,62,-137,-170,-146,-7,-71,53,25,-101,-78,-71,-280,-55,41,-39,-103,-51,-91,-34,-30,29,-170,-84,-69,-114,-104,101,-52,-2,-179,-19,-22,-173
+U07919_at,535,381,150,102,304,131,517,446,197,426,240,80,0,101,203,436,864,-71,198,250,63,456,153,174,174,-26,273,178,-149,527,436,101,464,97,101,296,359,328
+U08015_at,28,159,317,-1,125,-60,-11,89,163,117,-10,31,40,161,142,162,40,53,24,88,-51,71,-125,-6,90,92,62,-28,-177,116,191,91,167,165,206,92,106,76
+U08023_at,-32,289,-174,63,163,-87,-115,85,-34,107,82,12,73,-63,14,-34,-271,21,134,98,87,201,-138,61,97,36,-139,9,69,-49,165,19,272,-2,291,-83,136,162
+U08049_at,52,43,156,-55,74,90,90,101,57,135,80,40,-49,103,41,156,170,65,-11,-20,99,168,226,129,120,145,156,-1,7,93,50,-26,16,-11,123,86,50,111
+U08096_at,148,219,-369,-58,166,-521,26,103,82,144,70,-80,-15,247,120,-217,-113,-34,132,163,0,81,-493,75,197,123,-386,-21,129,233,220,93,47,125,-12,60,95,200
+U08198_rna1_at,-503,-527,-101,-527,-306,-368,-641,-263,-502,-231,-334,-125,-348,-644,-296,-203,-511,-616,-495,-596,-7,-350,-341,-18,-35,-161,-1275,-501,-990,-430,-618,-502,-345,-123,-1304,-736,-546,-694
+U08316_at,362,434,486,355,419,483,515,523,347,260,281,369,393,617,503,40,192,212,153,365,136,359,389,414,369,199,406,210,415,495,501,445,707,159,718,814,785,957
+U08336_at,58,236,250,226,83,176,302,278,162,379,180,140,287,195,205,291,167,138,168,172,242,302,98,464,389,188,140,254,175,642,344,105,460,182,325,272,423,610
+U08377_at,172,43,18,5,194,161,89,134,450,161,245,-73,171,99,151,31,68,-67,-67,437,99,126,58,337,190,40,392,-7,-31,-71,20,-88,-97,99,-361,211,-86,81
+U08438_at,-1306,-1026,-1514,-268,-1173,-572,-137,-1859,-1015,-590,-1986,-257,-956,-797,-1043,-1214,-2832,-769,-987,-1578,-634,-685,-1113,-1212,-925,-1182,-1998,-1096,-1077,-1381,-707,-523,-985,-102,-1336,-476,-392,-1460
+U08471_at,-182,-370,-318,-375,-359,-215,-351,-281,-252,-320,-125,-152,-138,-167,-304,-313,-516,-324,-141,-326,-206,-340,-486,-171,-441,-235,-658,-346,-151,-138,-270,-268,-293,-163,-605,-400,-339,-300
+U08815_at,267,375,244,176,416,167,280,502,601,240,485,70,366,325,670,278,1088,280,390,1415,527,252,433,520,179,264,230,343,110,97,188,449,408,363,64,392,294,238
+U08989_at,257,98,76,124,61,-16,28,238,69,148,48,-81,-12,24,62,-22,630,90,83,-7,138,65,123,208,43,196,129,43,274,-39,96,71,104,-86,151,47,65,383
+U08998_at,-40,244,256,-388,146,-160,-391,-542,-92,-45,-61,-212,-64,-89,94,-205,-371,86,-76,286,87,83,-231,319,-152,0,-466,-64,-370,62,-354,-317,186,22,-386,-228,-210,-397
+U09002_at,186,104,418,252,148,158,290,233,444,206,74,99,193,118,114,12,262,212,149,278,272,172,201,270,172,350,452,183,206,159,2,198,241,247,211,358,434,460
+U09117_at,1184,689,225,539,250,645,334,1299,1262,551,410,415,215,910,788,852,196,394,369,976,738,1388,530,696,1031,668,741,1907,1430,1981,-55,1290,1306,542,1457,1359,780,763
+U09196_at,2022,515,899,1231,1072,611,1135,1146,1000,824,572,439,916,746,1637,1122,937,2295,938,1010,171,554,391,680,1081,1768,-45,1369,1187,1221,894,900,968,523,788,1181,1196,1199
+U09210_at,-212,-37,-221,-594,-3,-152,-20,-377,88,-84,-380,-219,-240,-587,-11,-100,-296,-23,-146,8,-9,-269,-18,-112,-230,122,-78,126,-165,-171,-293,-54,-54,-114,253,168,30,49
+U09278_at,-43,-67,-55,30,-87,-8,13,-103,-25,-31,-77,-57,-56,-11,-55,-527,-135,-89,-64,-79,-64,-125,68,-84,-6,-36,20,-78,-33,-9,59,-104,-32,-41,-67,-87,-60,-108
+U09284_at,77,121,281,229,113,140,1398,35,652,106,81,24,58,198,233,6,179,91,72,127,136,39,100,165,10,311,142,122,38,178,179,3,36,94,143,115,174,155
+U09303_at,694,337,599,261,179,328,384,614,538,228,258,363,749,276,845,234,759,223,230,569,98,312,264,402,575,409,608,423,476,426,297,499,531,130,801,330,481,598
+U09366_at,161,104,191,30,123,192,183,53,130,61,25,53,98,167,198,112,381,203,40,237,33,69,235,94,100,183,87,177,180,130,-66,42,150,-19,130,162,129,95
+U09367_at,3,321,250,44,116,8,144,208,167,107,315,100,241,94,337,130,272,81,72,211,88,317,218,182,236,297,172,313,81,44,160,186,242,82,101,102,203,143
+U09368_at,24,47,-21,22,13,17,-53,98,-25,14,-25,-25,-59,-24,50,-50,-9,-72,-29,-13,26,-51,56,-15,-28,-48,-101,-54,36,-23,-29,-19,41,0,-67,-56,-53,-110
+U09410_at,641,810,654,494,406,277,541,364,435,247,567,172,301,554,519,141,567,235,133,546,448,502,305,563,175,268,431,537,182,294,406,474,278,222,450,253,407,226
+U09411_at,414,216,404,245,163,309,320,440,159,200,274,153,209,274,182,198,369,197,79,119,116,153,205,224,197,253,413,301,377,186,236,218,206,134,156,272,278,289
+U09412_at,364,502,412,302,304,245,369,503,340,468,385,186,328,392,350,183,468,190,225,502,157,431,516,428,312,300,372,393,389,316,329,427,289,306,330,346,616,500
+U09413_at,-23,-33,-80,-8,-10,87,-45,158,-17,65,-8,35,86,101,26,9,-30,16,45,159,106,23,119,15,24,24,20,-79,-14,-21,-75,-35,-83,10,-19,-22,-2,-33
+U09414_at,343,328,534,488,303,433,413,403,311,280,276,321,320,330,320,255,460,216,199,426,129,200,340,407,245,267,364,298,235,271,235,341,246,207,321,224,600,349
+U09477_at,457,300,566,337,530,327,529,446,345,252,383,224,370,473,605,414,527,315,283,704,373,275,283,678,272,429,502,390,348,323,292,512,326,187,307,295,395,384
+U09550_at,-34,105,-1093,-948,-40,-489,-102,-1088,-84,-19,48,-435,-56,78,-78,-63,-659,-57,42,-123,-489,-98,-767,121,66,-553,-752,-275,-375,41,-84,73,-32,-380,-476,-1178,-206,-5
+U09564_at,338,277,724,416,791,403,507,326,679,443,349,209,1037,980,681,367,589,654,423,975,895,211,332,817,144,230,381,357,367,328,316,369,443,177,355,210,221,419
+U09578_at,-320,1344,601,-214,192,553,-420,-410,512,-80,209,109,-137,60,201,-199,-285,-30,-75,62,171,-142,231,-22,61,38,-233,198,120,577,-63,-119,269,551,953,638,1294,-79
+U09579_at,503,370,49,688,924,280,685,146,455,471,297,659,1433,187,1003,53,208,483,408,58,278,1013,-3,892,902,756,28,78,254,1783,502,116,1151,241,1168,-30,766,1568
+U09584_at,206,205,363,416,285,154,285,415,216,231,203,158,363,220,278,220,-66,268,188,328,163,113,290,245,185,241,104,335,156,487,38,440,188,87,240,168,322,420
+U09607_at,374,884,1153,1233,333,899,443,-19,-207,759,293,504,654,817,735,248,460,504,-7,533,-66,627,839,345,-38,280,17,501,625,596,-277,-9,656,382,488,991,1074,759
+U09646_at,47,21,-26,6,125,58,-42,56,33,-76,-46,0,39,76,123,50,88,87,13,159,8,-77,-53,-5,-30,-53,-40,-203,-72,33,40,-43,-27,-3,4,6,4,-24
+U09759_at,181,147,191,91,220,113,115,-34,183,44,80,114,215,122,258,135,436,123,30,160,274,0,79,307,152,81,-21,168,43,87,-91,2,114,54,99,156,261,-2
+U09770_at,1235,917,2060,532,2444,1214,488,188,7228,3454,1793,699,93,322,1241,812,-194,868,-30,-144,574,357,457,875,122,1382,-203,678,12,1001,-31,-89,58,141,2598,1221,882,412
+U09813_at,1954,4090,3895,2056,3857,2589,1189,1346,4990,3139,3764,1760,2088,3570,4046,2633,1828,2650,1501,4755,4391,1604,2787,2943,2718,2019,1616,1622,1550,1754,1896,3384,2346,2931,2277,1893,1812,1436
+U09825_at,1142,987,757,755,773,599,705,1169,1140,943,910,244,1201,911,933,667,1785,934,757,1495,878,731,575,653,602,1087,1046,630,579,1229,639,962,783,133,470,741,525,1081
+U09848_at,559,351,493,556,537,371,536,905,563,136,396,155,387,557,500,280,718,290,228,674,217,302,284,630,393,340,572,343,403,303,294,320,294,170,265,316,673,630
+U09850_at,578,375,411,531,104,229,176,5,292,330,503,67,214,-21,326,447,802,556,-384,435,67,309,172,183,553,395,591,113,86,664,293,642,539,283,-21,-102,695,1014
+U09860_at,20,80,-38,-14,29,-8,21,131,18,-12,44,60,182,16,19,-38,158,122,32,66,12,-17,0,2,32,53,95,-27,9,-14,-5,-5,9,3,-18,35,-24,43
+U09877_at,-355,-1030,-1496,-1566,-266,-928,-1251,-1800,-980,-713,-780,-813,2,-776,-307,-646,-1794,-235,-483,166,-54,-966,-953,-619,-833,-26,-2383,-847,-966,-404,-1205,-901,-371,-135,-1180,-1219,-602,-1416
+U09953_at,14573,17462,14029,14988,17703,7402,10300,14147,16006,15103,16324,9750,16478,15309,15156,16293,17948,18473,16317,19895,22793,16661,11448,16405,17725,16897,17937,17123,13263,13240,14600,18488,16102,15408,16193,11789,15127,16554
+U10117_at,449,734,447,345,856,245,171,263,378,318,839,209,405,520,783,264,902,349,330,1174,419,206,379,672,603,266,70,560,370,347,316,504,786,394,640,207,370,381
+U10323_at,3215,3784,4719,3110,3157,3142,3150,4100,6142,3665,4923,1751,3412,2030,3862,2767,3809,2249,2428,7637,3380,2398,3592,2819,2296,1259,1785,1653,1764,2682,3065,2904,3371,1050,2693,2432,2844,3425
+U10324_at,-78,-1246,112,571,1087,211,42,-100,514,65,824,79,227,517,821,48,680,85,128,1020,-433,77,355,393,483,-197,15,-439,-829,7,307,186,299,-215,6,-156,-204,-81
+U10362_at,50,-254,-58,-157,375,-67,-72,-170,845,140,122,-168,354,161,331,117,-284,275,263,357,-368,-202,-414,151,261,216,-253,-64,33,609,25,292,295,126,290,444,-124,49
+U10439_at,1989,1415,1951,1570,1385,1483,1381,1464,2582,1126,1576,416,1203,2278,2225,1344,1882,877,1361,3584,844,1187,1139,1543,1370,1135,494,870,620,1639,2848,1200,1231,707,525,1727,1891,3110
+U10485_at,333,212,541,3267,3306,133,3081,74,79,462,455,67,1102,155,4073,3302,277,1796,416,552,1805,1573,623,3134,195,243,2037,205,12,222,249,343,0,222,442,113,101,122
+U10492_at,482,131,291,510,105,227,779,281,245,79,369,153,58,208,147,130,83,133,-18,140,156,198,552,386,359,113,118,392,197,215,234,216,247,53,130,506,239,207
+U10550_at,144,62,175,111,137,83,99,176,142,207,93,25,122,106,21,80,55,148,111,64,233,132,102,150,163,119,112,74,12,135,123,103,175,83,215,190,201,303
+U10685_at,162,25,72,15,-3,101,94,97,-123,59,38,51,47,19,24,97,-14,89,40,-23,-32,13,79,90,75,10,-43,50,134,49,62,31,73,34,28,-48,101,110
+U10686_at,833,725,783,530,80,403,737,844,164,859,180,41,843,18,226,587,1345,390,232,634,251,401,151,803,365,294,1508,1036,425,293,910,770,1249,151,509,881,667,1072
+U10693_at,-55,2,7,-8,-62,-40,-109,28,-4,13,-10,-30,-125,66,3,-27,-28,80,29,68,-21,-119,43,-63,2,-93,-31,-21,38,55,31,47,-134,-29,11,-94,-50,119
+U10868_at,812,311,1170,952,577,368,1305,716,770,413,333,435,1299,548,527,569,379,625,230,462,296,473,245,740,700,419,624,856,880,2168,792,766,678,422,1519,885,1236,1244
+U10991_at,77,354,-463,180,-199,440,-31,-368,456,47,222,347,-133,-440,-106,-167,-140,-7,-179,-304,82,-308,554,163,69,-236,-541,133,-283,442,172,396,-313,95,16,455,654,36
+U11036_at,-174,-210,-391,-146,-38,-35,-270,-254,-97,-96,-279,-160,-37,-130,-86,-121,-169,-13,-85,-154,-104,-91,-315,-82,-88,-66,-230,-157,-490,-88,-175,-314,-54,-126,-63,-221,-431,-261
+U11037_at,260,285,329,278,264,302,270,461,349,230,378,41,201,424,110,230,90,124,266,178,96,309,262,486,218,243,305,451,428,298,274,249,136,54,277,117,70,474
+U11090_at,775,836,1197,1213,628,826,912,1203,1004,967,798,415,1099,989,683,1147,888,695,965,823,575,814,957,749,564,915,1422,1242,1130,1045,712,998,1138,528,1042,974,1179,1519
+U11292_at,166,195,285,482,379,215,166,311,332,343,210,219,394,215,341,198,473,288,204,380,33,122,167,390,310,270,187,257,252,241,185,139,287,218,405,350,516,124
+U11313_at,86,124,120,42,282,71,-30,-1,224,137,133,15,130,69,182,101,290,64,63,358,378,53,37,237,85,66,51,54,36,22,64,58,21,103,118,53,77,19
+U11690_at,-21,75,-95,-36,-103,104,73,29,15,36,-98,33,29,-59,-114,-1,-146,-29,-51,-114,39,-27,-184,43,-9,-57,-32,70,-79,-95,-51,-12,-40,-89,-32,-37,-170,-146
+U11701_at,38,-21,42,-49,50,-78,15,22,29,-79,-52,-80,-1,35,-89,-12,24,117,-1,-43,-123,-49,-28,-112,-48,55,-120,-211,-45,-128,-78,-244,73,-170,90,-104,-23,-144
+U11732_at,71,358,84,215,160,48,263,238,182,109,155,262,142,-33,177,165,1269,66,285,637,49,158,112,377,225,181,65,458,252,57,147,312,214,404,99,222,407,409
+U11791_at,429,212,336,408,461,183,315,371,277,277,289,185,232,437,455,466,651,364,413,790,463,189,302,464,294,281,225,296,245,173,508,460,981,531,243,279,480,471
+U11861_at,1587,1834,1871,1730,1528,1273,1466,1934,1999,1949,2456,1284,1286,1610,1819,1884,2083,1373,1435,2841,1946,2019,1350,1705,1560,1987,1491,1514,1291,1675,2018,2489,2293,2264,1630,2028,2314,1893
+U11870_rna1_at,-79,14,-54,99,116,-131,-52,-46,700,-4,224,64,-57,-106,38,374,-154,124,169,56,303,27,7,175,99,126,56,-20,324,-55,-309,-110,100,22,-32,-51,-53,-111
+U11872_at,444,527,723,459,406,298,485,893,417,387,338,175,459,306,110,488,837,513,398,665,131,205,94,489,525,535,458,478,461,404,364,526,518,174,475,217,380,870
+U11877_at,38,12,192,-117,398,-72,-152,23,33,-8,62,-152,-47,-45,26,108,679,388,41,-136,27,-99,-41,135,130,181,-303,-37,-218,107,94,132,134,-35,-7,-70,-52,-12
+U11878_at,42,114,197,5,76,72,94,113,68,53,73,-21,43,54,94,156,211,155,64,104,54,47,132,153,52,124,140,211,16,137,57,85,109,13,36,52,139,175
+U12139_at,499,-218,544,151,100,793,425,-214,-191,262,380,310,46,95,707,219,1641,342,170,-1,337,372,188,268,796,774,-635,-536,180,413,391,-210,87,269,-125,999,167,1425
+U12255_at,3830,1675,2802,910,779,1017,712,1677,3221,1415,1778,498,1511,978,1447,1385,3187,744,1045,1437,515,1093,1481,985,1483,1983,1345,609,1204,3706,2141,1715,3781,479,3007,756,2894,2757
+U12404_at,16874,18656,16744,19405,22103,10340,13801,12486,20634,21003,16469,13007,20578,19140,20539,22738,16376,18984,20386,20206,27333,13750,13713,18904,18406,19521,15750,21363,11753,12485,16041,21827,20201,16885,19465,15467,17995,15791
+U12465_at,11717,13457,12592,13384,15305,9376,8594,9229,14537,16775,13554,13107,12381,13106,14170,15241,9875,13340,15303,13965,19655,9730,10937,13478,15005,13950,9483,14241,10649,11759,14872,14907,13618,14683,11048,16012,13732,12980
+U12471_cds1_at,160,134,167,104,145,81,122,335,131,264,195,104,150,135,128,182,227,157,290,70,39,126,74,205,144,98,143,293,322,337,417,271,238,217,213,283,264,304
+U12535_at,-100,32,-66,-96,-59,12,-141,-38,-28,-54,-40,-47,-25,-1,-21,-2,-85,7,-21,-38,-24,-43,-55,19,-66,-42,-139,-29,-31,27,-22,-3,49,-6,-72,23,-78,-99
+U12595_at,-228,-146,-158,-143,318,37,-162,-757,75,77,-57,218,343,-193,3,148,-98,161,64,409,0,-202,157,-272,71,138,-67,73,-144,-276,320,-295,195,111,285,160,16,-613
+U12622_at,179,186,140,201,214,96,257,332,193,223,154,70,134,168,105,211,136,225,151,166,186,202,231,177,132,143,204,316,353,173,210,207,251,83,202,320,255,316
+U12775_at,-2,178,67,-74,15,32,15,211,-51,-28,-12,47,11,4,36,-4,39,65,3,28,129,10,178,69,50,19,-4,-9,91,38,-125,44,6,61,169,49,1,-18
+U12778_at,8,69,-5,29,74,19,42,101,22,25,37,11,22,45,86,64,32,40,33,122,-4,27,-22,35,24,32,50,3,69,-13,47,55,64,-46,33,86,38,8
+U12779_at,963,855,1393,526,765,698,1441,2406,1567,449,856,244,899,918,354,951,170,1179,991,2202,617,853,794,878,765,625,1306,760,1635,1073,983,1471,1370,721,624,771,1109,2877
+U12897_at,53,32,69,42,38,24,-18,49,22,77,40,53,55,71,-5,18,-19,1,31,102,164,30,68,66,38,5,7,-25,21,-5,110,29,-21,1,7,43,145,5
+U12978_at,-125,-193,-249,-53,0,-96,-84,-38,-145,-121,-126,37,-78,-56,-40,-80,-28,-51,-69,-53,-87,-92,-132,-21,-157,-90,-143,-66,-60,-141,-7,-72,-132,-21,13,-30,-50,-99
+U13044_at,72,0,28,175,119,147,120,52,12,138,142,125,123,66,95,90,28,68,174,64,48,51,87,121,41,30,147,-7,57,33,83,4,50,53,9,15,170,1
+U13045_at,313,116,250,195,316,170,181,283,212,93,288,51,495,167,229,289,263,137,440,544,182,196,188,214,53,110,147,45,40,160,197,174,214,191,259,62,144,309
+U13061_rna1_at,-8,70,-13,-10,47,-39,6,-25,8,62,18,10,62,45,11,10,64,23,-24,-70,34,-35,-7,46,-82,68,78,-30,38,3,-53,68,14,-22,-28,-31,44,15
+U13219_at,203,77,239,109,99,56,97,145,164,65,14,7,68,114,37,-26,7,29,57,21,-16,52,75,7,9,64,402,70,-2,34,101,178,231,-63,151,70,161,294
+U13220_at,215,252,302,127,90,78,151,40,128,-30,98,-67,94,30,31,208,-158,260,-86,168,26,71,51,180,83,110,239,57,175,134,95,121,200,17,264,94,108,172
+U13369_at,-268,39,-204,-124,-180,-53,-40,-49,-90,-138,-122,-274,-121,-206,-46,-201,-357,-71,-88,88,-114,-357,-193,-137,-4,-113,43,10,-276,-5,-266,-227,-80,-170,-226,-204,-44,-255
+U13395_at,720,236,968,224,432,298,811,1235,726,527,669,182,422,278,574,615,460,377,342,609,169,304,636,678,557,414,496,482,644,509,183,689,720,352,522,787,585,933
+U13616_at,-37,-72,-54,-139,-80,-128,-35,-67,-34,-101,-111,-109,-167,-42,-52,-122,-86,-129,-137,-167,-209,-119,-15,-82,-123,-99,-29,-123,-129,-122,-8,-20,-85,-130,-150,-128,-129,-109
+U13666_at,317,196,544,436,226,288,542,334,223,268,137,247,26,197,106,305,369,182,216,356,71,168,262,254,278,169,442,468,353,565,374,611,414,257,393,494,279,290
+U13680_at,119,45,-4,20,-26,-28,33,-47,133,-33,-73,58,-35,38,-13,-64,92,58,85,-44,19,56,-28,11,-17,36,197,-48,45,49,114,16,-6,95,-45,-82,-38,3
+U13695_at,387,276,410,500,528,336,364,491,245,73,20,120,399,553,416,604,1606,365,251,1013,239,77,184,402,276,59,464,256,346,240,196,171,279,131,210,155,70,346
+U13706_at,522,381,593,363,385,298,149,575,354,387,272,140,473,344,272,531,854,479,357,850,2,563,368,342,517,520,574,379,310,239,267,563,436,157,184,292,513,566
+U13737_at,168,-24,119,51,255,-53,413,-515,169,57,98,-22,166,416,354,295,842,235,232,155,132,24,-102,172,40,92,61,202,57,17,97,349,82,367,-57,30,-5,-69
+U13896_at,8,23,35,18,50,-33,-13,-25,55,-48,33,-27,49,84,57,7,13,-40,0,-3,47,-35,125,-9,10,18,56,-67,-9,29,4,70,-46,-7,36,-51,-20,26
+U13948_at,90,68,163,180,90,10,43,203,245,49,85,44,64,106,179,91,200,79,106,106,2,20,24,73,73,38,134,145,43,57,40,65,64,23,83,86,92,108
+U13991_at,640,1125,766,618,1069,734,564,187,1072,1210,726,377,476,944,1155,1160,847,922,752,3067,282,302,416,1284,717,1147,-300,501,113,1149,1092,657,544,841,2617,727,667,207
+U14193_at,796,849,1002,845,1004,359,561,635,852,619,769,327,709,578,864,756,4327,491,476,1538,990,447,431,841,628,541,607,404,596,573,563,525,644,423,492,570,490,523
+U14383_at,171,3,79,400,182,204,47,298,247,42,206,218,265,221,67,129,325,182,185,146,44,56,49,172,128,175,334,177,115,325,407,91,245,135,278,159,233,276
+U14391_at,265,426,595,393,389,202,371,452,427,186,102,178,159,207,268,373,696,478,357,323,-102,275,237,286,332,192,553,299,153,487,341,404,377,321,378,261,637,691
+U14407_at,-12,-21,11,59,-11,-21,-6,-16,19,16,1,-40,13,12,-10,96,-21,9,33,-87,34,-27,39,38,-38,20,31,-31,14,15,-64,24,40,38,43,-48,-61,19
+U14417_at,986,758,690,1043,409,558,836,1001,574,392,680,502,706,1055,114,761,1291,195,354,361,156,825,294,787,1029,200,632,830,978,971,1818,1037,444,303,2805,958,1755,2048
+U14518_at,147,-12,195,136,170,8,89,-86,87,-9,119,-5,174,124,215,54,38,186,69,114,-27,60,30,93,47,77,39,-110,14,-25,60,51,74,26,-29,41,62,93
+U14528_at,43,53,77,55,79,1,60,82,-29,83,-4,-68,22,-21,91,60,185,52,-10,-2,-59,5,-104,151,2,-42,-21,29,16,75,35,-24,-41,-79,15,1,59,46
+U14550_at,114,-27,451,344,211,145,110,34,137,153,80,44,116,257,28,198,146,187,270,392,27,257,-79,57,67,69,34,192,266,384,126,145,298,49,285,88,168,538
+U14575_at,426,371,420,587,483,272,178,224,459,345,479,175,909,539,592,715,652,143,452,1139,394,485,436,592,210,161,600,151,283,186,488,534,403,315,409,344,272,268
+U14588_at,855,574,930,471,334,272,520,682,814,611,515,311,732,943,330,570,830,432,300,637,308,500,461,418,304,596,585,920,642,868,698,698,854,462,566,735,884,1434
+U14603_at,1890,10296,14101,2181,2529,9598,2189,2286,13001,4087,9121,1585,1467,2393,2474,950,1633,1524,1254,3294,3029,2363,9016,2342,953,1087,608,2615,1709,3618,2508,2710,1807,1527,2536,2918,4252,1976
+U14747_at,19,30,183,95,72,103,63,47,40,59,125,-44,61,64,70,75,47,21,-9,59,41,13,41,207,-12,60,46,21,122,107,27,45,83,35,51,18,59,109
+U14910_at,-90,-160,-62,-182,-132,-231,-35,-178,-105,-140,-176,-248,-149,88,-117,-53,59,86,-246,392,204,95,-159,-34,-111,244,276,93,-360,-343,-68,-242,-222,-6,91,-302,-120,-312
+U14968_at,13353,16698,16707,16960,15831,13912,8088,14679,16866,16302,17025,12258,14389,17786,17641,17532,11778,13791,13882,15747,20294,14081,16318,17417,11294,15807,18900,18118,14345,13597,15491,15863,16390,18236,14805,16203,17261,16761
+U14969_at,19130,20960,20453,21278,18912,27775,17528,21222,21087,22181,23149,23799,16759,20376,21418,22477,18183,21917,20035,18353,16588,22724,23148,21532,23912,22006,23587,22820,18161,19822,21241,23651,20908,23838,21999,24088,20884,21558
+U14970_at,15119,20593,14283,18977,22706,14611,13830,16711,22709,20338,19725,23650,14555,18743,22167,18557,22629,18432,21879,18643,9454,16951,13981,18952,23576,17285,18086,15440,13350,7341,18590,20343,20627,20969,16168,20236,19187,16571
+U14971_at,12143,14953,11750,13939,15848,10055,7853,9769,16610,15529,12024,13451,10227,11334,15059,14143,10184,12278,9848,14539,5755,13042,6598,12014,16104,11140,9987,13673,9135,7538,15619,17284,16028,17052,13049,16813,14459,13040
+U14972_at,12720,15360,10604,14156,14358,7194,7747,11387,15426,13630,15537,17485,13237,13232,14540,13733,13555,12561,11493,17445,13401,13564,13339,13594,16518,13213,11874,12330,9967,7507,13794,15745,15182,19666,13483,15013,14795,14815
+U14973_at,19398,18006,21085,20331,18998,23824,23848,23246,18541,22030,20014,21289,21565,18057,18202,21255,18239,22268,20849,12932,24478,23416,26307,19490,20967,19273,26052,20310,28672,20056,19179,22051,18813,22737,18883,21504,20264,20138
+U15008_at,7093,10263,10012,7288,8690,6479,3972,5473,13151,9053,9476,8310,5507,8576,10876,9058,7647,5634,5531,13522,12649,5249,6790,6677,7711,5401,4825,5803,3902,4318,7303,7159,7421,8322,6778,6328,4976,4707
+U15009_at,422,575,632,687,976,480,346,233,1316,643,398,541,821,952,1322,688,1003,543,336,1242,463,197,512,577,645,488,405,294,538,547,263,451,540,475,487,595,536,309
+U15085_at,3277,1048,793,1371,1530,569,819,1457,815,580,479,724,3601,656,2369,1194,-30,4161,1933,4702,834,1275,560,1319,1273,1459,1020,864,1507,1207,672,633,1232,579,1379,1430,1678,1291
+U15128_at,114,115,82,213,300,48,92,196,188,179,169,47,470,138,225,181,604,205,229,349,17,108,-20,258,87,68,184,80,72,172,212,127,114,239,267,92,212,394
+U15131_at,-399,-91,-429,-306,-154,-270,-216,-712,-197,-216,-359,-102,-255,-347,-211,-186,-768,-241,-75,-315,-254,-285,-338,-340,-176,-399,-444,-491,-415,-321,-241,-402,-318,-14,-338,-146,-304,-216
+U15172_at,825,725,966,774,593,569,761,874,678,701,788,442,604,659,602,835,882,711,677,876,317,814,697,747,788,811,654,898,812,1043,790,944,820,279,639,667,991,1146
+U15173_at,414,208,254,344,384,133,230,416,260,93,549,169,469,-121,214,228,957,173,151,980,392,306,144,338,199,337,439,159,-52,531,514,126,289,287,904,239,263,284
+U15174_at,248,62,-15,33,275,65,-85,215,271,0,152,76,80,112,-2,98,-5,439,162,361,137,147,121,244,128,109,39,323,103,123,148,363,245,25,73,2,119,407
+U15177_at,967,806,1173,792,366,855,1446,986,764,670,734,741,379,618,522,592,1075,119,383,630,398,819,564,773,856,447,1009,912,1216,1118,520,1135,969,462,959,826,854,1585
+U15197_at,406,248,383,46,371,-181,-20,-58,75,228,154,-68,369,103,153,297,546,235,54,83,-12,132,150,225,298,347,369,266,173,331,78,175,395,59,392,57,466,470
+U15306_at,-3,236,82,170,115,65,102,88,125,33,59,30,148,149,218,145,55,-29,21,317,9,100,53,220,104,41,50,-16,-16,59,163,173,57,82,42,20,115,97
+U15422_cds2_at,-694,-506,-1012,-773,-409,-565,-735,-970,-716,-716,-605,-441,-343,-688,-408,-578,-782,-445,-474,-625,-318,-457,-691,-675,-470,-411,-729,-697,-738,-601,-783,-766,-790,-297,-711,-669,-750,-996
+U15460_at,-189,-232,-396,-393,83,-368,-428,-527,-376,-188,-208,-182,-85,-111,-105,-138,162,146,-164,-294,-301,-245,-260,-75,-161,-155,-441,-252,-307,-132,-453,-675,-355,-147,-312,-404,-574,-323
+U15552_at,574,907,632,376,730,193,472,374,371,381,1002,409,691,575,701,622,1251,203,475,1839,648,652,425,511,299,395,384,418,64,622,781,681,748,444,621,578,1170,1220
+U15555_at,-8,522,-175,-78,16,-124,-169,46,-94,-227,-41,10,10,-100,35,72,-449,-159,-14,-257,-87,126,-262,-10,282,15,-345,320,271,869,42,-73,387,454,253,34,105,-132
+U15590_at,-153,-67,-74,-92,-78,-129,-97,-146,-84,-101,-31,-117,-100,-78,-124,-25,-189,-103,13,-22,-19,-34,-169,-182,-37,-153,-194,-125,-137,-162,8,-11,-76,-110,-175,-58,-101,-19
+U15655_at,64,172,-144,6,-45,-115,75,-305,50,246,242,-60,-52,-90,-107,239,-25,-141,47,-32,-97,86,-37,200,-18,-56,-549,-3,-33,171,32,267,371,141,5,-6,206,540
+U15782_at,691,523,939,704,646,510,803,578,721,893,375,247,726,1036,659,667,1136,580,504,1396,352,423,412,626,373,422,721,521,531,557,490,556,599,261,431,550,536,764
+U15932_at,186,358,141,163,247,44,216,110,148,195,138,505,52,406,34,19,42,236,103,310,123,143,79,154,1485,182,375,101,122,751,562,313,684,47,581,307,465,1016
+U16031_at,196,122,318,197,641,254,247,158,234,51,141,-28,183,365,483,316,166,9,65,138,-23,-10,-87,563,194,70,-189,112,88,300,45,217,238,2,150,103,584,225
+U16126_at,7,-144,-122,-45,-41,1,-149,-40,-137,-99,-80,-67,-120,-136,-45,-15,-158,-124,-71,-105,-169,-132,-36,-91,-361,-122,-14,-263,-242,-147,-8,27,-119,-102,-194,-183,-132,-76
+U16127_at,558,535,1075,653,285,524,656,793,510,673,512,271,370,667,323,678,288,336,495,518,282,659,564,487,84,327,441,739,764,210,549,822,529,262,91,701,721,1177
+U16129_at,24,39,-19,38,50,48,119,62,85,22,16,54,15,40,-11,-11,153,40,58,-3,-11,61,26,-2,63,83,111,13,50,-32,90,56,41,42,66,43,10,55
+U16258_at,137,48,134,-53,92,58,105,49,138,112,76,45,86,82,68,51,162,86,49,72,-46,103,94,54,135,41,-78,51,91,176,134,106,130,25,41,121,168,204
+U16261_at,0,5,-3,-4,-15,-117,-131,-148,-20,-21,-73,-24,-10,-22,-6,-96,166,-49,-19,26,-42,-54,-15,-38,-18,-54,-123,-12,-40,-80,1,-36,-44,-9,33,-136,53,27
+U16282_at,699,360,671,513,264,151,294,512,314,426,360,245,206,284,305,536,348,309,184,569,97,477,227,337,301,219,959,444,478,414,616,434,633,339,721,640,581,712
+U16296_at,222,149,276,137,87,200,203,379,355,105,173,206,265,82,67,235,99,159,79,356,238,11,243,214,201,105,140,252,218,172,191,511,138,233,131,160,194,367
+U16306_at,71,335,-22,146,1192,81,28,-55,0,59,100,-2,-4,292,140,74,0,13,-4,55,-31,-52,37,-39,31,-15,106,106,9,7694,955,-8,134,129,5285,159,481,3263
+U16660_at,919,794,70,257,1291,-42,-20,-158,691,248,-55,298,1236,822,1412,967,1064,726,135,1989,580,-506,-110,916,420,991,-71,124,175,498,-65,-27,852,542,834,988,441,-739
+U16861_at,256,-61,382,-19,43,17,38,277,234,157,88,-4,76,238,43,287,141,117,-23,72,38,134,119,131,61,60,75,7,396,506,18,79,279,-61,163,-48,27,342
+U16954_at,399,252,1588,27,331,439,-38,196,2779,550,2178,-27,316,1267,241,57,82,142,1,708,1030,164,362,158,-15,-28,-23,-142,-108,-106,2,72,178,-31,-60,-119,-69,-55
+U16997_at,-214,-81,-25,-2,-80,40,-90,-271,66,49,-278,-5,-74,378,-57,-275,-413,-71,-231,-273,24,-28,195,140,-272,-222,-251,-143,-312,-232,-340,-294,-227,-245,65,-87,-87,-429
+U17032_at,7,-42,23,13,23,-71,-8,-22,21,26,-2,-11,15,3,0,-47,-8,-43,29,45,-43,30,43,4,18,-33,59,-51,2,-46,12,27,-26,53,-32,-31,26,32
+U17033_at,6,-131,-38,3,-12,39,-18,47,34,-14,29,-5,1,-36,8,-30,-30,19,-60,22,27,-35,36,25,28,-13,51,-10,-38,-44,-21,2,21,-38,21,-6,-3,55
+U17034_at,-44,-13,-87,24,8,-90,-15,-26,-22,-20,-27,-7,10,-17,29,16,-30,-5,0,-30,84,-6,43,-55,-6,22,-61,-64,-50,-77,-58,21,38,19,12,-43,-27,-58
+U17077_at,-253,-134,-273,-237,148,-83,-154,-299,-278,-165,-112,-182,109,-46,-78,-89,-47,-110,-143,-25,-27,-107,11,-191,-106,-50,-297,-123,-113,-126,-139,-51,-154,-83,-280,-193,-211,-316
+U17163_at,610,299,739,410,361,396,379,517,267,194,83,370,210,258,248,355,379,163,169,184,217,375,391,309,253,224,500,412,158,342,278,283,417,15,439,474,394,404
+U17195_at,130,12,120,27,91,48,-28,-50,105,55,73,109,17,99,34,166,142,30,18,-73,14,2,108,90,-1,77,126,-26,31,-50,280,-109,42,65,53,37,109,-25
+U17280_at,-237,-201,-339,-253,433,-120,-45,-352,-111,-159,-191,2,-133,-206,-168,-104,-416,-118,-167,-290,-79,-172,-60,-242,-134,-99,-211,-60,-177,-208,5,-25,456,35,119,-129,-307,-161
+U17327_at,-6,-212,-173,293,-73,426,262,367,-173,-93,-209,244,-213,-88,54,-178,89,-153,-121,-310,-172,-58,-199,14,-213,-133,162,288,283,-304,129,-95,-250,-85,180,708,631,403
+U17418_at,-109,-252,-102,9,378,49,415,-122,-63,37,-57,383,-21,-256,-196,62,-294,-33,-88,293,166,608,243,-60,266,20,541,115,-141,-156,371,85,31,137,317,155,-81,809
+U17566_at,-1525,-761,434,-348,-85,272,213,-977,-214,260,-393,57,-528,-224,-126,-460,-1260,-334,-337,230,-154,-780,102,-177,-1040,-276,-1150,80,-389,-107,-657,-853,-278,-454,-987,107,249,97
+U17579_rna1_at,507,267,525,411,257,238,485,424,326,345,324,165,297,406,198,298,357,300,188,397,103,306,239,462,223,228,680,385,473,396,371,390,341,55,232,350,412,644
+U17714_at,279,250,439,222,238,160,332,287,383,317,389,160,79,316,157,128,329,124,144,284,189,159,246,183,222,167,339,180,189,143,177,291,171,135,158,181,295,358
+U17760_rna1_at,-72,-97,-53,-149,-63,-135,-124,-176,-111,-131,-133,-110,-66,-124,-93,-178,-126,-103,-129,-91,-11,-156,-123,-127,-75,-4,-192,-206,-137,13,51,-40,-129,-97,-162,-201,-181,-56
+U17886_at,240,136,460,349,632,257,220,13,441,217,477,300,275,635,596,276,311,74,256,531,179,158,117,545,225,162,126,171,214,475,323,214,222,297,750,344,239,293
+U17894_at,1261,934,1393,1415,707,1258,1324,1742,988,1295,943,671,996,1396,898,1107,1143,825,754,823,314,974,1493,1250,742,914,1589,1115,976,1080,909,1050,1051,559,1144,1682,1183,2015
+U17977_at,-252,-277,-571,-395,-170,-384,-352,-751,-387,-140,-273,-178,-143,-288,-245,-296,-109,-46,-103,-259,-162,-207,-336,-261,-175,-187,-427,-343,-432,-390,-238,-335,-305,21,-455,-248,-363,-222
+U17989_at,122,104,98,112,59,-10,20,128,71,74,140,99,230,69,132,93,87,38,90,422,108,6,53,159,87,54,104,60,33,28,108,66,31,43,79,34,90,199
+U18004_at,-84,-47,-159,-209,-60,-88,-122,-77,-90,-89,-13,14,-51,5,-76,-85,-120,-65,-171,-76,-72,-99,-20,-101,-70,-42,-53,-71,-91,-11,-29,-140,-64,-139,-40,-78,-16,-95
+U18009_at,500,1554,913,337,768,1662,325,499,2730,1556,1281,423,662,558,570,415,499,442,204,557,327,141,974,715,455,466,427,1048,264,349,208,363,347,904,790,435,459,467
+U18018_at,503,453,216,339,-23,72,139,548,259,246,248,405,101,598,306,305,-269,70,94,162,-2,239,583,254,145,328,219,385,413,114,342,425,129,9,119,251,8,559
+U18062_at,952,388,559,626,776,24,339,602,483,450,488,326,1370,385,1236,742,786,279,625,1958,823,511,615,650,560,572,395,330,141,298,264,733,450,243,398,206,291,561
+U18235_at,-555,-603,-638,-660,-652,-320,-621,-737,-495,-353,-433,-426,-288,-450,-512,-400,-736,-450,-177,-631,58,-351,-374,-504,-500,-368,-948,-401,-533,-364,-633,-405,-447,-323,-610,-548,-545,-636
+U18237_at,206,0,294,299,73,115,366,38,182,39,217,106,179,41,148,169,-65,51,68,178,147,20,121,125,59,168,306,57,115,158,238,164,78,65,132,64,295,306
+U18242_at,516,540,299,544,630,94,312,493,941,388,1482,429,467,732,808,315,363,499,363,1003,1437,672,258,537,492,595,305,714,315,298,311,540,765,452,292,430,349,433
+U18244_at,-5,-369,164,-47,-159,167,-189,-310,-19,-190,-19,-114,-128,-58,-72,-174,-1391,-369,-145,-250,1,137,125,-324,49,-17,-943,-625,-531,241,63,271,-29,-271,-873,-7,-17,426
+U18271_cds1_at,-39,43,80,50,65,71,-31,-88,96,179,308,-73,114,-30,260,136,40,-74,84,260,168,-74,402,-55,106,0,23,-129,-84,11,91,238,0,98,25,-51,-149,71
+U18288_at,73,79,368,299,76,113,307,442,25,103,142,152,46,104,234,46,224,135,49,124,-63,160,165,19,150,133,261,127,278,91,232,142,322,79,217,248,320,332
+U18291_at,374,331,514,571,449,325,411,316,263,221,25,74,193,580,382,314,765,269,174,741,231,64,414,619,144,310,82,347,288,82,69,218,235,109,199,255,320,0
+U18300_at,495,800,696,620,557,410,490,497,711,531,451,293,564,540,892,209,940,989,300,241,216,332,199,619,432,577,434,438,492,712,554,798,738,338,354,593,674,557
+U18321_at,246,133,379,394,369,318,-47,307,370,-96,288,86,120,468,272,224,-44,295,59,562,407,154,98,388,267,318,230,282,-14,243,160,163,328,82,-62,193,146,29
+U18467_at,150,63,247,116,86,81,206,131,211,130,175,58,141,115,79,139,153,118,123,61,28,143,108,115,130,163,214,158,64,168,118,141,109,-19,136,141,179,158
+U18543_at,344,269,288,189,309,87,186,110,211,217,306,125,189,262,286,313,368,237,187,316,88,189,315,288,237,263,211,200,125,261,131,207,330,66,153,133,321,216
+U18548_at,769,531,2129,1081,901,-17,741,512,-1,66,-298,129,667,-127,392,1206,2316,578,850,1257,228,1230,-180,554,1085,648,1611,907,562,1233,560,1276,989,126,790,1272,1554,1131
+U18549_at,144,78,256,17,114,106,154,107,141,121,153,73,62,220,52,159,142,111,125,111,-21,113,119,90,122,102,136,151,52,129,36,152,123,41,135,94,196,116
+U18671_rna1_at,330,23,557,171,332,131,-114,-91,157,136,32,83,254,180,297,238,70,211,179,187,209,128,176,290,128,174,103,165,288,228,361,128,84,98,143,-27,326,121
+U18914_at,116,298,208,34,85,53,107,205,137,43,81,-22,95,86,83,88,172,134,118,132,41,153,108,143,147,153,242,144,103,80,100,197,129,74,130,30,69,223
+U18919_at,-104,52,157,39,310,-5,48,-176,187,70,126,86,119,129,26,55,-52,4,5,108,9,23,-180,105,63,61,-95,54,-24,88,59,121,-77,-66,303,-124,-101,-294
+U18932_at,-102,-49,-2,-185,-90,-131,-20,-193,-209,-140,-42,-89,-107,-182,-159,-52,-138,-15,-2,-14,-22,-3,-74,-18,-69,-94,-280,-128,-122,-43,-113,-16,-139,-77,-166,-102,-303,-25
+U18937_at,367,129,512,266,282,126,453,442,279,243,177,102,248,247,217,194,199,241,195,398,283,312,294,391,198,274,225,320,115,319,234,413,268,175,160,207,231,295
+U18985_at,-8,18,26,-35,2,16,80,25,0,24,25,1,3,62,-11,-6,-27,5,14,-20,26,23,64,31,43,62,32,15,-38,19,19,13,25,18,-4,-27,-22,-16
+U18991_at,-58,-70,-57,-91,-25,-30,-68,-86,-41,-39,-36,-56,-23,-14,-34,-62,-57,-17,-41,-39,-118,-34,-93,-59,-61,-58,-84,-99,-98,-100,-7,-36,-7,-30,-35,-68,-50,-78
+U19107_rna1_at,16,-10,69,60,23,28,6,13,104,20,50,-7,-17,56,13,81,32,27,29,96,32,28,-3,43,5,-11,7,10,12,47,17,43,73,27,32,39,18,-20
+U19142_at,48,141,231,-1,94,-44,31,91,118,27,113,37,104,128,67,53,107,138,64,154,42,108,49,150,179,89,186,118,120,116,47,137,72,23,48,66,53,115
+U19180_at,-57,-54,-63,-45,-34,-21,5,98,24,61,-29,0,4,-57,38,-19,86,-43,-45,19,-43,77,-9,-52,-84,-12,21,-20,26,-26,0,-28,-38,7,122,-35,-40,-73
+U19261_at,939,427,605,582,687,309,623,794,447,258,336,300,541,341,800,440,821,2455,897,537,469,988,151,752,698,768,613,1447,964,439,670,627,450,206,610,422,530,1730
+U19345_at,244,143,526,263,165,362,337,517,324,223,281,140,167,203,227,171,496,252,79,303,104,227,250,197,160,137,264,300,226,112,265,375,278,143,250,162,421,398
+U19487_at,72,198,3,150,309,17,18,178,42,-2,-17,11,25,62,160,113,567,14,39,357,163,56,7,216,88,-54,-21,106,62,174,136,14,64,66,4,20,464,127
+U19517_at,-290,-274,-337,-256,-44,-241,-371,-452,-236,-219,-266,-162,17,-152,-110,-143,-492,-123,-191,-229,-157,-222,-60,-174,-215,-236,-380,-113,-264,-305,-330,-340,-179,-167,-213,-177,-466,-299
+U19523_at,-4,147,86,-24,41,174,75,-238,74,83,146,102,11,194,85,-44,121,81,-40,17,152,-15,39,18,23,-35,-70,49,0,467,339,189,14,123,142,105,22,360
+U19718_at,-487,-531,-433,-651,-144,-531,-598,-712,-570,-380,-299,-438,-149,-476,-207,-502,-822,-187,-275,-424,-82,-234,-832,-443,-355,-143,-1001,-36,-389,-607,-630,-413,-335,-177,-814,-602,-580,-288
+U19796_at,878,911,859,371,1370,602,235,724,1124,539,260,-79,1180,489,1107,661,1336,762,883,1577,588,945,414,864,367,1452,968,690,969,636,1014,448,378,422,1183,83,195,804
+U19878_at,-28,16,-101,-105,41,35,1,-4,-40,44,40,-4,-16,-33,0,-12,188,10,-30,46,54,-1,36,-70,-3,-8,90,90,105,8,85,70,-7,-6,97,167,65,222
+U19906_at,105,72,120,120,92,69,42,161,49,22,88,34,42,99,57,94,187,85,50,79,8,100,182,64,77,122,131,109,175,63,41,119,64,-17,44,77,99,101
+U19948_at,379,348,476,318,255,245,428,629,346,336,343,235,183,227,199,298,518,279,221,332,61,363,459,226,244,218,643,488,492,376,458,540,393,203,165,401,408,655
+U19977_at,620,369,731,531,360,382,614,284,439,392,428,162,468,324,346,420,622,510,282,354,86,474,343,414,378,413,879,536,769,465,410,498,409,146,593,668,439,1021
+U20158_at,394,923,985,212,323,576,194,245,820,204,344,204,352,2509,481,263,1680,194,347,439,82,189,309,296,313,386,84,260,199,973,698,298,295,125,515,265,778,509
+U20230_at,-338,-831,-213,-219,-238,-375,-567,-107,-841,-485,-691,-166,-266,-273,-77,-497,-328,-390,-348,-88,-187,-222,-360,-278,-360,-332,-1226,-809,-307,-519,-327,-446,-842,-346,-1294,-549,-861,-115
+U20240_at,85,576,59,94,210,-24,3,-5,43,131,148,-11,91,70,199,56,98,-4,-36,154,358,105,98,166,85,60,87,101,-134,189,19,178,90,163,235,-56,124,115
+U20285_at,1222,1624,1909,1349,1438,1292,1527,1553,1802,1329,1385,626,1393,1135,1456,1232,-682,757,497,1530,376,936,1345,1329,1064,1246,1248,1336,1146,1299,544,842,1075,568,1294,1276,1629,470
+U20325_at,541,306,970,424,341,650,423,1097,632,477,265,396,364,461,283,444,523,268,191,304,172,496,298,441,325,425,420,500,464,693,372,465,432,103,387,358,413,933
+U20350_at,585,135,425,177,132,280,270,562,1154,235,22,15,143,739,245,191,117,73,108,185,81,156,9,46,127,115,198,74,149,306,229,168,151,122,258,163,231,151
+U20362_at,-99,-60,-51,-85,23,-32,-23,26,14,-31,-56,-58,-50,-29,31,-94,-109,-9,-82,5,-97,-68,15,-15,-25,-80,-93,-68,-57,-79,-78,-110,-65,-70,-72,-66,-74,-126
+U20391_rna6_at,-644,-1689,-1513,-743,-341,-803,-872,-1074,-1313,-649,-731,-556,-816,-955,-936,-419,-1847,-517,-497,-747,-281,-894,-763,-762,-409,-528,-2099,-338,-625,-767,-880,-1050,-724,-331,-2008,-767,-1056,-883
+U20428_at,533,477,547,491,343,352,594,715,423,384,305,284,318,392,348,324,495,295,307,471,306,-166,416,424,480,339,621,515,444,450,446,414,531,315,581,468,591,811
+U20530_at,62,114,122,-33,127,58,-3,226,210,35,122,10,73,18,96,72,77,83,19,184,2,112,182,-5,-49,95,100,46,-52,65,175,27,182,99,80,-19,125,150
+U20582_at,404,221,403,381,242,216,458,607,241,211,230,204,164,318,231,285,138,148,258,479,279,279,262,332,408,284,217,359,245,309,225,296,340,106,155,307,344,531
+U20647_at,171,52,658,488,275,464,487,796,689,400,564,317,82,340,213,-54,-19,-3,115,120,67,236,265,66,268,336,-3,401,420,247,621,440,320,135,630,447,424,152
+U20648_at,24,63,180,51,31,24,-1,167,108,91,88,77,79,57,72,64,51,62,85,39,52,79,191,8,107,65,89,90,-14,104,56,97,51,-30,116,53,76,156
+U20657_at,450,616,662,702,652,453,342,647,554,350,389,186,333,597,784,326,261,264,223,471,284,385,427,776,328,415,472,869,242,717,759,658,393,314,1493,396,641,401
+U20758_rna1_at,-54,34,-58,-14,46,56,3,160,75,6,26,12,-19,-8,36,26,43,3,58,57,-39,-14,-36,75,17,59,84,48,69,-7,41,-12,43,-2,80,-3,60,111
+U20860_at,-84,-21,-116,-12,4,5,-67,-121,-68,-50,-51,-57,-21,-74,-42,-50,-71,-43,0,-45,-21,-47,-32,-57,-52,-95,-43,3,-72,9,1,-72,-60,13,-31,-57,-29,-75
+U20908_at,638,1006,788,887,677,670,507,712,367,440,494,392,491,418,903,382,955,597,342,1393,1452,367,626,812,756,1011,477,747,569,125,574,761,626,241,437,613,810,799
+U20979_at,485,684,825,435,364,270,0,128,753,242,599,214,650,325,644,223,510,361,171,139,232,115,554,361,388,451,150,257,353,-17,324,328,537,151,381,375,232,265
+U20980_at,-435,-523,-287,-342,-206,-208,-225,-469,-178,-138,-221,-329,-65,-292,-145,-388,-514,-53,-186,-310,-258,-300,-269,-130,-123,-228,-414,-315,-312,-277,-331,-428,-292,-315,-614,-443,-508,-259
+U20998_at,1753,1602,2761,1486,2298,1013,898,1586,2334,878,2016,426,2151,2263,2901,2523,3297,954,1146,4700,2914,1000,1122,2298,498,753,672,407,529,697,786,845,824,1174,440,651,660,580
+U21049_at,156,-166,90,3,-3,-12,159,329,69,-123,11,-14,-94,-73,54,145,-132,-242,-20,0,122,134,106,-153,-33,76,-23,-131,-74,41,195,639,69,399,-122,11,43,72
+U21051_rna1_at,-49,-66,0,-43,-26,-176,-20,92,-54,54,2,-110,-73,9,-32,56,189,110,38,86,-123,-11,26,88,65,72,-203,99,31,56,-12,-6,37,-17,47,-71,48,106
+U21090_at,240,178,-86,45,773,432,-154,-358,789,475,244,321,457,46,751,12,97,-79,186,954,-101,-286,70,548,141,423,-458,-89,57,-176,49,-299,241,-57,-32,349,-162,-531
+U21128_at,-3,-43,21,-2,-20,0,0,41,35,16,-10,47,16,41,18,-2,42,-2,15,8,-2,-15,-9,47,0,19,1,41,0,-23,0,6,56,-6,102,43,2,30
+U21551_at,140,111,253,167,608,218,173,230,245,117,66,60,96,103,283,231,120,125,136,58,164,171,119,174,118,122,345,154,165,138,108,143,234,118,122,222,182,238
+U21858_at,425,400,632,379,630,309,379,304,577,516,790,235,395,632,411,361,824,327,450,1145,1020,360,429,495,385,361,280,789,485,527,571,687,695,560,845,512,516,620
+U21931_at,717,747,1299,935,536,846,1443,1143,706,952,363,640,318,449,643,487,537,610,426,665,562,728,402,523,575,453,830,1119,524,2928,793,346,535,103,3584,807,983,1313
+U21936_at,135,7,75,134,42,122,11,88,25,65,36,33,56,78,70,80,207,92,54,29,48,14,81,53,55,73,175,114,98,132,88,60,25,-2,179,66,97,89
+U21943_at,21,98,-33,-9,44,83,11,103,67,32,40,58,20,88,41,34,-43,70,37,3,34,-52,115,-6,39,15,115,50,81,64,98,109,69,27,70,45,119,39
+U22055_at,1646,1849,1336,1162,2253,926,1381,1227,3929,1678,2886,728,1633,1913,1651,1778,3082,1731,1947,3770,1231,822,1259,1737,1171,1858,808,1751,1502,2244,1436,1467,2059,1270,1929,1827,1810,1754
+U22233_at,87,48,7,-12,84,51,53,68,70,42,32,54,-13,37,50,44,184,46,21,105,34,44,58,106,54,60,84,53,16,4,67,2,80,18,58,77,76,32
+U22377_at,209,406,118,65,203,104,75,53,184,222,427,172,277,182,285,233,176,171,244,378,344,341,239,238,118,151,28,315,9,335,281,364,382,119,419,78,266,107
+U22398_at,157,163,128,-94,141,10,-20,59,54,82,70,-8,88,73,64,86,-43,55,48,6,236,2,307,180,206,53,3,173,122,55,-121,194,85,83,77,-57,38,28
+U22526_at,235,374,-9,-52,272,106,-5,-1,462,253,316,-126,279,55,177,-53,442,150,224,1264,-54,268,89,20,-27,108,143,49,12,34,-72,43,225,-61,343,-129,246,220
+U22662_at,-562,-125,-359,-304,-92,-179,-562,-161,-232,-166,-227,-90,-62,-145,-127,52,-226,-110,14,-70,52,-137,-376,-181,-20,-11,-330,-271,-415,-262,-91,-8,-193,34,-458,-354,-256,-110
+U22897_at,1078,338,782,721,1084,300,599,553,592,405,378,192,1295,443,1113,568,1607,222,681,909,409,253,395,889,446,536,441,459,264,628,334,483,714,282,541,264,562,380
+U22963_at,460,263,474,643,414,298,583,451,449,483,277,221,309,382,291,495,526,369,355,294,144,326,550,346,286,314,588,531,492,657,497,332,538,123,247,406,394,791
+U23028_at,99,221,276,199,390,177,510,418,142,147,180,11,287,328,328,251,236,207,243,322,127,139,227,291,241,174,184,115,317,122,205,352,38,91,103,-11,154,165
+U23070_at,-38,-30,-102,-4,-45,-65,-85,17,-73,-73,-84,61,-48,-106,-9,-59,-71,-84,-86,-44,64,10,-87,-25,-63,-104,-4,-66,43,-91,-31,37,-151,10,-13,-91,-144,-154
+U23143_at,395,372,528,435,453,355,551,479,570,455,380,159,278,511,468,363,353,453,349,573,101,247,482,412,245,304,414,296,262,443,396,214,422,270,675,286,445,531
+U23752_at,-80,-65,-21,-31,-39,-78,-57,-98,-67,-78,-115,-57,-61,-45,-29,-83,-74,-43,-30,201,-79,-52,-18,-32,-40,-42,-56,-52,-52,-25,-64,-67,-80,-46,-42,-51,-58,-60
+U23803_at,647,369,666,815,293,346,409,679,947,495,955,34,847,484,515,582,51,657,1021,2810,763,1199,1153,936,600,607,244,715,382,618,277,934,1228,575,376,901,365,573
+U23942_at,107,65,15,90,202,-8,23,-8,303,62,175,51,138,74,82,73,207,112,37,129,396,70,47,182,50,55,161,96,36,99,75,16,175,47,77,119,84,197
+U23946_at,565,217,532,520,563,284,626,692,288,125,623,227,242,564,1145,360,855,144,85,713,-7,468,511,650,486,400,115,563,204,317,191,606,337,125,205,194,202,176
+U24105_at,3163,3504,2991,2103,2698,3065,1245,5037,3076,1665,2375,1769,1960,2737,2869,2127,4357,2544,1419,3757,795,2911,2201,2828,1921,2172,3698,2643,2156,2310,3718,4137,3472,2119,4482,2848,3468,4050
+U24152_at,955,473,1259,896,605,819,341,940,1002,722,708,416,464,597,883,769,2144,777,572,482,573,503,691,762,419,696,999,796,807,1056,456,760,896,410,950,1037,811,899
+U24166_at,2320,1991,1711,1500,1825,983,1273,1851,2168,1007,2909,701,1810,1491,1526,948,2637,1079,1119,3206,1796,1353,1025,1047,1708,1821,2124,1357,916,1778,1480,1929,1753,1110,1844,1229,1424,2339
+U24169_at,-113,-1027,-283,95,789,-215,-16,-305,138,-102,-146,-337,167,168,233,86,-231,105,-182,1057,212,-368,-283,363,-104,-203,-485,-871,-238,-350,-395,-251,-123,141,-111,-448,-555,-701
+U24186_at,167,17,364,207,124,144,171,350,190,88,186,-8,1,154,36,205,144,123,167,123,41,19,195,39,-18,112,212,189,91,41,152,-52,-98,37,178,132,228,237
+U24266_at,119,119,192,160,265,101,90,328,124,95,84,25,156,89,283,292,423,134,251,1004,93,100,132,278,198,210,445,220,252,77,32,165,148,105,124,175,89,189
+U24576_at,91,-77,-165,-44,289,-1,819,-43,24,-31,-47,-10,157,523,228,43,-245,-30,2,352,362,6,-20,-11,-65,69,-86,-118,-177,95,-96,-20,-7,9,-55,-51,359,-82
+U24577_at,-11,-45,-76,-134,-1,-48,-75,-4,-33,-13,-25,-51,26,-34,0,-42,-82,-23,-28,-32,-27,-88,-53,-3,-76,-23,-51,-27,-64,-35,-5,-73,46,-11,-14,-47,-59,-82
+U24704_at,463,570,659,377,748,540,230,209,959,611,444,221,545,567,647,481,385,384,42,1092,87,52,357,618,206,405,-215,-89,141,116,466,176,409,427,92,414,66,-75
+U25029_at,251,143,177,189,172,177,502,551,64,56,357,61,248,101,314,225,68,66,489,804,1318,490,62,772,75,110,87,104,50,170,77,113,66,279,77,64,75,82
+U25041_at,3,-186,-23,-219,-114,-160,-208,-325,-127,-194,-8,-24,-115,-216,8,-74,-293,-23,-115,-212,-27,-164,-250,-98,-135,-101,-328,-3,-319,13,-78,-253,-296,-22,-299,-228,-207,-310
+U25128_at,90,65,157,11,50,23,80,89,68,39,28,93,53,74,50,24,86,127,18,70,31,71,72,312,83,54,111,173,377,122,102,85,306,99,55,177,132,112
+U25138_at,358,-165,-118,-701,139,-391,-381,-1106,-199,-1,-293,-194,78,-164,-134,421,-706,248,-219,-251,-91,-265,-455,197,-18,175,-186,90,-750,-104,-421,-340,111,-279,-35,-412,-325,-73
+U25165_at,465,503,682,589,930,344,549,460,1414,817,684,372,710,614,842,873,898,1341,679,1848,1509,326,539,843,426,392,153,573,286,454,584,304,542,542,684,321,407,325
+U25182_at,156,249,51,157,236,117,36,-40,213,171,161,149,678,98,101,223,227,182,197,553,258,2,98,23,100,158,95,67,125,206,93,24,116,158,423,95,153,23
+U25265_at,720,688,1067,226,346,138,341,797,11,121,287,-86,470,202,205,600,299,535,-124,684,3,24,210,413,337,509,783,163,120,486,-221,728,258,-23,208,316,338,4
+U25433_at,-101,36,-166,122,20,12,241,-77,45,109,88,40,-66,-36,99,127,-68,66,41,-73,6,20,89,-39,31,99,158,56,50,-79,8,135,-1,58,162,-28,221,-38
+U25435_at,509,624,677,404,430,474,425,329,774,327,823,15,510,504,675,278,390,147,184,1027,274,495,381,508,245,243,172,165,113,275,348,414,243,130,191,96,298,258
+U25750_at,688,555,1074,759,503,563,609,848,755,504,602,278,535,524,350,687,681,513,422,692,213,478,455,574,445,498,705,649,608,566,472,566,695,237,462,489,768,859
+U25789_at,6556,10632,7688,7736,9239,4850,4822,5905,10185,7775,9182,5643,6032,11123,10378,7971,6037,5599,12277,11543,4792,6885,6548,7626,7118,6151,5399,9925,5624,5656,9075,11003,9621,9333,9806,6379,8438,9805
+U25801_at,-248,-148,164,76,41,142,255,245,-3,88,-42,87,88,225,-25,-8,0,-17,235,-48,-121,2,43,-67,-138,69,1,-18,12,97,29,51,-195,-74,-57,-10,273,43
+U25826_at,-174,-224,-138,-213,14,-183,-391,-92,-25,-31,-103,-231,-24,-185,-67,-35,-205,-51,-68,-200,-189,-121,-60,70,-96,-178,-219,-201,-132,-168,-286,16,-127,-171,-139,-58,-233,-291
+U25849_at,347,1332,479,503,930,296,433,179,1161,925,1501,61,562,563,1112,912,665,34,637,1886,2897,300,537,754,411,20,-37,196,182,149,272,459,455,789,202,111,465,95
+U25956_at,97,845,610,-219,59,362,-84,-34,873,115,-76,-231,142,2181,-11,37,1602,270,79,48,-97,-128,-245,-140,-18,-2,-97,527,86,846,-151,-86,21,-46,497,149,364,135
+U25997_at,-79,-28,-175,-115,-111,-72,-40,-161,-109,-47,-76,-109,-70,-99,-85,-105,-228,-93,-28,-77,-48,-86,3,-140,-70,-24,-40,-79,-120,-35,-23,-93,32,-63,184,-77,-90,-110
+U26032_at,141,37,36,35,150,42,129,35,167,55,99,35,180,103,102,126,232,74,53,440,101,-5,-32,121,65,72,7,31,9,9,-7,40,83,114,4,47,-24,88
+U26174_at,34,17,-30,3,74,-48,-58,70,47,51,-57,84,69,23,194,39,-67,1,69,-24,41,34,-3,14,4,39,-10,45,67,124,-48,-55,9,-53,-56,35,48,-78
+U26398_at,-111,288,226,271,-40,280,119,187,156,109,299,182,52,309,27,214,126,140,488,47,-7,160,-3,78,94,60,78,83,120,207,372,333,74,38,106,74,183,161
+U26403_at,68,94,84,42,172,17,43,154,261,32,155,27,171,16,4,129,-25,33,88,-30,116,49,140,214,174,142,70,18,168,88,98,106,190,-11,-4,48,44,126
+U26591_at,-148,-444,-341,-281,111,-606,-142,-368,-488,-293,-356,-405,-122,-151,-226,21,-876,-220,21,144,-148,-370,-452,-149,-252,-60,-686,-459,-726,-229,-86,-219,-322,210,10,-461,-25,-448
+U26648_at,768,189,555,575,689,122,376,863,955,386,405,107,701,358,707,804,915,528,390,1406,1772,421,212,726,451,857,472,527,548,553,384,602,591,507,199,367,530,585
+U26710_at,399,357,33,472,304,-92,300,205,319,130,18,18,302,435,463,493,493,80,257,1370,833,227,115,321,84,325,286,213,7,74,103,118,163,113,122,296,145,256
+U26712_at,-6,-61,-9,-24,26,55,13,-31,-9,2,6,5,2,-1,-22,26,44,22,0,-5,-1,14,34,1,26,-18,15,-56,12,25,38,-28,-44,29,-8,-26,-7,-9
+U26726_at,-232,-293,-403,-296,-324,-293,-215,-359,-302,-169,-210,-130,-359,-483,-180,4,-1013,-484,-137,-574,-163,-337,-269,-286,-190,-498,-876,-463,-464,-543,-300,-645,-299,-173,-279,-200,-378,-337
+U26727_at,294,246,572,383,353,1,292,-154,-209,-83,63,179,224,-170,285,437,448,77,-16,406,23,51,284,309,212,253,452,152,-108,44,277,81,126,31,52,132,-26,4
+U26914_at,291,164,399,208,182,40,262,104,24,148,180,100,125,72,64,197,312,138,55,-8,119,32,47,94,119,149,242,264,28,257,-40,-96,237,94,53,121,222,334
+U27109_at,95,30,122,74,18,-42,26,164,108,49,54,-18,65,45,-11,111,5,43,50,40,24,45,93,51,29,72,159,48,28,77,-25,108,48,94,18,57,62,15
+U27185_at,-1,16,-6,-29,45,1,-21,-50,-50,-3,-20,4,-7,17,-33,68,-4,-19,-41,-33,-49,-30,5,41,-35,-30,-14,-45,-69,-34,9,-10,-43,2,0,-24,-24,13
+U27193_at,-110,1,-94,-92,-68,-67,-109,-44,-85,-80,4,54,-66,0,-87,-35,-155,-11,-101,-114,2,-61,-140,-44,-179,-35,-283,-12,-96,8,-171,-27,-43,-150,113,-54,-103,-338
+U27330_at,304,301,289,312,300,266,277,331,255,134,210,202,166,214,250,265,230,209,251,273,277,283,357,417,332,217,270,288,322,221,327,227,212,74,135,303,408,542
+U27459_at,64,22,151,149,165,-19,173,139,140,66,67,43,238,216,186,132,208,68,130,302,219,37,-32,105,52,73,173,54,76,62,54,76,140,45,46,43,117,19
+U27655_at,65,13,-36,-85,157,33,6,-424,111,-144,38,-100,-12,405,18,158,-182,0,-55,49,-18,-74,-129,28,94,124,-156,-15,31,-33,7,149,109,13,-73,-6,-185,-209
+U27699_at,-466,-426,-824,-534,-149,-558,-356,-782,-412,-524,-244,-271,-287,-347,-167,60,-460,-251,-156,-248,208,-300,-406,-490,-198,-187,-560,-346,-223,-291,-258,-618,-291,-87,-374,-604,-852,-832
+U27768_at,-39,-24,-52,-30,-163,250,-107,26,-38,-173,-26,35,-127,-26,-96,-142,-299,-186,-107,-237,62,-145,-43,-78,-89,-174,-233,-159,216,-110,-36,-133,-171,-58,-111,-3,-165,-172
+U27831_at,798,317,1194,785,422,595,1065,1217,844,728,750,458,573,873,481,702,695,596,225,341,381,604,267,837,580,520,973,807,904,922,1009,591,819,422,861,882,1067,1438
+U28042_at,123,-3,19,170,225,12,55,133,64,9,61,47,237,264,154,174,181,61,55,444,61,5,68,201,17,1,75,73,7,-29,38,-37,99,-14,-51,-17,60,-25
+U28043_at,-11,-240,-283,-84,-132,-83,-120,-34,155,-271,-115,-194,-80,-219,-324,-165,-352,-71,-284,-396,-186,-219,-15,-249,-213,-177,90,-207,-105,-233,-353,-257,-230,-207,-426,-86,-22,-301
+U28131_at,650,-60,172,712,257,254,267,686,606,-82,232,446,-116,351,297,1,28,-80,-104,-239,187,455,180,244,119,37,-54,317,401,578,815,510,448,98,-415,813,788,901
+U28150_at,-9,45,261,60,-56,30,95,236,46,-25,-24,1,11,91,-81,44,112,32,144,120,81,121,93,190,15,57,-15,45,302,-47,83,87,6,178,-70,81,206,219
+U28249_at,-105,-124,-206,-92,-66,-94,-110,-284,-170,-129,-98,-114,-83,-202,-42,-40,-66,-147,-54,-81,-83,-119,-123,-92,-101,-79,-151,-234,-125,-56,-253,-90,-131,-39,-98,-206,-103,-208
+U28251_cds2_at,-128,-89,-356,-149,-114,-160,-126,-208,-181,-167,-146,-116,-177,-179,-121,-128,-74,-175,-58,-208,-159,-173,-345,-240,-189,-158,-367,-229,-14,-167,-32,-270,-341,-118,-366,-32,-15,-196
+U28281_at,177,-42,331,57,62,-58,99,-146,113,65,257,94,184,22,-24,250,453,161,20,181,-8,180,36,113,63,142,222,60,209,-16,80,245,28,21,107,150,111,261
+U28368_at,-20,-73,-4,15,60,-14,89,32,-18,-45,34,-77,-35,90,-15,-56,20,26,-58,2659,26,-57,41,45,107,15,-54,-35,40,-76,63,-13,-88,-50,45,18,90,41
+U28369_at,32,100,107,109,104,184,213,127,135,71,43,171,-16,56,0,140,-106,60,38,49,79,94,110,34,72,99,29,-23,98,124,118,55,19,38,-69,122,98,54
+U28386_at,619,922,331,829,1081,161,756,68,884,455,1332,132,658,757,1008,682,584,1091,269,978,1299,294,531,1068,488,431,230,792,435,400,607,898,1030,480,251,227,480,419
+U28413_at,19,-21,68,-6,47,-26,21,-55,-22,45,-21,-58,-2,-89,9,12,-26,104,-56,194,-13,-53,45,32,51,15,4,-115,-38,-69,-112,-49,114,70,-68,88,54,118
+U28686_at,907,1789,910,753,892,558,488,866,1149,1143,2045,987,1055,990,977,630,825,494,587,3124,939,1404,617,971,1018,914,430,898,747,601,751,1481,938,1017,873,567,1001,1123
+U28687_at,424,322,591,110,175,156,43,698,270,170,281,199,332,389,236,349,728,374,185,165,202,215,372,295,194,546,344,313,485,249,367,490,299,171,186,204,302,512
+U28727_at,-724,-615,-873,-851,-289,-665,-719,-1122,-586,-463,-428,-403,-485,-660,-513,-478,-1097,-461,-486,-744,-374,-557,-486,-461,-1093,-465,-1087,-765,-678,-709,-793,-862,-595,-335,-594,-797,-686,-925
+U28811_at,1188,166,449,872,896,275,134,310,838,-126,380,50,210,509,1305,-43,-449,129,69,511,784,300,235,1014,298,338,353,425,146,763,-48,-34,407,138,435,294,733,178
+U28831_at,364,597,691,298,486,444,99,248,413,163,821,117,467,826,514,227,677,231,41,475,1746,17,313,564,359,316,259,1146,483,220,222,676,703,193,50,197,542,301
+U28833_at,215,134,101,244,240,64,166,145,68,48,57,132,466,85,324,141,159,65,143,168,194,281,172,230,145,142,195,11,67,29,6,122,73,82,113,51,107,111
+U28963_at,946,416,842,793,798,465,633,446,926,446,758,273,862,370,669,519,1063,294,585,1072,261,461,503,642,525,621,522,431,461,455,803,714,591,282,589,563,933,481
+U29091_at,-327,-153,-301,-196,-208,-284,-341,-83,-348,-143,-125,-189,-189,-296,-218,-229,-574,-197,40,48,54,-113,-332,-19,480,-16,-517,-279,-60,-41,1989,1760,159,709,-114,-315,-267,736
+U29171_at,932,1277,962,742,839,521,529,937,682,568,1103,1000,921,717,846,1228,1487,883,948,1144,62,2218,587,688,1103,723,511,1253,673,1919,3150,4129,2460,1700,807,834,1042,4772
+U29195_at,-77,29,104,-59,15,-5,-157,-161,-31,368,353,-38,-78,-103,-35,-89,-207,-59,29,-57,-8,-10,-91,1565,-55,-65,-201,-128,-62,-4,-158,86,427,-33,-43,851,-49,-39
+U29343_at,310,204,234,271,233,-16,124,94,176,148,36,87,211,222,189,113,217,153,92,169,24,162,85,221,53,161,25,34,254,65,279,94,171,41,161,181,196,135
+U29589_at,-143,-23,-149,-114,-62,-69,-218,-143,-151,-163,-92,-64,-112,-133,-86,-124,-114,-105,-126,-59,1,-85,-24,-157,-113,-130,-153,-212,-187,-162,-74,-89,-105,-71,-75,-133,8,-173
+U29607_at,7072,6849,8705,6609,3654,5885,7620,8243,4257,3684,4523,4064,5410,6989,5833,5822,6527,4385,3622,9305,7028,5222,5796,5141,4327,4955,7285,7887,4527,3471,4591,5800,3672,1454,2855,4295,7389,5693
+U29615_at,-179,43,84,115,118,-76,-84,-266,181,497,-162,-25,93,54,23,786,482,213,203,311,161,-194,-245,256,184,156,-7,59,-67,62,113,-207,-1,-198,53,75,562,620
+U29656_at,345,548,566,611,543,376,572,454,889,486,425,254,304,465,572,374,853,587,366,613,249,316,581,1114,257,339,464,796,512,682,759,591,564,388,908,973,838,511
+U29680_at,126,712,309,140,79,113,114,238,260,283,163,389,101,120,103,106,121,427,64,87,126,47,157,131,156,143,103,205,139,1978,2355,104,585,249,1247,147,518,1752
+U29700_at,949,503,831,952,24,481,554,848,741,820,804,382,386,545,407,861,819,505,598,404,288,847,900,475,476,679,517,655,759,614,296,868,817,142,689,842,518,724
+U29725_at,-282,62,-166,-148,31,-37,5,-124,107,107,71,-156,22,180,-22,-79,122,-17,-27,126,-31,-162,-5,457,150,-99,-115,118,144,310,-358,14,291,-87,71,-338,26,283
+U29953_rna1_at,271,853,516,72,442,293,142,-218,843,270,95,-1,187,193,194,208,-63,150,80,660,-124,451,315,26,199,203,56,111,293,188,72,351,214,-125,219,39,117,374
+U30185_at,-360,-252,-411,-419,-159,-359,-438,-694,-303,-334,-300,-241,-288,-305,-226,-266,-236,-306,-247,-185,-144,-235,-341,-302,-245,-160,-281,-528,-425,-491,-273,-304,-373,-165,-29,-346,-288,-472
+U30245_at,8,15,-20,-62,1,0,-1,-23,-24,-36,-22,-4,-30,-33,-5,-30,-57,-4,9,-18,-76,-51,-60,-19,1,10,-25,-23,-40,-47,-24,49,-13,-37,-45,-57,-6,-50
+U30246_at,125,110,147,112,150,64,45,115,229,192,118,74,162,101,95,110,219,148,12,73,107,94,-1,227,73,50,363,96,91,53,66,94,45,41,209,78,228,104
+U30255_at,273,289,164,483,914,376,184,232,890,487,942,538,523,644,999,302,1055,368,76,600,-47,70,-102,539,601,171,26,630,391,1018,692,549,819,1005,2784,1462,755,982
+U30313_at,-241,59,-145,-140,111,160,-208,-494,-84,113,-22,-61,-6,-173,-52,-13,-394,15,-57,283,-71,-226,-9,-31,-42,-78,-283,-207,-250,-105,-105,-159,-57,-23,-34,13,-175,-269
+U30521_at,2191,784,2529,2336,2824,1691,1591,1721,3332,770,703,438,2804,1661,3548,3456,2128,473,558,10062,2444,609,4586,2865,427,422,1625,1047,1180,281,189,314,814,383,564,1517,756,401
+U30610_at,316,129,63,310,163,298,184,-43,-10,154,202,73,209,128,128,304,97,110,151,154,127,-192,-7,9,39,147,-236,131,62,188,-69,-483,281,50,132,248,304,-75
+U30825_at,2970,2965,2366,1919,2732,2715,1510,2193,4560,1516,2750,1573,2217,2920,3515,2025,4504,2095,2092,5892,1041,1896,2321,2777,1522,1416,893,2031,1053,1905,1985,432,2576,1771,1146,2152,3406,299
+U30828_at,133,-47,-152,130,-18,23,307,-137,303,-152,-104,-28,118,39,-25,363,254,-137,137,145,-48,56,110,228,-52,-137,-53,-113,-60,-262,4,-88,-149,-23,-65,-75,75,-138
+U30872_at,376,129,319,624,311,245,446,355,232,207,163,79,655,116,376,131,611,236,226,332,157,234,254,224,190,236,397,170,375,174,250,130,176,125,208,188,252,325
+U30888_at,605,717,661,381,1058,378,492,785,788,417,1533,350,1284,879,625,466,2283,404,387,1295,347,478,501,898,439,593,542,1494,577,646,1066,1922,1097,572,881,519,522,1044
+U30894_at,-41,93,209,247,203,195,174,-115,156,477,272,145,392,23,330,295,13,494,396,147,39,270,214,83,145,247,500,21,259,220,28,63,225,298,526,333,326,-99
+U30930_at,48,-45,118,53,84,387,-8,200,12,-78,-55,66,-17,38,5,5,173,-1,12,-41,108,176,77,76,66,4,6,63,28,202,146,-40,-3,81,-57,69,198,138
+U30998_at,131,69,123,230,67,24,63,128,58,39,71,21,109,37,6,55,127,111,38,144,-27,111,68,71,86,126,103,83,84,146,93,94,159,13,32,65,86,179
+U30999_at,-157,0,160,228,77,3,-8,58,-85,-22,-8,22,70,-97,35,118,1146,444,439,23,233,87,106,50,10,220,-70,629,331,389,192,106,208,103,460,167,216,9
+U31099_at,30,131,46,295,6,224,181,89,95,-84,-43,123,-28,45,162,120,254,-23,39,1145,4,-35,83,13,38,244,-115,-142,60,-129,363,-27,-104,153,159,323,364,442
+U31116_at,66,-34,-21,1,-2,-3,3,103,38,25,-5,37,-20,38,7,-38,-125,4,6,20,-1,-37,17,-13,-35,-14,148,46,9,-33,-3,12,22,58,-58,54,-2,58
+U31120_rna1_at,333,203,258,256,193,176,134,200,235,95,214,116,166,123,112,194,160,308,102,245,81,279,188,287,109,101,381,252,98,252,159,236,282,81,146,27,183,259
+U31176_at,611,456,709,599,321,423,687,757,432,184,292,209,130,362,359,218,557,347,107,456,87,417,340,779,258,320,741,539,372,400,170,627,365,183,332,460,550,618
+U31201_cds1_at,-140,-137,-199,-201,-102,-316,-346,-230,-184,-120,-215,-129,-92,-137,-159,-132,-240,-141,-136,-223,-107,-95,-26,-92,-96,-158,-228,-177,-245,-194,-273,-211,-177,-15,-201,-243,-296,-291
+U31248_at,259,155,207,172,94,183,225,173,285,202,182,155,59,309,105,49,114,43,141,105,128,151,70,187,74,82,212,148,281,159,178,219,211,38,198,192,352,203
+U31342_at,518,607,562,618,376,551,789,605,627,338,370,366,352,483,431,443,838,375,356,653,354,466,509,668,600,484,256,670,331,698,689,544,820,305,1071,753,1036,873
+U31382_at,185,221,655,295,144,309,204,280,431,219,273,135,93,206,67,146,344,129,127,198,182,128,-13,299,111,106,242,275,129,124,174,233,307,69,294,129,196,450
+U31383_at,395,223,425,293,549,23,210,88,419,247,207,163,1095,629,568,586,567,280,463,1631,892,88,243,618,236,478,84,205,168,500,166,235,236,217,438,185,706,282
+U31384_at,1094,186,237,169,302,-28,236,1074,-41,138,65,439,383,98,154,143,164,156,51,8289,107,48,191,8,240,328,439,185,158,126,250,149,183,15,302,99,712,294
+U31449_at,46,-4,-29,-83,-59,-113,62,-103,-89,-70,-46,-116,-10,13,-26,12,-27,-10,-93,45,-6,64,-11,8,20,98,37,-72,-36,-52,-130,32,-44,-67,-176,1,-52,-9
+U31501_at,478,237,581,350,236,314,389,452,637,721,436,-12,836,254,413,448,315,577,517,1092,207,360,271,556,167,477,585,464,288,303,202,706,398,396,53,256,419,861
+U31628_at,-301,-204,-225,-513,-24,-264,-252,-397,-186,-44,-410,-106,-171,-103,-56,-92,-275,-155,84,-185,-191,-328,-294,-370,-208,-31,-129,-275,-406,-49,-68,-232,-104,54,-70,-265,-205,469
+U31799_at,-70,-95,-132,-204,-92,-195,-82,-23,-144,-124,-118,-34,-225,-137,-65,-66,-206,-97,-77,-7,-24,-39,-127,-108,-104,-69,-54,-28,-141,-227,-93,-45,-63,-45,-280,-240,-239,-143
+U31814_at,790,420,1223,449,856,471,591,515,1074,485,541,176,1666,705,762,646,1349,331,395,2251,793,279,904,657,258,358,521,427,218,167,393,494,145,161,385,418,379,412
+U31875_at,675,501,886,584,372,261,751,709,525,436,446,280,412,493,410,530,638,425,370,708,82,680,383,460,429,411,677,598,613,604,631,561,525,-33,532,576,724,683
+U31930_at,2070,1732,3533,1733,2335,2526,1730,1031,4202,4159,2041,1349,2665,2533,3847,2274,4056,1463,1542,4924,1928,464,2108,2097,1460,2169,1225,1761,1882,1522,1549,1464,2373,1310,1409,1517,1730,1039
+U31986_at,263,235,238,298,162,430,270,361,407,206,141,376,89,327,134,408,149,106,239,188,176,278,359,85,224,114,506,217,139,174,267,321,399,155,125,460,385,222
+U32114_at,74,48,27,76,75,60,26,35,46,71,43,68,25,32,82,71,40,29,5,30,-11,58,62,-4,24,23,54,65,33,16,106,6,74,29,67,31,76,70
+U32315_at,-42,-56,-196,10,-42,-42,42,-1,-63,-80,-48,30,102,-83,23,9,20,-76,68,119,-63,-52,-151,77,101,22,0,-132,-14,-62,42,-50,-22,30,-79,-10,-48,-76
+U32324_at,-9,144,142,4,-31,183,89,272,-11,3,14,34,160,533,143,333,141,51,95,66,207,-61,11,195,43,-38,17,127,129,20,126,122,77,31,53,-27,3,96
+U32331_at,18,12,140,71,20,37,104,46,62,10,116,28,32,89,16,-2,27,42,24,78,-16,60,-15,21,58,-9,51,40,62,98,-6,43,44,77,97,-19,46,109
+U32376_at,-92,-107,-132,-146,-33,-161,-201,-184,-185,-153,-88,2,-89,-130,-40,-127,-194,-252,-30,-69,108,-164,-176,-103,-24,-128,-219,-62,-31,-168,-57,-71,-91,123,-238,-170,-176,-151
+U32439_at,161,109,225,244,24,232,122,151,237,172,114,22,113,202,91,96,-21,146,119,109,76,160,140,106,108,162,175,104,228,140,132,184,220,138,115,155,62,384
+U32519_at,643,84,948,747,616,892,332,644,242,396,323,201,548,861,703,428,661,271,583,833,-113,274,476,915,324,288,708,628,211,292,416,318,473,155,274,452,611,348
+U32576_rna1_at,135,-132,257,-58,135,-167,68,-398,-15,-1,21,33,110,-67,-184,353,-545,332,-29,180,29,109,-28,48,-70,356,183,-29,-1098,155,-237,-622,184,-119,-529,-253,62,-41
+U32581_at,304,198,376,339,196,197,285,329,259,148,243,159,206,203,296,181,517,135,178,234,144,317,119,190,63,-85,420,166,170,201,93,-18,329,-3,-21,214,366,506
+U32645_at,147,-240,-417,-255,72,-245,-152,-568,-363,-194,-365,300,379,370,7,-18,-330,-134,-219,-55,-84,-164,-349,367,-281,-39,-472,8,-444,218,200,-214,-45,566,949,-27,-313,13
+U32659_at,206,55,280,204,9,144,149,329,135,88,102,149,107,104,66,252,220,166,44,16,64,176,148,191,42,116,328,229,182,135,85,156,200,-35,60,185,141,324
+U32680_at,218,560,853,921,585,403,1023,380,171,458,147,426,553,756,637,810,1743,390,167,797,68,597,17,548,404,361,721,391,560,569,581,1073,626,279,746,524,532,1079
+U32849_at,593,660,628,772,916,394,613,581,747,454,428,247,441,1214,1045,658,2560,205,331,1567,984,227,431,751,362,386,267,512,615,456,391,492,598,591,293,678,487,666
+U32907_at,-67,-33,-112,-126,-80,-103,-95,-257,-115,-56,-92,-10,-48,-73,12,-142,-86,-157,-46,276,-11,-153,-193,-168,-72,-166,-92,-142,-43,-168,-196,-79,-125,-46,-12,-40,-201,-193
+U32944_at,3349,1002,2089,1625,3502,316,1530,1042,2286,934,282,277,2069,1613,2952,3110,2591,820,1116,5908,1143,108,146,2457,1081,1480,1283,427,288,295,224,230,384,179,651,469,328,133
+U32989_at,-100,-54,-57,-76,-86,-80,-89,-197,-82,-35,-102,-33,-64,7,-19,-159,-172,-76,-54,-91,-22,-95,-70,-42,6,-100,-111,-144,-117,-147,23,-81,-128,-87,-82,-77,-34,-28
+U33017_at,-953,-348,-704,-346,-330,-352,-633,-856,-540,-336,-378,-403,-541,-160,-201,-461,-790,-197,-352,-427,-31,-71,-281,-317,-472,-639,-843,-531,-550,-606,-589,-514,-469,-147,-491,-613,-556,-704
+U33053_at,610,889,550,238,338,471,388,230,784,466,798,265,624,863,902,457,1058,347,501,1064,-56,126,454,513,217,806,-142,877,437,757,351,315,658,443,624,563,1133,733
+U33054_at,-333,-73,-91,-80,-56,-110,-6,-89,-74,-60,-106,-119,-222,-306,11,-212,-276,-184,-212,-243,-152,-87,-104,-71,29,-24,-311,-126,-108,-319,-234,-429,-77,-18,-146,-133,-66,-394
+U33147_at,579,1361,701,252,379,156,631,863,413,379,391,50,393,453,218,233,704,328,252,312,86,228,368,143,225,375,597,298,259,463,542,402,293,-10,460,171,412,787
+U33267_at,41,59,106,87,65,32,87,88,61,79,23,68,66,113,98,51,136,14,31,220,78,-19,32,58,29,64,122,99,33,3,118,57,27,-17,103,36,79,109
+U33286_at,280,190,610,297,1017,273,357,332,713,250,681,112,702,448,977,433,861,385,380,1237,431,128,208,760,164,445,280,232,259,384,167,486,238,157,202,155,105,189
+U33317_rna1_at,95,112,42,-17,158,136,75,112,109,82,172,50,123,71,141,167,127,70,173,202,56,18,87,116,183,15,117,122,98,-2,213,213,-14,-77,156,145,238,296
+U33429_at,-1128,-140,-1267,-1150,124,-796,0,-607,130,-746,-28,-307,23,461,-665,97,733,60,139,-289,106,-852,-531,-425,59,-307,-1639,560,-887,488,496,76,-367,-167,-322,244,528,1387
+U33447_at,-644,-600,-761,-664,-316,-439,-685,-793,-560,-492,-675,-330,-386,-458,-384,-357,-981,-418,-390,-397,-228,-444,-511,-574,-466,-370,-871,-647,-644,-908,-794,-572,-604,-226,-868,-610,-646,-847
+U33761_at,-8,35,0,63,201,40,28,56,-71,-15,11,61,51,58,81,38,213,5,-24,102,8,-54,30,25,-9,7,54,-42,-60,-83,73,-60,-54,43,92,-52,20,-118
+U33818_at,573,552,595,601,1237,449,693,469,727,1285,621,359,577,619,862,588,764,1375,447,1646,1243,479,501,1038,423,440,467,872,569,769,854,980,872,566,1187,643,622,568
+U33821_at,1799,1453,2642,1795,1505,1191,1850,1689,1497,965,1617,467,996,1244,1812,1172,1922,558,1198,2856,1095,833,1379,1424,1374,484,1545,2505,1067,1774,2730,2054,2039,1931,2248,1712,2450,1789
+U33822_at,-418,-14,369,-358,11,215,-129,-709,468,2,-301,-107,276,-302,505,32,-53,22,739,278,211,559,-165,-188,-44,509,-538,-470,-743,-591,-403,-325,-306,-173,-594,-451,-74,-565
+U33837_at,-67,-87,-195,-87,-9,-48,-126,-68,16,-152,-34,-24,35,-71,-46,-76,-43,-173,-59,-66,-59,-95,-64,-88,-21,-177,-384,-115,-60,-75,-82,-32,-57,-23,-87,-143,-115,-124
+U33839_at,423,442,660,425,350,439,571,595,455,458,402,281,296,447,326,363,280,220,412,359,209,264,442,383,293,308,605,449,488,474,557,565,439,317,434,621,525,703
+U33849_at,-367,-279,-274,-963,-251,-257,-761,-1045,-282,-368,-183,-303,-241,-35,-359,84,252,30,-11,-114,-178,-27,-560,-33,-475,-173,-719,-536,-473,-385,-437,-382,-644,82,-59,-79,-814,-529
+U33920_at,229,-72,276,65,50,56,72,250,211,-30,37,86,85,-50,89,76,-32,65,-57,297,-61,22,-98,-189,186,-56,204,24,-16,128,-37,337,-1,15,485,119,63,-20
+U33921_at,138,190,245,180,210,174,131,122,74,77,82,64,127,227,245,139,358,86,77,324,-31,132,18,306,140,236,100,240,137,10,83,163,16,30,123,70,147,12
+U34038_at,304,447,384,399,232,360,-292,338,387,170,163,291,34,306,160,253,469,67,240,139,13,414,212,327,378,232,306,250,519,227,446,383,472,226,360,422,337,493
+U34044_at,349,193,342,401,264,314,193,365,295,125,173,142,195,144,263,121,351,199,22,248,201,44,256,179,164,149,167,71,14,1,155,251,212,-47,105,154,209,123
+U34252_at,255,519,387,424,536,103,431,559,452,146,403,67,352,560,1144,279,1447,249,-10,1191,1303,782,136,518,434,192,239,248,28,251,100,186,222,235,980,277,163,59
+U34343_at,1389,1849,2887,1048,1529,1168,904,1016,2637,1384,1714,836,922,1919,1585,1329,1977,901,763,2500,2799,948,1362,883,793,846,888,892,930,1098,1013,1031,1153,1189,1541,1309,1057,1290
+U34360_at,-330,-125,-447,-520,-131,-17,-583,-362,-376,-223,-40,-44,-336,-191,40,-136,-686,-245,-41,110,-164,-137,-214,-106,31,-161,-201,-241,-286,-464,-569,-549,-336,-246,-171,-334,-207,-814
+U34605_at,267,192,212,187,230,129,95,116,126,99,209,90,168,182,193,190,253,128,103,643,156,71,123,175,195,106,137,40,79,185,195,174,232,85,53,103,180,209
+U34683_at,-66,104,-71,-252,139,-202,-189,-361,219,44,2,-33,74,-72,54,-212,149,-97,23,288,-176,-192,-246,-23,35,41,-217,-11,-4,-31,-234,-357,-64,-53,-84,-62,-108,-52
+U34844_at,140,64,84,77,122,161,97,142,-10,141,73,168,78,208,193,43,238,110,107,-24,19,99,273,-96,212,68,208,126,127,100,145,226,64,59,11,94,261,48
+U34877_at,271,-35,387,28,200,179,0,-110,102,252,133,79,328,317,157,253,-68,760,302,432,274,83,41,-2,191,145,42,142,211,368,323,390,401,147,118,193,236,683
+U34879_rna1_at,-102,-54,-185,-98,-79,-46,-57,-169,-74,-78,-138,-113,-73,-69,-46,-213,-89,-103,-93,-105,-82,-104,-79,-127,-65,-118,-103,-149,-228,-160,-20,-136,-115,-34,-63,-128,-120,-144
+U34880_at,309,502,565,325,463,519,910,596,1026,444,368,260,385,173,350,413,633,225,68,868,313,597,222,190,608,369,-37,726,423,719,621,702,161,14,331,706,784,701
+U34962_at,657,390,676,482,340,508,621,854,531,497,449,451,391,372,456,550,547,281,571,590,227,470,457,435,793,475,467,563,687,476,1293,1091,441,468,366,512,565,999
+U34976_at,180,78,144,54,6,126,134,16,76,28,-11,35,31,19,46,-2,17,14,-22,46,29,-2,112,73,-23,56,104,-16,7,101,64,22,58,30,22,66,44,13
+U35048_at,481,1445,629,200,1133,368,156,140,816,2316,1177,265,1104,548,608,324,686,34,806,489,525,162,334,408,1238,91,112,15,187,83,434,1382,4739,355,90,136,738,1138
+U35100_at,-1807,-1572,-1164,-1843,-896,-2016,-3073,-2557,-1129,-713,-1171,-1266,-535,-1279,-962,-1130,-1101,-453,-959,-832,-704,-1825,-1525,-1200,-745,-1145,-2074,-913,-1341,-1061,-1313,-1890,-1459,-789,-1151,-1825,-1354,-924
+U35113_at,-39,540,-37,344,752,-19,1,-337,421,409,724,-148,753,523,664,217,76,111,269,1577,73,-47,894,202,183,421,206,187,-406,2,3,90,-24,85,436,-96,217,84
+U35139_at,-249,-383,-481,-394,-249,-110,-374,-631,50,-181,-66,-221,-315,-310,-117,140,-696,-217,-256,327,179,-388,-131,-250,-100,-343,-366,-387,-391,-530,-338,-301,-417,18,-517,-224,-366,-752
+U35246_at,100,72,181,141,83,-53,164,-23,-55,51,49,96,131,103,84,175,250,74,56,85,48,79,55,190,23,-12,168,35,149,34,-2,164,-3,87,286,-112,120,51
+U35340_at,-161,-218,-356,-161,-130,-128,-211,-290,-204,-205,-111,-127,-196,-129,-116,-163,-518,-156,-235,-324,-172,-133,-165,9,-143,-119,-505,-273,-257,-152,-222,-104,-165,-87,-235,-214,-267,-358
+U35407_at,57,-15,9,-19,58,19,60,-59,-80,-38,11,-50,-20,-9,38,45,-35,-19,-1,39,24,-26,-28,-51,20,-35,75,15,-26,26,-9,42,11,-11,7,53,-16,6
+U35451_at,408,633,912,304,398,506,357,134,982,613,745,15,810,404,547,72,665,726,95,767,600,247,442,621,116,96,291,208,57,214,149,195,209,29,160,223,293,73
+U35459_at,155,141,231,257,145,67,204,320,143,73,139,125,119,175,130,158,51,100,59,139,92,129,131,176,88,148,156,121,310,162,219,153,119,85,154,116,40,199
+U35735_at,-79,45,28,66,43,65,43,46,26,28,35,0,35,-3,19,-7,191,28,38,55,38,-6,0,18,42,-2,117,-7,187,-5,68,10,-11,11,48,36,27,67
+U36221_at,635,452,617,553,490,451,460,730,174,679,258,275,813,502,509,818,33,421,453,780,178,357,613,432,646,535,979,827,709,874,678,656,546,330,438,66,599,1128
+U36448_at,-81,-129,-301,-112,-31,-129,-270,-395,-277,-241,-112,-57,-114,-248,-56,-227,-300,-171,-138,-303,-136,-228,-191,-213,-177,-196,-107,-246,-245,-168,-84,-275,-131,-86,-207,-312,-330,-105
+U36500_at,-48,45,88,-176,-51,-99,-194,-229,-50,-16,-136,-56,15,238,44,301,-146,529,-12,-17,54,0,-49,-67,18,-162,-148,-161,76,104,25,-1,-48,30,-262,-111,-89,-27
+U36501_at,212,58,442,36,142,74,18,127,155,100,84,11,74,191,93,147,220,95,6,320,57,36,169,22,95,147,140,-21,45,34,45,65,125,22,29,-77,236,113
+U36601_at,110,-60,-76,-56,29,-60,20,212,-48,-67,5,-56,-70,84,51,-23,-138,-53,-69,74,-37,2,-89,-22,-71,54,-394,-23,-50,-170,70,174,-73,27,150,107,-123,21
+U36621_cds2_at,-399,-40,-283,-124,-111,-199,-115,-434,-114,-74,-207,-143,-162,-169,-77,12,-332,43,-135,51,-199,-138,-220,-112,-116,-42,-46,-241,-353,-198,-183,-164,-276,-50,-250,-308,-268,-272
+U36764_at,1024,1985,1236,1187,2133,946,895,763,2011,1326,1441,1188,822,1138,1904,1191,1751,1058,447,3226,327,1021,733,1803,1260,1421,1206,959,750,873,1577,1593,1421,960,2698,1328,962,1238
+U36787_at,359,422,255,285,326,279,268,196,300,471,325,219,429,345,395,292,378,337,242,667,343,215,246,160,535,341,531,226,170,289,651,577,384,587,384,249,478,524
+U36798_at,556,207,517,426,151,206,618,560,453,130,264,208,233,286,270,180,430,212,226,366,258,317,345,187,258,241,508,154,444,229,370,63,125,145,249,239,184,430
+U36922_at,1036,8,2,130,201,56,10,632,-2,-50,-18,70,1185,-40,1033,962,176,266,716,3157,1190,795,-87,103,175,1103,236,-33,-110,21,2,91,114,37,105,32,103,154
+U37012_at,1901,1018,1594,1107,1421,1470,1500,2475,1041,527,938,853,899,1335,1481,1055,730,593,906,1351,728,874,1557,1259,1354,1037,1023,753,1512,485,1260,1429,1221,841,539,749,1072,1523
+U37022_rna1_at,541,378,514,538,871,430,391,536,1181,465,131,255,601,699,893,294,1215,320,335,1756,71,98,408,601,371,341,333,377,415,392,247,204,541,178,491,502,302,178
+U37122_at,3242,605,1244,2299,2085,848,1737,1764,1636,474,361,839,1153,1603,2022,1768,1474,548,513,1082,732,965,1424,1242,521,987,1042,1291,822,1335,607,425,689,428,1155,967,1802,1232
+U37139_at,362,239,378,363,298,417,336,394,381,231,267,163,309,388,361,300,627,388,268,555,459,130,216,276,362,277,434,299,307,160,241,260,343,234,216,222,364,181
+U37143_at,133,47,109,147,16,71,20,107,38,143,10,40,31,112,97,72,37,80,67,-9,-82,-6,-20,44,71,138,168,104,-7,-16,-10,67,87,70,-42,32,60,32
+U37219_at,1293,1277,1714,1110,926,1488,2261,1043,1339,963,746,1164,891,808,1062,1431,651,1060,1165,796,248,1450,1413,680,1019,60,1262,1323,1132,1461,1467,1667,1862,948,797,967,1868,2197
+U37221_at,-54,-87,-695,-617,-311,-487,-593,-1319,-410,49,-21,-475,21,39,-148,-198,18,46,-20,-318,97,-588,-545,-379,-103,-341,-98,-112,149,131,-90,-11,-50,-302,-242,-915,-570,-83
+U37248_at,1,436,102,-281,217,231,201,110,144,-15,6,-25,142,-357,203,321,-156,-228,89,1024,-33,64,-260,479,-101,275,475,302,113,40,-524,270,271,163,361,309,-198,262
+U37251_at,372,480,525,423,405,416,818,338,575,420,193,308,259,405,315,707,649,313,238,824,87,372,649,227,472,377,668,475,550,237,556,671,473,61,265,287,393,838
+U37283_at,41,-59,43,203,-22,-39,-60,-47,-80,-32,-65,-64,3,-92,15,7,-22,24,33,76,77,-65,-218,79,18,42,-21,-76,-38,-64,-88,34,0,-29,-66,-47,-40,-49
+U37352_at,311,121,280,459,348,94,650,268,344,97,150,1,654,466,1474,368,468,133,204,961,423,66,93,1084,94,156,139,131,62,74,79,197,104,54,110,111,263,239
+U37359_at,28,-27,142,84,204,78,87,-7,133,8,85,-25,171,166,255,80,286,148,71,215,204,40,47,175,55,82,-53,105,4,28,127,3,60,26,22,15,76,73
+U37408_at,476,837,1322,111,467,1058,813,97,2071,202,778,196,1401,1247,1622,1010,634,399,1301,1780,705,689,663,540,543,575,248,398,57,494,94,-164,603,518,182,674,828,272
+U37431_at,-71,-35,4,73,-22,7,-75,-47,175,49,-22,1,-60,69,7,-126,-210,23,-46,30,69,-57,87,-20,-59,-62,-173,-68,-26,32,128,32,75,93,-68,-37,84,84
+U37518_at,103,264,111,51,117,94,-15,73,-4,-33,-10,-25,37,90,81,23,-28,34,11,-52,66,-19,-34,11,13,37,-68,-52,-43,1126,904,68,-8,13,162,610,-7,409
+U37519_at,685,-6,344,612,371,236,310,631,590,236,314,208,191,352,256,303,87,66,246,334,136,329,324,251,217,532,456,575,548,388,279,465,254,187,88,444,323,702
+U37529_at,5,2,-4,-82,-57,0,-35,76,71,-47,3,17,-20,-7,-55,35,-71,-38,-13,-27,-53,-20,36,1,-9,-18,-1,-75,-62,68,-54,-18,3,3,-17,-17,4,-44
+U37547_at,228,143,179,124,457,0,191,37,282,96,378,-37,413,219,372,630,225,368,318,1071,207,45,148,90,24,146,-6,199,-4,331,398,453,30,215,13,47,249,110
+U37673_at,-364,-8,-69,-331,-582,37,72,-151,-777,-119,-499,-90,-10,-29,-247,-300,-97,-471,-63,-1057,-379,-347,-49,-181,-535,-784,-234,-104,-526,-418,-493,-47,-1014,-419,-162,-143,-149,-909
+U37689_at,888,737,1020,1060,747,997,767,818,1178,718,502,413,582,761,996,423,550,670,291,804,497,452,948,1207,569,369,625,583,827,513,358,379,894,189,-20,626,803,420
+U37690_at,1490,2250,1817,1646,2385,2140,1345,1506,2727,1600,1541,1770,1249,2190,2299,1680,2114,1365,1228,2456,3779,966,896,1871,1769,1523,981,2196,1514,1777,2715,2539,1564,2043,2712,2612,1854,1952
+U37707_at,612,510,1163,427,604,234,574,442,466,655,350,255,596,238,642,514,242,419,503,505,124,519,558,464,928,547,808,670,605,473,502,721,450,293,408,456,778,843
+U38175_at,85,351,143,23,299,90,-28,-164,622,329,59,45,298,458,366,299,354,311,91,403,73,-49,-3,196,112,286,208,218,375,103,211,-98,126,111,289,359,237,-15
+U38268_at,389,169,380,537,324,446,515,-205,453,208,305,344,241,370,334,321,161,191,263,238,236,455,275,98,608,313,-247,402,783,512,255,-229,251,402,392,542,375,451
+U38372_at,-9,-28,-59,-12,9,-62,21,32,6,-12,-65,-60,-46,-59,-27,-9,4,-138,-154,-42,-81,-79,-161,-126,-14,-13,45,-79,-74,5,-56,-183,-47,-47,36,31,-67,-96
+U38480_at,69,0,-15,-17,96,-16,92,101,2,241,17,-21,93,34,40,274,295,173,215,148,192,-53,-34,79,51,230,122,-30,290,-1,10,58,31,107,54,45,81,94
+U38545_at,145,75,116,312,261,87,215,178,213,74,2,103,103,212,80,180,126,11,136,191,217,177,96,321,134,196,65,279,238,241,137,194,196,177,207,193,198,237
+U38810_at,-46,-41,-90,10,-31,-76,6,-47,-44,-9,-49,-7,-23,-30,-14,-29,-88,-24,0,-66,-1,-48,51,-80,0,-35,-39,-41,21,-2,-54,-48,-66,17,35,10,-12,-94
+U38846_at,2170,1407,2049,2703,4006,1250,2145,1295,4201,1612,1850,788,2389,2680,3210,2673,3510,2382,2148,6664,1700,566,1246,2613,1271,1969,1370,1161,899,890,965,1145,1563,1029,1374,1236,998,579
+U38847_at,220,328,240,483,598,133,1058,754,241,212,183,196,288,677,614,347,1057,339,498,2249,872,210,148,1486,458,224,372,1132,324,172,67,381,294,59,301,177,620,138
+U38864_at,-1568,-760,-1906,-1526,-313,-1075,-1282,-3045,-1152,-204,-448,-993,-390,-528,-541,-415,-1903,-496,-450,-531,-283,-850,-938,-478,-585,-276,-597,-839,-836,-634,-1585,-429,-1440,-379,-248,-1526,-1729,-1618
+U38896_at,75,62,21,50,49,106,28,88,22,36,76,-66,75,3,108,43,66,-24,47,89,33,85,-39,121,7,-1,-101,-85,-69,41,-77,54,-43,-35,52,-39,-20,-61
+U38904_at,221,344,368,266,232,163,300,403,347,265,281,99,123,282,207,99,385,128,119,450,189,159,184,228,113,148,261,232,158,403,284,420,273,58,321,66,292,310
+U38980_at,2063,1638,2512,2396,1240,1582,2394,2494,2112,1690,1635,1096,1138,1557,1389,1781,1985,1301,1493,1823,569,1524,1858,1508,1655,1378,1772,1815,1437,2147,2320,2550,2143,935,1608,1975,2374,3140
+U39196_at,67,-65,65,49,50,14,-50,110,-8,59,79,8,10,42,22,113,-8,7,-10,75,-3,75,-1,5,14,33,-18,-35,-12,59,128,47,22,-23,12,52,97,112
+U39226_at,159,65,-54,42,76,44,-268,-305,-200,36,7,169,-1,71,-78,-33,-107,90,-62,70,-101,-128,18,43,13,-90,50,-151,-139,-56,-187,-196,-46,-13,26,-201,-91,-185
+U39231_at,-63,32,6,-7,-42,-7,15,-5,-20,-48,39,-76,-21,16,-62,-17,-24,-3,-28,-35,-7,-36,-81,-32,1,26,-104,17,36,23,20,124,9,-186,12,-6,-113,-43
+U39317_at,1253,632,995,820,1179,752,924,692,1445,775,1081,500,1253,666,1396,892,386,1135,1019,2359,2709,1107,554,421,691,637,204,463,396,1145,1222,1297,844,681,1364,1058,584,1175
+U39318_at,1123,2099,2252,1637,1604,1296,1713,1677,2318,1570,2212,883,1429,1454,1592,1605,1870,1033,871,2187,873,1935,1329,1337,1455,825,926,1435,815,1974,3403,2842,2097,1654,1952,1327,2284,3175
+U39400_at,899,408,955,779,620,739,554,745,745,623,831,352,387,819,564,372,401,131,377,995,590,261,568,742,170,337,389,480,514,52,786,213,585,271,394,514,551,694
+U39412_at,393,726,748,176,253,380,300,715,207,192,290,160,58,535,268,67,-6,155,277,667,2,360,324,458,367,124,-118,166,620,727,1741,1246,365,438,186,388,598,1323
+U39447_at,-118,-162,-74,-109,34,-117,-215,-148,-235,-131,-9,-58,-86,-112,-93,-98,-230,-11,-44,-51,46,-48,-39,-114,-120,-59,-126,-113,-173,-160,-65,26,-50,-33,-73,-85,-145,-82
+U39487_at,-309,-68,-330,-187,-121,-58,-297,-40,-125,-266,-76,-248,-70,-89,-77,-208,-238,-91,-150,-117,-7,-35,-151,-132,-16,-76,-353,-368,-216,-166,-289,-40,-33,-182,-140,-81,-224,-185
+U39573_at,147,534,47,166,182,558,45,128,103,-6,170,-70,218,89,253,106,59,121,279,363,99,193,-26,98,371,87,134,198,257,389,250,14,-19,117,1143,62,190,364
+U39576_at,-696,-619,-767,-862,-508,-449,-779,-898,-456,-451,-691,-227,-417,-570,-385,-767,-761,-174,-545,-713,-298,-447,-359,-506,-318,-470,-791,-710,-387,-813,-541,-643,-828,-362,-890,-1183,-957,-776
+U39657_at,-68,-81,-117,-67,-70,-126,-127,-149,-62,-65,-101,-68,-82,-114,-97,-66,-56,-46,-32,-102,-139,-14,-51,-215,-76,-89,0,-146,-156,-9,-96,-109,-112,-65,-68,-146,-56,-63
+U39817_at,-56,2,-375,181,97,-227,-15,-208,-194,-128,-101,-102,118,202,177,-133,240,23,4,19,77,-239,-423,107,-90,-113,-184,99,182,-497,-336,-244,-105,-142,-202,-197,-265,1
+U39840_at,57,108,101,13,75,128,55,139,99,91,42,70,48,68,81,36,205,74,-15,124,7,119,140,77,-12,60,162,56,24,-3,114,211,108,11,108,-52,142,255
+U39905_at,427,351,740,516,295,357,452,646,517,314,229,212,225,329,216,382,625,308,250,353,241,430,406,294,363,354,721,425,466,439,480,390,565,114,221,508,528,826
+U40038_at,108,116,271,109,235,94,5,55,160,57,138,25,51,163,94,0,212,-20,67,89,13,49,96,126,-6,8,-10,164,33,53,102,75,62,159,82,86,190,140
+U40215_at,79,-19,-12,-3,106,-40,105,166,79,88,-68,37,209,12,77,102,-180,214,38,22,64,-56,-121,45,26,137,75,150,21,-9,106,126,121,19,-6,35,83,158
+U40223_at,122,-756,-317,-261,-272,24,-63,-682,-585,-157,-482,114,-19,-309,-186,17,-723,-95,-337,-445,-36,-347,319,-303,-507,2,-837,330,315,-848,561,-995,-226,-38,-262,-58,84,-829
+U40282_at,951,417,598,874,919,273,651,725,889,316,400,359,669,796,772,758,1046,560,338,1023,172,281,550,728,416,641,624,809,440,781,670,497,685,355,762,946,806,700
+U40343_at,914,814,1649,1349,1022,174,774,385,1605,1093,960,538,953,686,1665,794,805,503,638,1303,590,3491,632,1373,552,709,616,517,286,2041,684,944,656,507,1179,435,790,679
+U40369_rna1_at,372,1188,428,170,354,224,132,185,478,417,479,502,366,330,217,302,488,152,338,434,377,184,182,269,1267,467,3,761,420,1236,2636,928,1624,696,1876,296,412,3809
+U40370_at,115,21,15,83,88,-8,-85,10,65,82,36,-40,73,137,102,250,115,-5,153,37,51,56,60,127,-8,80,-32,144,16,-31,25,-19,47,30,-15,45,109,7
+U40371_at,159,21,87,105,45,113,149,-5,106,-24,72,63,42,32,49,143,133,155,73,-9,61,62,41,-17,16,134,-61,28,55,128,57,95,62,-17,-50,24,163,90
+U40372_at,-884,-540,-1281,-981,-326,-826,-766,-1634,-753,-573,-501,-596,-608,-692,-543,-316,-1272,-470,-372,-523,-257,-635,-832,-482,-573,-453,-699,-631,-1012,-868,-1068,-718,-780,-155,-815,-1114,-1052,-1089
+U40380_at,-648,-743,-1195,-898,-306,-697,-396,-1449,-1293,-1084,-618,-648,-469,-368,-904,-417,-1137,-724,-415,-1462,-308,-698,-1151,-587,-870,-333,-787,-463,-586,-972,-678,-1076,-842,-662,-1280,-498,-512,-1499
+U40391_rna1_at,2030,1314,2389,2047,981,1527,2256,2577,1887,1384,529,1263,1268,559,1123,1034,1824,599,997,1375,657,1073,1445,676,1048,1149,2098,1839,1457,1155,2362,2585,1547,514,1272,1765,2109,3011
+U40434_at,-173,-163,20,-66,94,-186,-94,-214,-102,-22,1,-100,84,93,-125,-36,155,-1,38,201,-96,13,-53,17,1,-59,-128,2327,141,197,47,244,-46,26,63,-61,-165,220
+U40462_at,859,181,433,678,1086,293,413,407,766,64,506,114,315,627,1821,234,301,225,576,823,41,81,163,874,144,1131,200,138,55,130,166,148,128,126,80,163,503,304
+U40490_at,495,631,561,536,416,881,475,508,969,207,705,166,441,329,477,779,1868,560,815,621,216,666,231,261,531,192,364,228,257,657,816,268,310,129,389,380,434,1003
+U40572_at,154,-50,256,-70,51,243,82,220,58,-68,2,-87,128,329,176,77,-153,114,1,-36,122,69,3,-47,61,44,-111,20,-19,-23,-47,-6,-136,-59,-140,-141,22,-25
+U40622_at,10,29,67,121,76,49,48,43,-1,-10,32,15,42,92,24,49,71,-4,27,13,114,49,87,104,37,83,143,26,24,22,39,-60,16,-17,16,39,97,69
+U40714_at,400,234,274,367,443,266,378,293,481,159,533,166,302,468,356,322,121,244,220,142,167,214,212,541,243,28,200,447,355,535,514,681,598,145,353,474,274,774
+U40990_at,797,189,954,176,167,494,406,446,555,471,505,388,218,495,105,215,218,406,283,59,257,619,385,451,161,303,269,625,550,548,617,99,375,97,77,668,884,1136
+U40992_at,-93,36,-187,-12,-61,112,-210,-115,-174,48,150,76,91,-63,125,-97,94,-62,49,49,-14,-129,-140,64,82,5,61,-64,43,68,164,-60,-120,-61,71,-94,35,122
+U40998_at,783,712,652,1040,499,489,1850,1176,1151,558,615,715,319,772,628,492,278,662,549,405,490,1001,816,907,739,421,311,988,1151,1136,1466,884,514,376,1365,901,686,1050
+U41060_at,241,242,378,235,251,80,105,260,296,93,265,109,370,304,171,170,296,149,71,411,297,125,138,251,26,171,198,117,48,105,99,224,7,102,54,47,142,128
+U41344_at,-434,160,149,-67,-159,-74,-23,-149,-282,310,-268,-252,-6,-135,315,319,424,123,-274,83,-226,213,-53,203,180,255,-348,-115,-192,-171,-329,-66,508,-233,-66,-269,-280,808
+U41371_at,1149,807,1535,1039,935,1200,954,1161,1729,1344,1514,426,1454,1160,1522,958,984,944,917,1983,955,843,1005,1111,679,1116,583,1023,815,1457,1496,1261,1148,876,952,1284,1664,1172
+U41387_at,216,1003,455,365,1074,199,199,680,523,455,1593,143,880,963,685,318,599,141,204,1542,780,300,302,1139,208,165,103,1068,353,380,317,402,1021,110,978,338,519,1334
+U41515_at,165,286,151,338,827,336,36,155,442,411,531,222,564,536,793,603,990,707,304,1938,1641,125,132,617,406,502,164,81,254,262,143,132,399,419,355,274,177,170
+U41635_at,2044,2317,2255,1753,2590,1696,1792,2544,3485,1374,2048,873,1791,1909,1843,1748,4496,1164,1102,4493,1153,1879,1265,1898,1578,2276,1674,2948,2366,2634,1959,2473,3086,1683,4534,4266,3528,4183
+U41668_at,272,226,229,312,448,428,273,128,321,608,288,89,210,358,563,392,201,213,374,986,271,43,189,518,187,419,309,458,122,-9,196,126,51,333,97,62,282,150
+U41737_at,-34,-1,4,110,13,8,-82,-208,-50,18,33,12,6,56,-37,71,-98,-24,66,118,-32,19,74,-19,59,-132,-32,105,-209,-73,-29,-109,-42,-29,56,-5,-58,-132
+U41745_at,-77,99,31,33,116,48,-5,-26,146,65,95,1,41,71,44,-43,0,-43,-5,51,-129,30,-58,80,28,-84,-114,67,28,93,82,42,68,10,71,100,87,-19
+U41763_at,-793,-724,-794,-556,-385,-485,-774,-1421,-630,-508,-432,-416,-409,-617,-368,-539,-1321,-457,-462,-704,-177,-478,-666,-603,-465,-768,-1148,-613,-942,-616,-738,-598,-592,-386,-875,-636,-494,-645
+U41804_at,-71,-799,-1029,359,-418,-581,-900,-424,-3,-364,147,45,-401,-442,-500,-598,17,-192,-463,-280,-88,-498,-93,-392,-577,-8,-333,-18,-100,-221,-77,-805,-708,95,-313,-85,-182,27
+U41813_at,-55,20,-45,586,15,24,1001,-106,4,7,-12,-67,8,71,35,77,102,30,-20,31,17,-22,43,1421,5,28,4,437,-84,219,329,444,648,1563,1231,739,566,271
+U41815_at,45,194,119,17,253,23,63,139,128,65,574,117,260,38,173,130,515,171,155,314,279,107,77,31,126,90,97,94,36,9,72,297,491,7,95,121,122,510
+U41816_at,176,53,319,266,236,199,-55,241,143,37,247,126,245,138,112,274,271,207,191,399,252,171,150,233,187,160,87,231,28,142,78,63,324,67,1,145,250,234
+U41898_at,-339,-257,-504,-282,-226,-286,-331,-473,-348,-161,-200,-290,-363,-207,-211,-303,-426,-228,-134,-439,-92,-243,-298,-611,-289,-288,-502,-286,-264,-539,-426,-432,-350,-255,-273,-247,-412,-599
+U42031_at,332,99,382,434,1692,428,1868,-227,1111,432,237,143,269,891,482,450,1685,131,414,832,67,272,32,517,197,201,197,416,12,442,43,-40,952,254,308,70,180,530
+U42359_at,78,-35,87,44,-19,71,-20,14,73,7,55,-12,-7,-5,25,-47,38,-19,-40,-38,-11,-27,87,11,9,17,139,33,-26,-65,-49,8,-15,-15,-36,-5,-46,-9
+U42360_cds2_at,-303,-144,-201,-176,-206,-48,-146,-184,227,-86,-111,-183,-120,-221,-240,-186,-188,-116,-213,-192,-168,-227,-233,-306,-201,-261,-151,-225,-343,-261,-270,-306,-221,-142,-125,-253,-193,-324
+U42387_at,-174,-139,-271,-167,-46,-170,-168,-206,-111,-73,-100,-86,-12,-142,-15,-133,-240,-105,-51,-210,-11,-95,-85,-98,-124,-87,-217,-87,-122,-176,-165,-134,-88,-82,-135,-44,-202,-270
+U42390_at,-181,-199,-662,-515,-188,-373,-483,-406,-473,-340,-395,-270,-169,-421,-205,-283,-674,35,-133,328,-231,-274,-355,-14,-352,76,-388,-215,-45,-355,-359,-458,-294,-62,-436,-457,-379,-566
+U42408_at,71,-103,229,-295,42,-138,-819,335,159,-22,-77,-461,13,-87,-128,-36,-354,-147,-460,-721,-92,-330,-237,379,-391,-264,-594,236,-519,860,-1178,-249,104,-460,-48,-253,-292,-363
+U42412_at,997,863,1367,1039,1048,801,1166,1107,1228,751,758,491,484,968,918,717,915,432,312,1333,432,629,847,789,777,636,904,825,690,620,758,762,744,440,637,818,1041,942
+U43030_at,914,272,1464,510,400,627,890,598,654,724,380,196,400,510,338,563,762,264,327,548,252,617,505,565,531,512,868,858,548,691,375,603,808,247,608,786,648,897
+U43077_at,1174,1094,1271,855,1053,697,1021,718,1247,1004,1036,546,878,1171,1082,1279,1090,800,500,2469,580,625,577,966,812,1084,273,1166,750,1082,1783,1080,1622,484,2191,1171,1668,899
+U43083_at,333,234,895,230,372,528,289,424,504,159,363,173,69,312,215,159,544,49,107,161,111,128,370,359,192,188,161,585,375,419,463,319,364,270,422,408,531,662
+U43142_at,-491,-219,-502,-539,-256,-344,-458,-332,-269,-291,-308,-241,-396,-345,-283,-289,-285,-281,-215,-345,-356,-368,-389,-388,-352,-199,-502,-379,-488,-304,-258,-459,-431,-262,-220,-419,-517,-370
+U43148_at,1467,1181,1645,782,532,659,1601,1818,696,748,1120,616,683,1110,808,1168,1085,369,720,1098,168,626,763,1375,687,623,1500,1537,1231,1323,958,792,782,343,674,716,781,1160
+U43177_at,417,344,940,103,170,288,314,439,287,187,225,-12,278,308,52,27,381,258,97,476,-78,359,222,343,352,329,369,495,639,322,251,446,268,-110,205,130,320,753
+U43279_at,-7,107,77,116,-5,104,92,19,-22,66,67,81,30,46,91,45,28,28,76,108,-11,64,-30,1,41,-8,92,67,62,87,-57,32,1,63,67,105,76,152
+U43286_at,563,714,614,578,654,254,589,512,324,561,646,285,864,764,965,639,775,1332,356,1315,590,459,514,815,405,384,214,298,341,245,372,475,475,488,639,691,926,597
+U43292_at,205,109,213,131,102,220,136,145,92,187,146,165,112,171,93,162,36,118,120,150,67,171,127,97,109,129,136,320,300,74,112,184,226,110,246,241,199,277
+U43318_at,297,29,-15,232,69,204,179,44,-104,141,210,53,47,188,229,200,451,211,139,165,258,292,-275,-144,67,223,425,247,96,-65,-7,375,195,241,59,183,-20,261
+U43328_at,8,21,90,46,-9,46,25,64,24,-22,4,-7,8,19,-1,-4,94,-27,-16,-10,4,-27,1,-4,-23,-39,15,16,-21,17,28,-11,9,3,15,-11,79,-46
+U43374_at,113,116,352,231,132,160,166,170,256,152,95,160,91,347,101,59,369,180,94,180,87,163,108,106,113,12,381,237,221,27,167,48,144,-9,194,163,211,133
+U43408_at,38,-11,33,-108,-107,-85,115,-46,6,25,-19,50,-62,-128,77,3,-210,10,-28,49,-153,18,15,-311,-14,-29,-117,93,-146,3,-73,82,-33,-22,-180,-105,-101,36
+U43431_at,-408,-325,133,-400,-222,-346,-823,-493,-309,-173,-269,-192,-62,76,-174,-477,-1097,-168,149,-246,-192,-210,-376,-371,-244,-253,-992,-273,180,-321,255,-249,-316,-214,-105,-176,-736,368
+U43519_at,319,253,-188,223,147,352,189,-46,86,138,72,294,-132,346,99,80,-404,-128,189,-321,-61,83,239,277,88,175,211,489,781,-200,-89,184,-77,-142,-130,-187,-252,-361
+U43522_at,1842,744,304,2362,1583,563,1095,328,325,138,412,472,2105,1379,2600,1471,1185,488,1038,574,231,247,74,2084,651,1640,740,1568,514,1013,984,1078,1065,586,1061,256,1083,1158
+U43527_at,864,502,758,609,550,453,599,1122,706,309,470,336,437,492,535,668,963,179,292,706,525,496,587,697,528,725,555,850,829,624,635,741,674,310,499,550,495,1131
+U43586_at,-7,4,-232,-130,-70,51,114,743,469,15,-16,100,-1,-201,-105,-69,-300,-62,252,-165,94,-78,-91,-387,67,36,-95,252,79,2,632,156,189,3,-121,98,53,384
+U43672_at,-67,28,-72,-107,37,-44,-119,-164,-58,-57,-2,11,-24,111,-26,-63,-39,4,-39,-37,-9,18,-49,-1,69,12,122,-35,-31,-47,-98,-18,-75,0,18,-49,-69,-154
+U43753_cds2_at,219,248,406,286,256,151,347,344,263,202,255,195,281,252,176,356,528,288,220,379,133,219,281,244,316,242,388,342,134,279,320,479,268,118,263,196,337,412
+U43843_at,-65,-317,-87,-78,-42,-14,-132,110,-63,25,46,-5,-5,-190,-35,-8,-92,15,-30,-60,86,-143,-22,-134,168,-72,-79,83,228,-132,-699,-374,-30,-103,-50,-117,-73,-90
+U43885_at,341,65,62,290,108,1,129,317,96,56,49,57,142,6,134,223,168,28,346,122,46,85,-24,82,237,77,259,56,-12,61,53,64,2,-23,104,-27,56,84
+U43899_at,64,152,268,59,106,48,28,20,178,234,590,96,165,879,118,87,191,46,139,204,221,132,121,96,106,88,222,61,156,55,237,930,439,355,102,43,93,-19
+U43923_at,1109,792,1384,821,708,798,1063,1133,1222,1065,677,589,1152,777,910,1046,1910,700,752,1585,480,949,839,1064,964,948,1287,979,771,1109,1078,1286,949,640,1026,950,1106,1232
+U43959_at,-286,-291,-424,-427,-197,-296,-347,-328,-206,-298,-249,-261,-220,-194,-244,-363,-446,-127,-335,-326,-141,-332,-621,-219,-212,-203,-485,-115,-122,-366,-447,-287,-236,-93,-238,-316,-405,-479
+U43965_at,423,253,371,295,184,309,347,440,261,183,172,137,149,233,190,248,211,163,146,183,127,313,281,263,207,236,316,362,293,263,404,373,274,98,342,354,367,494
+U44059_at,1045,914,1184,744,711,389,1426,1187,840,1089,691,547,754,696,658,889,1190,775,497,824,238,933,824,701,670,787,1295,1257,1327,1147,1075,1281,816,486,1145,541,1217,1401
+U44060_at,-200,-47,-216,-90,-38,-64,-114,-116,-118,-50,-84,-51,-71,-51,-68,-93,-210,-16,-15,-136,-47,-57,-170,-79,-71,-75,-131,-150,-91,-202,-120,-163,-171,-66,-25,-176,-175,-200
+U44111_at,35,56,-6,-18,23,-42,1,73,57,53,-2,8,14,24,-38,23,76,59,-20,102,9,-10,58,53,14,42,40,68,12,129,26,81,47,35,220,34,39,54
+U44378_at,138,114,159,128,234,184,218,137,151,80,168,79,305,150,273,109,347,114,82,385,197,112,102,315,92,69,183,102,86,56,82,118,121,75,76,155,93,239
+U44429_at,-239,-60,-117,-147,-10,-103,-84,-287,-114,-89,-172,-66,-109,-99,-39,-75,-129,-109,-46,-67,-69,-124,-106,-112,-83,-139,-143,-153,-79,-91,-91,-103,-81,-62,-95,-117,-108,-212
+U44754_at,166,219,215,191,151,48,136,131,110,175,118,53,231,207,239,158,61,79,114,377,254,81,24,261,141,157,190,117,100,104,178,171,33,102,195,54,119,238
+U44755_at,513,555,732,631,253,846,709,869,870,507,465,362,238,329,376,408,554,441,235,342,232,460,577,467,294,234,1070,617,435,632,605,610,398,380,948,609,669,757
+U44772_at,198,719,452,173,370,218,302,223,872,449,448,176,436,608,352,265,642,224,319,772,261,172,191,284,283,267,250,360,502,1445,614,259,600,520,1112,442,712,631
+U44839_at,4819,4231,5749,5135,3116,4125,5237,6749,4630,4263,3880,1964,6131,4149,4403,3924,4228,2618,3944,6652,1847,3406,4213,4697,3728,3011,1283,4915,3768,3652,4753,4729,4777,2192,4925,4686,5434,6706
+U44848_at,271,233,257,269,89,243,315,404,280,137,473,60,294,152,167,87,63,206,112,481,149,354,216,324,174,152,488,222,127,132,258,313,261,87,168,147,167,412
+U44975_at,1641,5314,1040,608,2323,1426,388,1481,1694,2165,3339,2918,2705,163,1268,1129,1776,314,673,3644,812,1184,1149,1806,4681,1682,566,2826,937,2295,2263,1879,4432,697,3687,1356,5120,2262
+U45285_at,1545,125,1786,24,350,1038,220,-344,769,601,306,63,69,103,456,942,656,496,-69,-29,319,-337,902,314,-436,22,567,1365,88,1211,447,190,380,-206,1695,1015,169,1149
+U45880_at,262,56,208,63,59,113,43,322,88,-7,112,-93,15,-8,19,92,242,136,14,220,-157,187,1,125,38,98,1,145,40,88,83,136,-117,22,-5,99,124,169
+U45955_at,58,-4,45,248,198,-32,136,179,25,60,25,10,43,-4,637,116,115,72,40,86,66,10,-15,804,63,-25,122,21,7,-113,74,116,50,2,49,10,38,23
+U45973_at,902,1332,991,1121,1031,1077,598,1817,1601,932,1159,982,790,1325,1499,758,1019,755,434,1194,822,712,1033,528,1342,726,1370,1181,1269,1548,1729,1839,900,885,1471,1220,594,1230
+U45974_at,1252,1131,1227,1218,785,841,1119,1263,1011,787,886,527,574,695,834,592,1335,809,599,1765,647,816,856,679,1038,861,1608,1087,1120,908,889,1020,872,588,1025,863,845,770
+U45975_at,2199,1522,1989,1481,1516,1255,1416,3148,2248,1061,1241,936,989,1771,1313,1342,1277,1198,1246,2103,936,1973,1398,1224,1957,1467,1405,1524,1356,1594,1336,2183,1888,1074,937,1642,1724,2736
+U45976_at,277,175,152,235,350,174,67,166,199,39,153,37,121,89,282,45,723,-8,106,184,-9,264,37,199,133,-23,-67,178,187,458,501,626,311,253,474,164,181,1863
+U45982_at,1149,823,1336,968,544,928,1132,1362,921,795,703,619,633,1094,697,774,1463,815,591,694,510,813,830,766,984,760,1253,963,981,831,980,997,1075,460,767,841,1275,1493
+U45983_at,-79,12,-26,-56,-21,5,-40,-179,0,22,7,-25,-44,-9,14,-72,-31,-23,-82,-69,-2,13,-64,-73,62,7,-81,-134,-14,-59,-42,-95,31,26,-45,-71,5,-32
+U46023_at,517,180,207,277,166,220,332,532,271,300,230,232,229,206,221,228,405,307,189,268,208,181,395,269,365,341,336,354,346,262,295,312,286,165,170,252,371,552
+U46024_at,219,90,-112,30,140,53,102,-23,-9,-30,-18,54,85,20,130,105,234,14,12,139,99,45,24,82,-25,12,-31,32,57,71,121,-20,6,37,34,-5,32,55
+U46025_at,2696,2193,2312,3155,2594,1031,3844,1319,4218,3340,3146,2069,2083,2763,4825,3039,4169,1016,3674,4848,1587,1001,1949,3229,2602,2329,1462,2036,1565,2492,2850,1044,2586,1575,3900,1364,2311,1756
+U46116_at,28,-58,-30,10,12,33,57,128,18,7,-7,12,15,-24,39,-4,32,59,9,-23,-11,-31,-34,22,72,10,61,-36,45,-22,-24,10,24,-23,-6,13,-31,14
+U46194_at,172,104,427,357,124,318,161,233,292,405,122,117,60,103,155,216,470,260,74,131,172,243,226,298,168,328,184,351,197,246,473,315,188,285,101,355,358,622
+U46461_at,332,420,423,82,248,247,23,394,-80,411,331,194,194,174,369,529,257,530,158,562,-17,-163,-53,205,230,367,436,245,-16,-97,104,328,318,138,507,211,323,389
+U46499_at,44,146,110,86,104,10,105,104,103,64,93,33,61,986,46,30,3107,85,2,78,41,-37,53,64,83,70,114,2139,1185,2046,753,577,208,1049,1304,2087,167,1689
+U46569_at,524,512,1284,880,342,615,1092,1196,503,-37,507,221,186,387,309,468,347,239,74,342,322,347,721,493,503,259,1071,133,819,255,639,466,340,590,410,788,681,245
+U46570_at,2638,1886,3592,2997,2539,1803,2572,2844,3099,1826,1560,1093,2127,2391,2073,2425,3088,1810,2495,3993,1043,1535,1742,2583,1801,2116,3227,1923,1894,2472,2094,1445,2051,1021,2457,1540,2866,2277
+U46571_at,472,340,623,449,680,224,236,259,764,321,386,179,533,375,544,384,484,258,424,952,66,304,336,486,338,357,211,414,216,564,564,621,473,322,724,258,454,342
+U46689_at,-234,42,-410,53,10,42,58,-211,-73,-444,-127,25,94,-138,81,-108,-96,-154,40,-588,-89,-109,-119,183,-46,-166,-328,-271,-286,-168,-118,-465,243,11,-93,-164,-313,-209
+U46692_rna1_at,662,2998,2533,1049,1637,1867,710,548,2877,654,1481,308,1823,3074,1173,997,1510,1265,751,428,358,130,733,451,498,829,679,599,235,2759,1023,585,948,575,4308,1773,2442,599
+U46751_at,1298,1379,1496,1401,1894,528,1747,1514,803,1939,587,1347,1489,1784,2286,944,1888,2111,1983,2731,1962,1739,585,1571,1395,1437,990,4719,1106,5868,6903,7061,7113,3717,11618,1262,3088,5749
+U46752_at,-96,-82,-108,-14,33,-21,-6,-53,-66,-41,-41,20,-105,-1,-42,-5,-82,40,-84,-81,79,-88,-15,-56,16,-34,14,-85,-69,-29,-42,58,16,6,50,39,-46,-6
+U46767_at,91,70,88,118,126,55,-6,134,12,64,14,-5,40,51,25,26,-57,41,69,29,14,91,15,113,66,31,-4,-55,60,80,73,122,38,51,99,5,9,32
+U46901_at,120,291,-33,406,208,266,215,485,333,221,239,130,48,163,186,245,341,72,235,334,-39,179,226,582,241,14,12,340,415,135,660,558,325,189,493,372,367,772
+U47007_at,32,-10,-31,-5,34,-16,16,55,-24,35,-22,15,3,42,11,32,74,17,-3,-6,-9,-7,-56,-32,13,-1,125,15,-69,77,8,62,-3,9,20,-66,-1,19
+U47011_cds1_at,-329,-306,-135,-334,-157,-168,1,-89,-1,-182,-168,-132,-227,-61,-93,-133,-142,-205,-124,-748,37,-107,-15,-266,-74,-197,-176,-275,-226,-49,-264,-251,-133,-174,-377,-175,-528,-256
+U47050_at,-85,18,-156,-4,76,131,-42,-67,110,66,216,-43,-30,90,-11,79,86,95,-232,-9,31,28,-1,6,36,78,86,342,353,-10,-106,-57,-80,50,4,-70,266,-60
+U47054_at,38,-2,120,149,-8,138,62,103,108,172,127,40,-3,76,-80,57,329,131,-31,55,126,32,151,94,46,147,359,118,103,33,-108,172,20,-75,195,107,56,58
+U47101_at,582,1447,611,490,1014,280,253,574,642,370,653,241,762,559,1073,456,1239,456,524,1907,799,451,343,797,451,317,67,566,305,-49,607,949,583,827,615,257,1137,361
+U47105_at,390,66,516,103,248,211,188,305,575,298,324,250,524,312,235,388,503,174,173,396,131,141,239,385,105,237,494,256,60,269,252,523,418,372,85,209,280,562
+U47334_at,398,288,500,294,215,170,499,505,313,294,293,185,179,232,153,351,1025,174,195,261,217,196,360,305,352,159,589,408,163,339,311,336,374,238,321,408,444,543
+U47414_at,419,482,167,374,394,104,156,268,265,277,294,25,773,314,453,598,460,264,145,603,797,172,184,473,223,228,164,-34,-14,372,160,403,293,201,361,115,279,58
+U47621_at,15,447,-322,126,188,-192,-194,-392,359,106,33,-41,6,299,270,250,269,359,660,453,204,107,-360,142,648,352,-475,229,86,38,343,135,407,578,261,37,-208,-136
+U47634_at,842,654,306,1101,374,602,907,1346,812,590,337,290,408,482,529,779,1082,523,521,623,769,512,809,557,722,508,783,299,779,971,1041,847,647,412,817,672,719,1494
+U47635_at,347,594,411,302,232,224,223,317,346,239,579,214,74,236,311,51,541,134,207,324,424,649,125,414,85,159,381,329,165,409,424,344,418,466,309,315,262,357
+U47742_at,1737,1382,1090,1051,995,928,880,1947,1440,400,1641,452,1209,988,1461,853,1599,263,635,1489,1781,1012,773,1246,620,873,607,483,492,685,765,789,967,376,707,444,1504,2178
+U47926_at,-457,-485,-604,-397,-274,-307,-322,-1058,-395,-144,-559,-294,-408,-370,-305,-73,-905,-115,-384,-431,-198,-447,-275,-407,-438,-311,-650,-520,-516,-497,-561,-639,-357,-297,-346,-285,-446,-636
+U47927_at,423,348,832,179,518,263,433,341,1211,478,894,122,567,476,569,732,812,426,414,1309,-4,94,400,355,234,722,-68,268,240,569,205,102,193,134,466,538,394,43
+U47928_at,-112,-188,-358,-144,-140,-208,-184,-227,-217,-117,-355,-143,-158,-144,-148,-110,-150,-92,-28,-132,-97,-116,-104,-125,-174,-89,-247,-241,-108,-41,-274,-241,-225,-103,-228,-243,-218,-267
+U47931_at,1170,321,2058,900,363,1130,609,2248,1694,692,1106,1057,653,766,495,897,640,555,342,863,376,1262,1415,1098,1191,592,1114,1398,1356,675,1556,1606,1589,483,488,1746,1935,2453
+U48213_at,-1520,-649,-1364,-938,-197,-986,-1117,-1500,-911,-200,-495,-429,-438,-479,-70,-270,-1075,-73,-308,-387,-273,-874,-701,-416,-552,-392,-1722,-512,-584,-648,-1225,-460,-1176,59,-721,-1041,-1410,-1755
+U48231_at,289,175,205,250,160,71,82,25,-3,-15,164,12,-2,2,35,300,28,59,240,-13,49,129,134,73,164,83,-37,62,-16,324,143,257,214,-5,18,209,367,286
+U48250_at,-11,-26,-164,-120,-46,-126,-114,-130,-45,-86,14,-5,-8,46,-72,-97,-131,4,-3,-64,-126,-112,-58,-42,-78,-112,-237,-211,0,-44,-4,-71,29,10,-115,-20,-24,58
+U48251_at,676,403,216,1182,543,202,1271,764,134,210,55,113,1031,293,1039,2463,633,504,1078,1489,2268,775,260,1793,218,815,907,378,468,176,342,301,411,210,108,108,684,79
+U48263_at,478,311,577,609,317,508,739,824,545,443,412,540,261,395,510,472,383,638,410,487,329,209,417,296,419,312,652,515,454,619,592,514,538,262,398,584,664,781
+U48296_at,510,1225,693,176,728,200,218,440,744,829,495,232,1106,332,676,418,672,385,256,1569,1166,715,398,644,675,705,345,708,538,1177,824,1422,858,440,767,504,559,658
+U48405_at,446,489,577,491,443,309,764,1067,570,493,479,316,274,766,443,470,289,307,729,612,63,379,455,457,671,274,258,752,839,1033,639,679,1030,277,782,372,666,864
+U48408_at,1303,1378,1330,849,990,449,759,622,1038,950,707,143,1090,1064,520,780,1558,625,692,1478,299,1077,834,774,674,713,1084,955,1019,1302,385,1009,1038,226,1856,584,613,731
+U48437_at,803,614,926,834,289,449,804,964,617,450,429,182,102,534,184,474,797,302,611,72,112,398,708,457,360,330,776,704,805,221,717,360,607,46,63,617,792,1013
+U48697_at,-377,-395,-482,-372,-218,-375,-263,-535,-370,-291,-287,-191,-149,-213,-305,-245,-57,-136,-169,-146,-181,-239,-370,-272,-150,-212,-400,-398,-197,-67,-173,-249,-281,-59,-686,-468,-339,-371
+U48707_at,-152,-286,5,-88,-80,80,-80,-109,-215,-67,-149,-51,-56,-146,-49,-50,-130,-89,-69,-79,57,-163,-55,-125,-131,-94,29,-146,-88,-35,1,-6,-144,-65,-248,78,-233,-35
+U48736_at,180,154,181,199,434,174,115,149,109,73,174,5,266,264,414,234,364,67,94,232,152,111,167,227,71,20,-142,32,-4,112,53,548,168,209,62,103,218,242
+U48807_at,149,92,47,43,80,-42,85,209,158,141,168,12,2,26,-28,48,267,598,62,-4,113,332,26,91,54,-23,511,69,45,67,72,49,203,-51,146,184,73,25
+U48861_at,-538,-811,-452,-173,-271,-392,-245,-526,-490,-277,-667,-215,-605,-784,-773,-594,622,-674,-365,-1025,-358,-655,-72,-339,-700,-671,-1516,-643,-300,-166,-797,-926,-386,-217,-1327,-659,-673,-618
+U48936_at,996,1491,2251,1677,573,1422,1670,1488,889,1398,1111,1155,952,1252,549,1337,2184,830,738,1136,787,643,549,1500,738,1122,1749,1883,1043,1681,1867,1255,1870,796,862,1725,1992,2549
+U48959_at,40,-272,-387,-385,-126,-96,-215,-103,-194,-144,-134,-130,-112,-220,-185,-222,-553,-229,-23,-42,919,-172,-224,-144,-165,118,389,-198,-141,-107,-202,-203,-233,-107,-286,-200,-274,-173
+U49065_at,96,58,166,33,50,138,159,131,31,18,63,-60,37,60,32,64,76,33,69,-2,-8,26,-3,142,87,94,28,27,52,-23,25,194,104,15,115,75,115,77
+U49070_at,697,1037,1229,776,1044,659,606,910,1102,1138,813,464,925,801,1331,879,1215,362,393,1704,79,476,1037,817,701,446,726,484,151,569,914,1006,641,650,396,663,794,872
+U49082_at,1002,664,701,787,424,684,799,721,695,752,414,484,461,452,446,491,635,428,865,817,264,542,860,638,724,726,535,898,589,664,731,1018,534,348,629,470,621,868
+U49089_at,550,620,504,528,298,398,359,874,417,332,403,304,329,642,514,511,608,257,305,525,371,393,516,355,441,146,441,454,553,560,783,417,429,290,343,372,508,519
+U49114_at,-206,-115,-125,-211,-115,-183,-188,-136,-140,-149,-127,-106,-131,-152,-182,-229,-192,-122,-107,-166,-12,-103,-64,16,-131,-146,-126,-270,-151,-213,-167,-145,-206,-103,-194,-94,-216,-184
+U49187_at,211,-18,-226,-364,-48,-55,-653,-550,-84,-196,-55,-217,17,165,8,-47,-240,-97,-40,158,-248,-173,-174,-207,30,267,-494,107,-396,-233,-419,45,-362,-29,-31,-111,-226,-510
+U49188_at,296,395,482,500,527,138,324,223,397,-21,320,14,352,425,856,312,1117,86,268,1380,248,145,172,873,99,282,-62,368,88,131,203,420,329,249,-82,193,660,-30
+U49248_at,173,99,65,79,172,248,156,235,-52,62,94,142,82,61,149,215,191,52,7,110,69,223,298,60,19,136,273,24,52,59,142,79,-42,14,57,53,16,-8
+U49250_at,415,8,334,257,156,154,295,92,412,227,239,130,210,254,107,291,529,271,206,338,79,228,290,15,274,323,272,494,454,344,236,310,326,137,435,368,326,602
+U49260_at,-190,126,28,-257,177,-316,-60,38,230,369,165,-586,-4,52,-63,-83,-172,231,57,435,-32,5,-231,149,-118,21,-222,28,55,-68,-777,243,53,189,163,-100,-272,166
+U49278_at,507,127,-149,225,552,266,184,529,-97,-291,238,-189,133,269,361,216,-180,93,294,895,104,-196,-112,449,497,20,538,760,399,765,343,953,473,344,1716,534,-342,340
+U49352_at,375,4,777,372,493,151,142,241,511,155,295,63,327,461,326,410,224,347,193,638,422,120,368,460,255,270,283,236,180,227,355,336,115,185,144,344,306,166
+U49379_at,-5,28,-45,-14,12,1,-47,14,-47,-1,-39,-45,-16,-16,-27,8,-49,36,-10,0,51,14,-32,-4,-44,-21,6,-9,-79,68,7,6,-5,61,5,-83,27,5
+U49395_at,752,1456,2239,2794,1542,1474,2362,1503,2336,818,1466,310,469,2326,1573,722,1044,1197,601,1118,624,507,1462,1859,487,550,1020,638,990,633,497,813,813,338,807,634,971,902
+U49436_at,305,392,461,277,393,225,73,284,495,305,384,136,401,182,415,250,352,64,128,337,189,262,174,274,237,42,103,243,127,316,555,375,434,174,499,248,622,1177
+U49742_at,262,408,127,120,-199,-241,416,101,-275,150,169,67,-276,190,52,124,-336,74,213,401,-67,86,-85,-73,-5,-28,-151,41,161,73,272,-305,77,-139,124,-98,101,141
+U49785_at,1258,701,1783,1111,1087,739,1011,610,965,1062,774,596,835,982,1135,1309,1184,1122,964,2092,1276,804,568,1304,954,1237,353,1263,1154,1151,981,983,1165,567,1198,1058,848,637
+U49837_at,816,115,735,601,385,545,670,1455,694,396,473,270,367,665,473,529,92,228,235,204,347,644,410,559,537,361,278,451,456,663,589,588,673,11,154,395,700,1179
+U49844_at,92,210,299,232,463,136,268,250,205,134,29,40,287,442,411,294,254,117,223,612,272,91,195,462,51,56,106,115,165,97,78,40,13,14,107,68,77,18
+U49857_at,245,219,667,362,144,165,181,221,84,186,144,58,182,309,177,218,205,298,179,392,273,150,241,205,163,393,536,215,214,164,206,201,298,2,281,14,281,212
+U49869_rna1_at,12454,19697,20420,13477,14846,18192,14223,19366,19824,21759,18174,10556,20407,16533,18153,13573,11833,9209,18879,22291,22336,13895,19249,15811,15227,10184,12494,9242,7021,12549,16524,22819,14906,15609,17035,15591,14683,15917
+U49928_at,20,-135,132,-85,42,-154,-95,-179,86,-79,-44,-146,3,33,-1,76,-184,-86,-40,28,-197,62,-91,-103,-14,-17,-327,-74,-52,5,-469,-6,-42,-29,-21,-312,-182,-31
+U49973_xpt1_at,1137,1122,1249,1091,907,1081,846,1098,724,954,854,589,999,1260,1333,1228,1476,1142,527,1652,474,874,968,1119,779,1254,1264,1171,730,791,1084,1389,1079,408,1113,906,1267,1129
+U49973_xpt2_at,9,97,57,-12,52,-76,-18,-112,0,-50,66,-81,-68,-12,57,-28,-82,-13,-64,66,3,1,5,25,-37,130,-220,-11,158,-55,-44,-21,-52,19,-25,-32,-35,-126
+U50062_at,369,251,327,334,161,192,389,287,382,195,138,178,162,209,221,301,527,238,179,259,323,151,378,338,326,292,327,357,252,359,549,496,298,289,267,368,392,497
+U50078_at,221,495,7,205,324,74,211,293,236,241,346,107,293,502,552,348,627,220,223,828,469,181,77,709,93,195,68,143,86,58,311,677,126,237,832,109,175,110
+U50136_rna1_at,1124,1062,1398,942,928,842,1066,1668,966,1175,626,747,706,864,515,825,1837,883,1309,817,383,825,731,899,1171,805,1286,2402,2137,3965,2539,2286,1641,2545,3818,2943,2535,1373
+U50146_at,-194,-287,-424,-234,-163,-229,-289,-436,-429,-259,-276,-175,-100,-163,-359,21,-182,-21,-234,-131,-222,-119,-294,-359,-123,7,-248,-275,-317,-601,-438,-10,-432,-49,-233,-397,-208,-590
+U50315_at,238,700,339,136,395,252,290,103,180,183,460,195,334,849,260,245,940,744,305,568,323,694,167,766,673,457,115,947,252,719,682,1154,358,917,807,-3,597,1119
+U50330_at,-280,7,-481,-381,-37,-339,-361,-710,-244,-129,-171,-224,-156,-220,-114,-80,-296,-134,-65,-106,112,-260,-94,-120,-267,-195,-381,-28,-144,-146,-480,-279,-124,-227,15,-406,-280,-422
+U50383_at,-275,-111,-92,-369,-141,-209,-174,-452,11,14,39,-156,-38,-97,-283,3,-140,-176,109,185,3,-240,-123,10,-213,-177,-323,118,-235,73,-67,-374,-43,37,-272,24,-106,-459
+U50523_at,2567,3975,3093,2902,3550,1877,1594,1233,3613,992,2409,1927,1466,3438,3512,2469,4043,3656,1099,2988,517,1350,1761,2033,1211,2556,481,3656,2265,3800,3068,2468,2161,1963,5052,3675,3724,1769
+U50531_at,188,163,203,44,176,163,90,307,94,20,118,57,129,166,50,205,377,102,91,140,96,78,96,257,118,63,82,47,189,126,91,59,43,111,131,47,238,78
+U50534_at,65,14,45,44,7,-39,-112,116,51,28,-10,-8,4,154,2,119,410,-15,22,-13,-37,-7,-58,27,-13,15,43,40,2,3,24,-29,52,93,-7,2,35,14
+U50535_at,1065,978,1316,1115,726,698,641,1250,540,642,592,462,645,954,810,928,1815,518,581,1130,462,592,638,1219,1000,851,372,921,822,777,759,1051,750,351,896,529,921,1051
+U50553_at,282,455,346,198,594,145,346,496,426,171,659,275,613,180,268,210,542,115,230,561,111,260,227,377,414,55,197,522,266,350,496,168,977,117,654,324,600,1077
+U50708_at,-27,-10,-59,-17,-7,-92,-60,-28,12,-60,-44,-22,-50,-27,-20,0,-63,7,-46,65,-8,-78,-28,-61,-18,-78,-81,-115,0,-87,-79,-81,-23,-55,-27,-53,-27,-86
+U50733_at,994,788,838,639,886,421,495,415,1988,644,1754,311,724,829,727,835,1020,955,459,1421,702,290,484,940,657,853,434,464,367,253,534,534,511,528,539,482,610,438
+U50743_at,-27,614,9987,124,53,5371,263,407,11770,11254,2986,91,115,171,-204,691,-71,593,12,255,367,303,1424,-95,44,47,-23,360,223,178,669,679,51,420,-54,213,121,269
+U50839_at,420,283,467,276,416,257,270,367,321,163,341,83,189,351,409,34,503,230,142,319,57,141,243,463,145,128,112,252,259,117,-21,229,175,147,237,124,298,92
+U50928_at,346,23,215,309,344,83,141,322,125,77,113,12,633,136,461,1152,607,16,475,938,882,147,235,535,105,123,303,85,137,70,5,64,106,70,92,116,87,59
+U50929_at,-139,-41,-184,93,-126,23,-137,-136,6,-35,-50,-24,-8,66,0,-68,56,7,73,-44,-59,-30,-89,-51,-3,-144,-10,117,-14,-43,4,-87,5,-23,135,-141,30,16
+U50939_at,405,490,690,335,574,378,362,248,857,386,775,149,518,631,475,628,573,273,540,1254,1642,264,533,650,178,369,305,240,199,118,297,338,311,267,190,375,337,199
+U50950_at,161,162,379,154,118,147,100,220,214,117,98,68,270,276,182,155,306,123,83,295,151,86,119,144,78,75,147,69,134,74,115,55,96,91,93,142,168,128
+U51004_at,2534,2294,5637,2534,3891,2597,2318,994,5932,3483,4243,3878,2621,5620,3409,2646,2921,3132,2654,5841,3138,2286,2105,2711,2925,1708,1281,6827,3337,2782,4642,5072,8524,5811,5146,5937,2541,4468
+U51095_at,-6,-44,77,124,57,108,104,4,3,61,44,45,19,38,1,43,-19,46,0,25,-64,60,30,25,188,82,90,82,9,28,59,52,89,53,-9,39,61,32
+U51096_at,106,270,409,47,98,129,68,140,64,248,153,77,122,168,16,141,219,184,103,113,14,146,66,130,123,91,212,83,122,125,229,144,157,91,187,150,135,220
+U51127_at,1306,1344,1953,1197,843,1488,1211,830,691,1345,1062,413,1561,1715,1155,1723,1568,1273,1408,2231,984,1658,1318,1192,1164,1278,2824,1536,1072,2171,2382,1621,1545,654,2639,1369,2685,2656
+U51166_at,111,238,110,141,437,122,80,43,257,131,267,-17,230,353,365,284,276,161,74,1109,353,88,79,202,88,148,128,17,2,10,79,133,73,145,77,26,102,87
+U51205_at,211,143,173,111,196,101,47,-56,111,33,242,0,62,212,191,179,-10,72,-23,202,2,95,123,169,62,55,84,-27,84,-41,155,195,236,119,109,70,142,101
+U51240_at,9059,4614,1236,7070,9553,917,4402,2033,4988,1083,753,5026,11150,2357,10737,4330,8865,7274,5811,6605,11,6563,467,7477,8681,13536,2207,1813,2469,4664,6595,2502,5032,3531,6945,3011,6517,4738
+U51241_at,327,280,262,265,96,97,347,302,114,213,85,103,130,219,103,283,250,115,174,105,241,71,98,313,126,151,272,305,346,122,207,233,240,169,209,205,308,414
+U51269_at,497,472,594,412,427,156,662,839,305,346,374,376,693,374,476,678,376,429,662,1109,725,400,264,607,449,600,-292,733,408,-117,25,823,509,347,230,257,689,630
+U51334_at,805,757,1150,951,917,825,873,1634,1121,849,726,402,1245,2110,895,931,2590,838,853,1696,684,664,839,883,932,1140,1085,1903,1156,2177,784,1065,1165,519,996,1132,1119,1190
+U51336_at,1698,932,1455,1466,936,848,1414,1094,1692,904,765,830,1143,1450,1302,804,1320,1035,784,1407,563,453,590,1208,840,850,582,1048,997,2012,1526,1893,1411,1017,1851,1427,1482,2128
+U51432_at,163,243,-47,361,765,225,146,-77,273,107,587,5,685,346,735,246,389,133,206,1211,1571,219,7,481,213,112,256,64,-4,196,350,443,51,508,333,423,-55,378
+U51477_at,627,805,1015,478,940,705,569,730,784,623,345,411,821,828,865,996,1856,376,620,1125,382,374,547,534,595,1227,613,1696,706,787,487,281,536,490,1369,784,1266,569
+U51478_at,3756,2271,1862,2534,3849,1365,2160,3314,4336,1937,1488,1330,3002,2186,4275,2937,4458,1489,1950,7801,1472,3146,1379,3906,1775,2988,1594,2292,2214,2859,1843,1793,5099,1710,2442,2101,2801,3924
+U51561_at,52,98,123,-3,42,28,23,49,137,74,-35,-11,76,68,71,79,123,8,65,83,-98,-22,70,38,9,22,3,75,-4,13,21,113,-11,53,45,-28,112,173
+U51586_at,394,732,441,493,755,-3,-263,-445,538,379,410,-139,1213,443,372,330,933,450,230,2278,-177,115,-89,-25,332,739,453,-205,-329,499,84,133,375,346,216,200,168,601
+U51587_at,108,63,270,14,125,-3,179,680,228,148,3,196,188,-46,145,219,444,157,167,334,176,43,20,246,31,224,32,118,115,240,275,-34,-156,1,19,78,409,70
+U51678_at,974,896,1376,981,1754,572,729,515,864,852,821,298,996,715,1765,995,1742,346,647,2193,605,379,668,1126,575,725,434,544,269,436,550,515,594,853,650,315,631,458
+U51711_at,31,-16,-33,42,31,-7,53,-92,-32,-10,-52,-30,-48,-23,24,-88,-142,-66,-68,-79,9,-47,11,-10,-48,-53,-176,-105,24,-19,-64,14,3,-18,5,-62,-58,115
+U51903_at,350,484,793,1258,1352,368,1554,814,913,101,331,574,880,1065,698,887,3772,277,754,2206,434,345,321,1488,368,327,403,523,569,754,412,281,482,239,305,669,1104,519
+U51920_at,351,170,329,285,400,140,181,217,263,233,184,112,457,252,231,285,499,332,168,459,282,78,129,240,157,129,201,160,161,93,118,195,128,199,97,81,149,232
+U51990_at,325,399,421,296,406,256,194,281,397,248,364,155,537,273,366,348,413,109,217,735,446,245,328,388,258,160,200,126,194,221,261,384,212,190,219,153,235,245
+U52100_at,140,-30,43,134,135,122,97,101,70,59,54,17,82,55,11,113,122,93,94,25,56,248,66,-7,88,65,112,-27,52,-67,89,59,125,105,21,73,70,311
+U52101_at,5752,3930,5249,2783,3720,1651,1702,3487,9480,4630,6953,3423,4282,4254,1395,2240,4060,864,258,1371,208,2854,539,2724,781,4415,1067,3533,1454,8386,7683,3527,2860,2598,9936,4935,4651,8878
+U52111_rna3_at,-271,219,-384,109,-21,-357,-356,-563,-175,86,-55,71,-47,-85,42,38,51,-10,300,328,-141,-251,-569,-206,-55,-53,211,-645,144,-168,252,-276,-73,125,233,-39,-41,-65
+U52111_rna4_at,-1553,-1322,-1718,-1867,-987,-1113,-1777,-1475,-1531,-1006,-1174,-1260,-945,-1317,-1251,-1036,-1423,-776,-940,-929,-630,-1314,-1495,-1202,-1076,-906,-1843,-1351,-1454,-1535,-2100,-1769,-1373,-271,-1526,-1081,-1620,-2098
+U52112_rna1_at,1601,843,1617,1868,741,1018,1424,1679,1069,1020,878,735,929,789,956,1471,1321,957,812,1257,584,990,1527,945,1491,1235,2071,1588,1139,1067,1552,760,1333,715,1070,1740,1994,2195
+U52112_rna5_at,1311,1144,1437,1168,725,1034,1434,1536,1269,870,871,830,936,1130,747,1098,1423,594,920,1092,392,884,1158,895,944,593,1222,1339,1096,1316,1062,1018,1309,486,1196,1372,2008,1721
+U52152_at,-297,-329,-419,-452,-202,-640,-460,-344,-343,-137,-261,-350,-183,-426,-200,-60,-113,-264,-119,-155,-71,-257,-355,-265,-168,-127,-328,-326,-459,-281,-468,-213,-263,-117,-426,-540,-313,-81
+U52153_at,-45,-10,-114,54,-12,8,5,25,-58,22,6,-47,3,35,-11,0,-90,-54,31,0,32,37,49,-47,29,36,31,32,9,-31,17,43,15,63,58,-11,-76,-17
+U52154_at,104,141,212,193,-43,60,94,307,64,61,134,-61,73,158,52,141,30,127,136,2,104,272,227,107,72,98,137,170,139,164,155,157,167,86,68,139,258,303
+U52155_at,33,19,71,-2,-14,-7,55,-32,21,10,14,18,-32,34,32,24,59,9,42,-46,52,68,-134,71,19,-1,-12,-35,-36,-11,-20,-11,23,-47,-44,34,31,123
+U52426_at,760,1184,1124,688,450,928,1327,437,1866,655,952,357,778,1058,1247,617,842,629,403,1000,189,585,758,536,810,88,-521,513,495,906,582,598,1277,234,195,685,941,1207
+U52427_rna1_at,1340,492,1308,1254,2207,1273,1068,404,2098,919,1143,773,1688,1004,2434,1523,1809,705,767,3748,1761,500,1024,1610,1075,1254,898,525,615,892,437,896,904,892,1333,799,1127,552
+U52513_at,471,164,277,78,95,64,425,295,58,83,84,12,173,310,137,113,451,308,243,1348,101,130,338,418,394,239,441,357,406,2091,2893,597,91,62,-91,58,161,3581
+U52518_at,23,-471,62,-23,55,76,204,-308,-125,-247,-311,2,-132,-148,127,17,-1826,-77,-142,-390,-71,309,-32,-15,138,-112,-747,-145,925,11,-498,-242,-362,-153,-645,-243,-8,-329
+U52521_at,411,184,336,258,125,275,275,302,168,105,29,106,144,214,208,161,458,197,76,264,104,126,138,233,240,213,366,96,235,501,375,211,172,83,244,146,324,376
+U52522_at,765,864,1167,763,962,631,480,1039,1113,671,889,160,805,795,887,870,1596,568,647,1656,434,814,910,1115,754,932,1153,964,738,1863,488,1129,1006,388,791,614,657,1125
+U52682_at,62,-44,-276,295,232,-158,-154,-49,-78,-143,-104,-45,338,-90,246,299,-91,833,-7,486,477,763,-77,-3,-168,-11,126,-220,-74,-178,-177,-252,-60,-70,-51,-30,-38,-175
+U52700_at,98,88,20,93,3,165,72,-398,74,-85,-16,100,-7,170,121,7,-22,24,47,66,-32,177,5,-38,144,-112,-28,-56,2,-111,39,-162,18,-45,26,-20,-68,149
+U52827_at,43,-47,-59,40,26,-17,-55,-148,-21,-14,-35,-7,-42,28,17,-40,-123,103,19,4,128,34,-13,-34,61,-65,-159,31,-76,-8,-151,-31,-29,23,-101,-87,-36,-147
+U52830_at,712,264,431,918,403,519,730,1298,744,358,444,241,266,404,372,437,529,370,465,653,412,326,435,500,636,357,337,460,644,276,457,619,449,225,171,605,565,742
+U52840_at,-605,-930,-1795,-1201,-285,-842,-1297,-1343,-715,-629,-861,-534,-409,-721,-733,-595,-1218,-693,-431,-777,-282,-712,-1098,-713,-533,-610,-2392,-878,-627,-1062,-638,-677,-931,-281,-658,-1130,-1163,-1209
+U52960_at,-84,-57,-163,-63,14,-74,-132,-188,-79,-131,-43,-53,-62,-38,10,-146,-9,-53,-83,-42,-37,-13,-74,-93,-69,-110,-134,-120,-180,-104,72,-62,-48,-69,-67,-116,-126,-132
+U52969_at,267,55,200,-184,66,-101,-5,-41,58,12,81,-68,47,123,44,40,96,-29,56,-89,2,154,43,18,31,57,154,33,-45,-43,102,-62,-21,-39,129,-37,155,-17
+U53003_at,102,341,159,200,1243,-71,247,-299,526,12,-43,-81,473,926,485,531,751,106,188,1459,143,-170,-34,298,-38,404,-89,184,141,-259,-48,-73,67,-109,167,85,-104,-255
+U53174_at,-133,-284,-92,-313,-90,-96,-304,-272,19,-129,-160,-2,-55,-107,116,9,-379,-79,-53,-81,26,-69,-9,-191,-74,-193,-541,-178,-216,-294,93,27,-187,-35,-248,-362,104,-325
+U53209_at,2410,2136,1922,1262,1290,787,1708,1337,1914,874,1965,679,1900,1676,1792,1896,2954,572,2210,4568,1038,1643,1645,958,861,725,1311,947,620,1023,1628,1747,1355,708,1154,1585,1842,1117
+U53225_at,314,-265,-111,120,196,-96,-102,-547,31,-263,2,-185,15,-266,299,54,-70,0,-111,138,-267,-121,-129,4,-87,-145,-291,-357,-625,-552,-264,-137,-281,-30,-1215,-446,-390,-334
+U53347_at,887,559,995,1069,1093,483,972,920,765,775,305,579,1119,968,1146,601,1470,330,959,1108,394,694,566,898,1008,797,654,615,892,433,1509,1113,873,987,652,521,1119,1049
+U53442_at,-375,-138,198,2,-198,-364,-332,-403,-111,50,-349,66,-174,-90,-173,-108,-512,-184,13,-390,168,-302,15,134,0,-44,142,-147,134,-410,155,-182,-344,-221,-435,-32,189,-597
+U53445_at,-120,-77,-62,-89,-23,23,-70,-35,-111,-45,-20,2,-46,3,7,-53,15,59,-51,-25,19,-35,-85,34,-16,-33,0,-141,-33,-114,-35,-81,-117,-35,37,-53,-104,-66
+U53446_at,309,46,317,72,116,3,70,202,73,90,78,60,246,66,30,142,223,52,49,326,108,88,205,229,72,144,129,166,216,98,126,159,138,85,233,122,113,344
+U53468_at,141,84,98,5,238,32,-1,71,90,62,54,63,112,19,62,108,17,19,191,167,162,82,20,196,58,55,143,-39,-36,-32,1,36,13,31,21,52,24,29
+U53476_at,-129,160,233,-15,92,58,110,-479,-336,343,118,21,-67,-136,96,293,254,45,229,8,-158,61,0,-21,-24,-62,323,231,-129,352,63,-282,291,70,339,34,178,420
+U53506_at,-251,-242,-393,-239,-166,-227,-181,-407,-125,-243,-163,-169,-161,-228,-243,-191,-134,-185,-75,-236,-14,-168,-201,-217,-175,-170,-244,-140,-276,-249,9,-353,-249,98,-190,-185,-213,-353
+U53786_at,367,251,526,-60,207,145,282,494,-185,108,-9,227,289,91,252,182,142,239,163,120,402,383,393,241,291,605,275,810,432,188,-141,328,278,-125,7,154,519,536
+U53830_at,284,60,216,439,411,195,270,-116,331,84,124,22,259,11,997,190,-323,-142,12,1730,203,-96,218,683,1190,345,-582,-148,48,434,2389,-5,178,-29,-266,286,378,1687
+U54617_at,138,47,68,73,43,1,139,110,59,12,82,-4,23,33,48,90,92,8,42,124,97,47,-13,45,3,82,46,82,69,45,75,79,66,70,65,105,6,46
+U54778_at,1965,1839,2190,1675,2614,1303,1930,1752,2977,1089,1694,924,1783,2049,2234,1685,3858,1003,1153,4784,2015,661,1138,1921,1346,1440,2620,1668,807,1138,1318,1438,1750,797,2054,2088,1142,1734
+U54804_at,85,-9,45,88,-20,-7,94,92,81,14,162,73,4,23,25,53,87,74,6,600,-81,53,13,130,5,4,106,24,-9,93,91,119,65,57,43,75,31,64
+U54999_at,165,110,-10,217,57,156,23,-76,333,86,146,188,196,112,94,73,129,46,66,61,1,7,89,-15,194,-15,195,89,-98,22,143,142,303,66,71,86,19,-71
+U55054_at,-53,-52,-305,6,17,-80,-378,-472,-194,85,-50,-126,68,-119,-40,195,-179,216,31,136,-337,-177,195,100,124,244,-331,54,76,95,-83,0,42,21,-195,32,-5,104
+U55206_at,148,-5,-277,18,53,-1,26,-370,259,53,167,87,279,91,156,49,172,148,-3,193,319,61,-129,-30,21,123,-167,-123,-100,134,242,151,95,229,154,200,-130,16
+U55209_at,88,319,115,-255,130,28,-20,5,241,148,263,22,49,92,152,252,365,127,98,242,-33,121,-53,85,50,102,-514,137,7,-58,167,247,332,79,171,-90,347,36
+U55258_at,47,-87,708,-450,30,26,544,338,552,48,305,70,26,56,82,53,72,307,-41,348,193,134,-36,-1,63,343,-50,156,110,114,154,255,587,50,-206,35,131,761
+U55764_at,288,175,329,283,85,284,347,439,287,107,148,221,26,213,158,104,140,105,147,101,181,230,262,168,166,97,289,205,26,366,275,349,142,37,164,239,267,279
+U55766_at,78,354,134,54,167,55,5,106,117,143,417,21,66,132,105,52,165,55,33,154,182,179,178,149,55,43,23,255,52,192,233,247,229,145,108,122,192,133
+U55853_at,38,137,54,244,127,115,97,160,95,64,80,66,93,137,133,146,253,205,20,191,112,145,129,175,51,99,184,220,88,100,132,195,167,103,90,104,180,177
+U55936_at,230,124,206,153,197,92,-18,85,7,32,28,27,100,83,145,38,165,79,58,248,-7,-15,110,166,67,46,-17,92,19,14,99,90,64,50,25,44,218,53
+U56085_at,-109,-106,-385,-175,122,-112,-105,-335,-160,-64,-118,-152,79,-28,103,-68,86,-45,-59,189,-228,-90,-144,64,-168,-53,-97,-117,-336,-154,-355,-270,-147,-69,-231,-138,-149,-214
+U56102_at,-114,-4,-10,-19,-36,-14,10,-140,-11,-22,-20,-30,-20,32,-60,-29,57,-66,-64,-47,12,40,-43,-100,-8,-1,-82,-3,26,-64,18,-8,-95,49,-16,-95,-31,-135
+U56244_at,212,185,701,651,271,503,675,1019,298,242,227,359,311,407,311,400,952,117,158,154,353,435,262,407,161,213,475,531,608,481,279,249,231,142,283,315,358,254
+U56417_at,1098,854,1643,566,950,693,867,1292,1455,994,1109,327,1497,1243,641,1086,2033,847,913,1339,193,928,573,1184,1095,1306,416,1114,1346,1581,1204,1562,1272,386,1038,1442,1322,1390
+U56418_at,915,201,491,410,833,197,752,581,748,437,336,876,905,444,1214,544,1266,285,901,1768,344,733,338,910,769,1086,194,940,634,1695,427,650,1148,797,1131,731,1134,1343
+U56637_at,4531,2051,5563,3407,4063,2505,3787,1811,4134,1659,2378,948,2831,3619,4639,3184,6074,2606,1561,5931,3269,1527,1147,3710,981,1627,1517,1683,995,3263,1943,2068,1484,1256,2062,2547,1440,2995
+U56814_at,276,189,305,247,117,115,213,208,260,265,169,70,121,157,134,192,369,188,97,100,203,111,208,230,147,288,325,200,254,253,136,176,214,47,509,213,339,392
+U56816_at,588,554,849,-331,573,670,791,460,921,1266,1245,592,1198,600,520,53,1180,643,378,468,194,465,1124,1306,845,811,-935,889,543,1135,1126,1813,687,587,301,643,149,700
+U56833_at,757,410,850,301,519,284,236,259,754,326,730,314,1212,374,524,462,544,248,193,1127,1084,179,366,296,264,142,197,152,199,201,442,378,350,218,91,145,91,135
+U56976_at,-88,-92,-177,-214,-81,-183,-114,-272,-259,-175,-172,1,-118,-147,-92,-130,-127,-72,-62,-162,-138,-83,-104,-47,-29,-68,-300,-52,-317,-5,-209,-178,-151,-78,-253,-282,-236,-105
+U56998_at,-98,1230,-481,-1606,194,-1294,-1542,-379,-1154,718,-203,-673,128,-213,153,90,38,21,311,-157,-588,-117,-1236,-51,276,251,-597,515,-504,876,-142,295,354,-524,-718,-1683,-1544,-639
+U57057_at,67,86,-60,-4,20,94,5,-70,21,62,-7,25,-112,15,24,-105,31,-83,18,-45,-18,-41,-56,-16,51,28,62,-17,-120,-5,-80,-20,93,109,104,82,-13,-18
+U57092_at,10,-92,104,-30,58,128,204,173,2,114,114,64,21,39,77,-40,-162,65,62,-12,-12,274,214,87,-3,216,162,231,113,-112,232,76,136,106,108,-141,290,-207
+U57093_at,-25,21,3,-11,23,17,25,14,6,14,42,25,5,34,0,-17,-21,10,39,39,-52,9,-34,15,48,-7,-4,82,48,-29,36,-8,46,54,4,83,35,33
+U57094_at,180,206,106,165,295,145,21,146,195,86,274,278,51,282,236,219,385,226,46,246,453,205,182,601,333,240,341,449,281,491,384,369,271,362,480,289,219,492
+U57099_at,89,-146,62,-40,-72,99,-28,-296,97,-48,22,-159,-104,-78,-39,-29,-112,-66,-167,-339,-267,-57,-39,-66,-127,-352,-184,82,-173,76,-28,-27,-91,-155,-65,34,-99,-122
+U57316_at,566,133,546,428,638,238,132,842,367,285,360,386,384,331,792,550,438,175,259,679,254,444,410,823,861,476,-64,1106,591,331,365,854,806,185,67,255,392,259
+U57317_at,-297,-241,-336,-477,-291,-300,-361,-310,-384,-304,-217,-146,-178,-178,-147,-371,-447,-142,-224,-253,-203,-222,-237,-312,-254,-310,-369,-341,-331,-196,-193,-57,-370,-215,-123,-222,-290,-451
+U57342_at,2164,3000,2376,1834,1409,1435,1850,2796,3231,1826,2694,1342,2418,1828,1385,1225,4870,944,1178,2659,899,1566,1267,1493,2051,1461,1940,2635,2159,1704,3190,3953,2636,1597,2397,2932,2520,3204
+U57352_at,-786,-429,-727,-550,-481,-414,-344,-584,-236,-163,-173,100,-488,-594,-134,-365,406,-87,-222,-726,-112,-555,-186,-551,-486,-526,-657,-653,-295,-569,-387,-381,-808,-22,-846,-300,-541,-556
+U57450_at,658,331,904,662,151,599,522,1025,93,328,289,287,131,138,301,328,719,301,286,48,382,176,353,146,272,302,729,530,334,570,253,399,301,45,254,359,583,436
+U57452_at,10,93,39,15,13,10,-26,74,18,-48,24,44,43,64,-2,-3,145,-26,-15,99,31,-19,60,3,20,31,6,69,-50,103,1,39,177,34,21,13,169,104
+U57592_at,119,466,125,192,207,224,-115,329,12,142,233,142,275,557,477,255,681,277,238,337,153,372,360,585,197,136,203,455,115,583,1301,492,531,329,853,245,511,1959
+U57629_at,50,77,230,44,139,40,141,127,156,114,124,116,288,151,136,172,411,76,118,232,98,104,89,106,124,128,90,206,170,153,113,33,107,45,176,36,140,153
+U57650_at,1956,1281,1099,2694,1945,456,1611,1661,568,512,519,872,2073,1155,2376,1927,3636,1765,1507,3343,344,1119,659,1672,2169,2657,1431,1906,1344,1291,1069,1769,2759,788,1121,1225,2159,2216
+U57721_at,148,158,247,116,243,106,243,185,119,115,127,73,83,123,70,68,213,339,59,114,9,85,56,91,118,119,281,163,331,268,542,132,264,157,415,218,233,219
+U57796_at,59,8,119,69,18,12,26,148,101,14,74,-24,13,87,30,34,51,65,16,16,-41,18,-49,22,19,38,-14,82,4,132,-24,-17,103,1,47,-7,110,134
+U57877_at,1069,695,1475,537,806,801,922,713,1091,809,691,449,850,701,817,992,1347,792,606,1215,372,617,835,916,553,738,1037,766,656,1093,838,599,477,567,496,916,805,1083
+U57911_at,-23,19,310,-22,0,56,47,16,-23,-8,2,28,29,25,44,46,55,80,1,1081,-31,30,58,4,37,-25,42,20,40,59,-3,-12,15,11,-23,22,79,70
+U58032_at,329,188,321,321,115,115,305,374,256,42,137,112,80,196,126,60,132,53,92,88,-17,142,148,134,55,100,59,117,76,212,148,-80,15,9,199,126,179,-69
+U58033_at,29,-77,-30,-56,67,19,38,-4,87,27,7,-18,12,91,50,31,20,14,20,30,7,40,28,40,-17,49,-92,3,-2,-13,-5,19,18,-15,38,13,17,-1
+U58034_at,80,100,-18,56,111,28,112,43,49,105,94,22,101,91,122,1,85,61,63,82,4,30,56,184,117,108,6,147,16,152,154,207,86,90,157,47,190,147
+U58048_at,895,674,1337,788,709,392,1151,871,884,817,822,343,839,808,756,738,1791,570,730,1334,323,838,410,934,498,903,776,927,663,1172,870,781,984,340,945,1025,1399,1247
+U58087_at,753,441,952,688,682,378,687,640,382,198,360,306,680,541,797,633,895,96,984,1692,223,309,385,578,414,544,766,513,230,594,646,380,282,-86,280,290,144,747
+U58089_at,618,726,567,432,553,272,369,416,696,266,973,211,668,635,842,702,706,499,620,1544,333,396,389,632,166,409,115,624,254,597,783,534,426,289,436,261,413,598
+U58090_at,155,262,165,78,272,115,169,143,167,36,95,44,92,302,221,133,341,86,111,320,-101,28,24,125,40,25,59,183,28,131,102,76,159,59,115,47,295,122
+U58091_at,78,75,156,61,62,-39,92,-29,122,68,108,-22,104,95,116,98,122,45,55,79,86,37,64,165,56,50,140,79,33,81,26,128,21,0,48,0,111,64
+U58096_at,32,67,119,77,45,99,57,92,117,82,63,96,33,83,58,89,78,77,71,48,103,113,64,50,82,49,51,78,60,94,75,60,150,61,140,90,108,225
+U58130_at,528,178,792,307,338,359,420,511,166,304,197,166,437,214,323,215,436,422,378,242,474,358,243,593,144,214,488,342,483,521,391,249,350,155,424,448,438,293
+U58331_at,-131,-96,-1,-164,-21,49,-35,-82,21,13,-100,-37,-51,-43,-27,-63,-28,-89,89,-57,0,-96,26,-31,-12,-44,6,4,-31,-76,-51,-25,-41,-22,-6,17,-119,-136
+U58334_at,769,732,815,482,327,707,746,1374,1014,520,1361,349,704,673,476,828,560,549,851,1182,697,897,877,654,333,491,708,878,382,1269,1259,1194,1028,602,1231,871,710,1058
+U58522_at,80,23,45,39,69,51,-15,13,39,0,21,24,94,35,74,79,134,5,36,193,127,-74,-43,23,-20,27,-61,-50,-43,-58,48,34,71,29,-2,-5,30,63
+U58658_at,159,89,91,144,91,-33,8,205,-24,132,-143,45,240,175,44,50,208,260,82,488,263,30,1,171,184,48,291,-30,175,-21,13,222,187,55,220,3,1,90
+U58681_at,730,-117,773,357,616,238,366,565,282,321,259,250,406,856,479,443,896,154,409,121,133,116,492,280,970,128,345,332,567,961,815,335,396,251,1008,245,892,1741
+U58682_at,11731,13271,10628,14484,14923,12573,12170,9874,15537,10000,12206,14494,9023,14156,17453,11607,12614,12455,9130,15468,13237,11190,12096,13713,15481,12217,9751,10160,8995,6983,12804,13118,14816,14213,9528,10392,11606,10778
+U58766_at,693,722,976,839,664,583,668,1146,669,318,491,615,627,449,861,359,1147,445,483,821,186,591,636,714,639,686,926,542,507,569,630,822,341,424,448,625,375,878
+U58970_at,1134,276,336,191,1003,140,184,1122,789,224,748,262,767,815,931,1229,1621,1047,644,1177,762,1046,281,1100,1004,1063,563,1083,880,1009,892,982,1255,387,956,287,968,943
+U59057_at,-105,110,-7,65,90,-3,-119,-100,-161,99,-153,-20,-24,229,228,-95,245,-210,63,58,102,-35,96,-48,284,90,-84,-145,-50,57,215,91,-150,-1,168,-34,183,-167
+U59111_at,127,53,203,0,120,88,104,283,37,28,86,67,109,122,34,134,222,89,16,81,13,56,146,73,194,137,162,57,177,-224,24,28,175,102,71,134,127,132
+U59228_at,-92,376,138,415,-72,160,515,293,350,218,262,112,44,218,-29,23,325,165,212,270,-218,158,146,-126,355,169,453,320,288,-11,271,270,514,158,128,223,436,375
+U59286_at,-157,-162,-217,-198,-69,-124,-226,-229,-150,-114,-63,-109,-61,-132,-114,-116,-321,-68,-67,-143,-103,-142,-159,-133,-98,-98,-255,-143,-156,46,-51,-57,-161,-45,-169,-179,-198,-200
+U59289_at,58,64,28,-67,-1,99,-11,44,72,27,52,103,-3,-6,26,21,170,90,-5,79,46,-19,167,-46,6,-9,226,-31,86,-23,4,-36,-8,66,11,15,-74,-25
+U59302_at,426,711,904,426,357,576,556,626,571,153,449,323,143,743,387,278,422,180,188,376,519,227,303,440,325,175,336,349,428,366,379,305,445,258,87,273,473,415
+U59309_at,443,235,675,448,883,497,435,235,468,346,106,107,285,713,1000,357,484,856,221,595,408,132,248,534,161,239,347,192,254,268,366,327,135,359,288,329,109,67
+U59321_at,356,-29,223,1127,196,179,287,199,282,91,71,-22,419,210,930,639,142,97,329,1307,274,27,62,386,1363,1724,61,987,14,9,-115,13,26,458,-67,7,3434,-54
+U59325_at,-61,-61,-72,-89,-97,-72,42,-4,42,4,-46,-83,-22,7,-64,-134,-193,-51,-71,-49,-63,-66,-41,-97,-27,-67,-148,-73,-115,-156,-16,-88,-103,-71,-47,-6,-144,-54
+U59423_at,2350,25,173,-5,44,160,36,4430,166,60,174,94,403,104,20,12,492,16,88,3035,327,125,150,11,263,199,12,118,177,75,56,24,87,191,101,149,385,133
+U59736_at,581,291,545,385,221,357,542,787,407,242,277,270,197,376,167,275,302,213,283,174,274,316,397,419,322,190,400,365,533,287,463,594,281,94,428,459,492,657
+U59748_at,-214,-66,-185,-77,-45,-117,-63,152,-172,-97,-144,-90,-43,-87,-62,-32,95,-78,-77,-146,39,-179,94,-15,-29,-94,123,-70,-137,-62,-106,-157,-50,-37,-28,-82,-132,-81
+U59752_at,1317,861,1457,1067,866,1018,1129,1412,1473,876,1375,593,782,643,850,830,887,593,940,1700,512,857,1086,983,534,775,603,891,543,908,1039,1342,926,572,593,575,1200,1336
+U59863_at,42,335,107,10,148,71,80,52,-7,14,152,-5,76,149,105,113,175,159,4,271,77,-3,-56,167,38,16,73,108,43,271,163,32,45,94,321,53,104,204
+U59878_at,367,561,977,279,200,542,245,259,888,589,822,175,201,566,245,239,918,171,216,245,86,146,478,284,186,132,366,853,447,758,216,495,371,182,424,767,527,610
+U59913_at,90,-44,41,93,39,17,-36,89,-18,-20,37,-22,179,129,38,62,-3,24,29,278,92,-18,22,77,27,37,12,24,-31,49,25,11,15,13,11,-58,-23,8
+U59914_at,1,153,68,106,8,14,25,40,0,59,83,15,-4,32,29,-10,-41,14,-23,0,-36,-1,142,0,2,0,118,61,9,39,59,-1,31,10,51,24,101,89
+U59919_at,148,121,277,231,66,160,188,247,205,150,200,12,121,443,104,313,153,200,145,164,3,79,98,197,111,127,95,98,110,131,194,124,139,111,107,188,266,14
+U60060_at,-42,84,-14,164,120,147,-6,118,104,4,89,74,130,116,95,-22,78,210,-25,44,-14,78,117,171,10,64,161,148,-12,436,111,109,-21,9,413,147,49,185
+U60062_at,196,111,190,66,49,192,258,298,126,248,236,35,-53,59,13,-37,29,140,-51,57,138,104,334,221,59,-43,-68,223,276,59,-249,-183,-25,73,267,521,-259,-81
+U60115_at,2466,119,550,1289,1098,570,315,653,2438,928,1130,560,2384,207,2241,1124,434,146,1354,606,1156,214,374,1432,442,1614,478,296,125,164,172,45,507,121,333,1237,829,363
+U60116_at,394,204,514,393,193,225,453,506,303,179,260,217,281,274,224,257,297,343,53,294,188,171,165,200,276,274,494,406,110,486,224,153,322,217,100,309,359,584
+U60205_at,-49,15,-17,29,87,-30,-25,-13,136,189,78,-22,58,57,49,79,-53,128,-45,29,41,-34,41,-31,-67,20,-109,-47,-110,119,-63,-47,-44,57,-8,-32,13,-139
+U60269_cds1_at,64,-41,90,56,114,-56,122,188,68,54,77,-38,57,76,46,27,171,29,71,107,203,-47,113,152,287,81,-62,-121,218,-97,-31,235,-20,-17,87,57,-91,70
+U60269_cds2_at,338,263,293,257,311,119,265,503,336,297,244,182,195,302,184,330,449,321,177,326,191,166,279,386,289,336,433,240,199,396,302,292,342,185,262,209,339,417
+U60269_cds3_at,638,522,544,388,230,80,194,743,150,299,380,61,303,331,236,394,713,216,298,533,107,561,469,283,413,151,744,583,464,842,371,643,444,187,576,729,390,613
+U60276_at,-675,-718,-956,-1110,-35,-896,-1199,-1467,-706,-564,-365,-386,-233,-590,-248,-365,-1003,-530,-515,-193,-524,-902,-908,-476,-588,-555,-1708,-1206,-632,-1264,-407,-1001,-849,-71,-988,-987,-966,-1483
+U60319_at,-68,-76,-21,-83,-11,-42,11,-8,-13,-2,-16,-11,-46,6,-4,-21,5,-47,-46,-43,-2,-107,-24,-69,-9,10,1,-113,-96,-135,10,-5,-75,25,-9,27,-59,-50
+U60325_at,678,531,523,369,631,496,267,412,986,334,510,176,504,843,771,596,813,277,254,791,213,95,554,767,152,471,61,507,266,283,157,397,332,290,446,209,476,213
+U60415_at,-7,39,2,34,71,17,5,61,42,20,18,-60,19,194,58,10,-6,29,-15,4,-37,17,41,58,33,29,-93,-41,-93,101,28,17,38,22,50,3,70,-31
+U60519_at,174,324,420,124,8,23,157,352,285,105,86,48,55,366,113,274,427,-5,154,153,176,251,51,135,230,161,25,142,113,395,24,174,69,-29,210,134,137,386
+U60521_at,-153,25,-274,-120,152,-74,-35,-347,-17,-113,32,-33,-142,-46,23,-46,-376,-131,-84,-3,39,-111,-144,17,10,-160,-208,-143,-331,44,-149,-150,-193,3,10,-190,-24,-177
+U60644_at,-79,364,-313,-136,195,33,337,-268,417,21,201,-317,210,351,-70,88,844,-60,-312,-380,-337,-511,3,313,292,-118,-405,784,319,8041,1676,-433,354,170,14219,2979,1121,-218
+U60665_at,-310,-299,-447,-417,-89,-248,-362,-460,-178,-322,-138,-244,-119,-297,-76,-124,-479,-103,-199,-154,-113,-265,-455,-236,-103,-229,-594,-423,-312,-237,-324,-252,-346,-87,-326,-342,-345,-237
+U60666_at,165,197,108,262,251,62,183,325,153,112,82,182,-16,195,196,230,-48,20,219,62,188,141,182,179,321,-40,23,234,317,165,303,279,293,207,182,405,382,266
+U60800_at,-105,-942,-474,-881,-1158,-48,-1833,-1386,107,-1239,-602,-668,-1070,1844,-470,-1029,1568,-860,-139,640,192,-1089,-300,-582,-573,-1112,-1813,-994,163,-820,-769,-1837,-685,47,-1372,-2207,-735,580
+U60805_at,-109,-54,-47,-71,-14,-42,67,-71,-28,-26,-29,-51,-25,-45,-36,-19,-47,-27,-6,-79,-83,-58,-79,-98,-73,-53,4,-99,-74,-44,-72,-59,18,43,-18,-45,-33,-138
+U60873_at,-573,-233,-802,-357,-8,-467,-524,-490,-587,-402,-506,-293,-322,-530,-327,-339,-280,-269,-161,-282,-307,-456,-625,-393,131,-422,-547,-141,-377,-172,-84,113,-61,-246,45,-409,-445,-282
+U60975_at,463,3347,1089,1581,1125,978,2357,1274,605,426,574,557,928,1618,2233,766,4147,282,836,930,528,578,427,2365,670,913,705,1668,3347,902,553,1877,1055,915,419,1285,3477,1261
+U61145_at,303,112,528,337,358,330,294,134,397,358,496,153,433,256,620,215,231,300,173,551,748,219,511,334,73,24,51,114,182,391,392,195,277,155,114,125,68,70
+U61166_at,360,235,571,576,157,183,393,905,383,256,323,324,322,138,175,397,566,312,206,297,119,227,224,472,227,129,316,475,461,462,395,415,353,195,371,317,453,616
+U61167_at,-117,91,-402,-63,137,-190,-72,-433,-268,-137,-88,-90,29,125,32,-21,-95,-98,34,55,66,-122,24,59,-143,-50,-411,9,-67,-61,105,166,-19,18,54,-121,3,-63
+U61232_at,128,87,278,182,227,147,127,119,172,49,203,1,159,92,112,124,156,121,-4,339,163,32,66,115,90,135,184,86,-74,51,16,132,37,18,25,20,119,51
+U61234_at,382,611,658,334,668,200,519,428,358,328,390,89,533,349,582,479,691,274,277,1154,168,394,227,760,337,609,276,325,230,642,215,779,563,227,424,349,846,403
+U61262_at,-220,-190,-329,-183,-11,120,-92,-362,-160,82,-139,-76,-152,40,-162,-23,-254,-36,92,-140,87,-192,112,-599,111,-207,-276,-225,100,-298,128,-51,-151,45,19,-204,-160,-369
+U61263_at,451,549,582,467,424,487,539,539,482,594,580,471,689,594,445,542,707,609,535,726,86,377,313,346,523,586,718,590,562,376,724,911,562,219,342,508,813,935
+U61374_at,14,37,34,-13,32,-23,-13,14,33,-32,-69,-21,43,88,58,-19,120,45,-25,12,-36,-3,108,-121,-24,-46,154,-123,-24,-26,-128,9,-27,47,101,-70,-5,-13
+U61538_at,80,181,180,95,60,60,124,8,38,86,109,71,-329,69,71,118,100,16,49,20,82,56,110,66,23,90,21,64,-81,138,189,216,67,54,134,126,167,192
+U61741_at,-226,39,70,9,56,-12,-146,-142,-100,33,-106,-165,78,-64,36,62,167,-32,3,206,19,-87,-58,-85,-141,49,107,-144,-93,29,67,-65,-99,107,-104,-30,45,53
+U61836_at,190,-44,490,579,-58,-264,-144,-344,314,-66,-54,301,38,-228,-6,-68,111,-122,-71,145,-126,-9,113,-165,24,-172,-486,-150,-4,406,1660,2352,620,396,1317,-158,592,826
+U61849_at,76,31,31,56,103,48,55,-16,41,45,6,48,4,110,-37,101,135,409,25,61,22,69,-26,192,109,184,95,-34,79,79,26,170,67,3,76,47,67,132
+U62015_at,-51,-36,-106,-5,-18,-44,-15,-50,-41,-39,-47,-37,-56,34,-61,-59,30,41,-23,-39,26,-66,15,-100,-18,-59,-23,-87,-79,20,-57,9,-27,-66,-24,-51,-27,-87
+U62136_at,327,516,338,285,782,298,230,266,466,280,155,140,660,513,695,418,812,239,273,1392,530,158,307,481,263,252,333,80,108,132,171,242,149,213,187,156,196,153
+U62317_rna3_at,1945,1306,1725,2904,1751,1950,2285,2778,2343,1624,1227,1373,1394,1804,1686,1894,3202,1683,1437,2790,2097,1029,1871,1728,1525,1842,2919,1937,1801,4163,2895,2320,2057,1417,2767,2619,1974,2620
+U62317_rna6_at,-117,36,-390,107,-115,-3,47,-757,75,-263,-59,201,-75,33,105,-112,-842,-173,129,-462,101,-155,39,-270,-50,-231,-301,-74,-117,-391,101,-67,-166,0,135,48,293,-670
+U62317_rna7_at,-865,259,-1110,378,799,-190,-525,-1505,-699,100,-1,-155,167,-191,376,351,-140,-49,-409,74,-669,-589,-208,191,35,723,-885,-114,-62,361,-604,-126,-216,-123,297,-452,-202,-608
+U62325_at,19,87,-3,69,103,-3,78,-67,-13,4,13,-44,-1,55,17,8,-6,-5,36,175,48,275,74,30,15,-41,79,-27,55,-88,51,4,88,19,-26,44,-69,7
+U62389_at,243,183,99,372,431,55,250,188,119,120,244,159,88,150,197,243,488,161,76,70,76,27,79,243,187,74,259,215,281,257,41,90,48,109,300,230,187,65
+U62431_at,-63,-18,122,-50,-45,-104,33,-73,0,-78,111,-58,-107,-79,-150,-47,-210,-99,-3,-159,146,-11,-186,-52,105,-87,-237,5,-4,-29,-104,37,-128,-6,-24,-137,-101,-56
+U62433_at,212,49,220,258,123,174,258,437,66,205,34,146,101,114,62,216,68,134,40,245,-52,170,188,185,65,242,89,306,117,391,54,129,252,169,166,160,308,747
+U62437_at,512,16,120,360,169,398,428,328,431,167,323,152,33,246,175,225,-66,178,282,61,549,264,385,176,287,288,-28,403,480,294,266,263,257,178,98,207,306,445
+U62531_at,-968,-1931,-1634,-1617,-1421,-1289,-1554,-2370,-855,-1636,-893,-1210,-811,-1434,-1668,-429,-2315,-524,-1292,-1534,-83,-1362,-1044,-953,-1148,-1122,-3029,-902,-1175,-1474,-3669,-1645,-1047,-1465,-2923,-1531,-1577,-3669
+U62739_at,1685,1306,1880,1728,1215,1187,1819,2081,1555,1160,1019,832,901,1144,1045,1389,1766,1061,1163,1381,589,950,1476,1272,1007,1185,1567,1391,1719,1354,1448,1410,1459,588,1133,1672,1877,2168
+U62800_at,-271,-288,-558,-320,-60,-211,-305,-310,-96,-299,-208,-219,-83,-78,9,-55,-276,-86,-6,-118,-28,-260,-290,-35,-220,-262,-466,-187,-153,-190,-126,-80,-333,-63,-55,-410,-549,-265
+U62801_at,-498,-347,-646,294,-124,-401,-677,-944,376,-375,-59,248,-73,46,244,-60,-766,-198,67,329,223,-36,-328,-123,372,-252,-215,-416,-497,-197,-49,58,370,69,281,460,488,-715
+U62961_at,4,111,233,80,89,113,62,49,198,95,191,94,105,200,160,49,45,54,123,77,274,-10,66,170,-12,43,125,-10,-28,-20,-56,-64,78,-9,27,91,97,-26
+U62962_at,3512,2807,3142,3167,5468,1790,3416,1919,4451,2629,4523,1853,4145,4295,4876,4138,3674,3460,4103,10651,7152,2521,2958,3891,2453,3391,2824,4377,1938,2420,2999,3972,4546,3733,3728,2533,2835,6855
+U62966_at,-91,-92,-244,-141,-60,71,-208,-428,-249,-77,-131,258,-202,-251,-118,-131,-376,-83,-158,-164,242,-11,-159,-132,-174,-97,319,-238,-293,-194,-72,-411,-91,-173,-273,-126,-138,-262
+U63090_at,211,27,369,231,187,131,178,308,262,171,195,-67,158,64,103,273,293,153,-41,258,-31,240,220,57,170,200,189,-78,-218,281,317,311,329,-66,29,205,332,413
+U63139_at,48,-33,-157,-211,57,-8,-141,-8,-10,-20,-107,-76,-44,-13,-26,-78,-59,-14,11,0,-42,-39,-146,-8,-99,29,-128,-48,-144,-114,-93,-82,-57,-70,-66,-41,-137,-112
+U63289_at,-183,-51,-245,-126,-108,-48,-265,-161,35,-147,-17,-159,-128,-221,-56,-161,-170,-118,-95,-131,-56,-30,-30,36,-208,-138,-61,-92,12,77,-9,96,26,62,-76,-7,-68,-54
+U63295_at,30,74,-66,27,-28,74,-26,106,-14,-24,123,-2,14,67,20,66,70,15,47,66,439,40,-24,113,56,19,154,8,-38,-38,47,111,120,59,147,-13,6,153
+U63312_at,-351,-350,-609,-461,-247,-398,-527,-643,-508,-303,-342,-293,-307,-263,-365,-244,-374,-263,-252,-371,-209,-321,-383,-461,-213,-266,-580,-503,-425,-333,-455,-364,-426,-231,-378,-413,-418,-485
+U63329_at,205,-761,-863,-863,-290,-727,-825,-1085,-210,-379,-257,-612,-47,-253,-292,-305,21,-248,-190,-314,-173,-656,-414,-545,-491,-391,-1223,-607,-557,-1007,-1080,-997,-470,-630,-590,-784,-1089,-998
+U63332_at,-37,0,-19,-47,-17,-14,13,-76,48,-13,-19,-33,-20,-18,-80,-74,-9,-46,-20,-17,-62,44,-53,27,3,-33,10,-31,24,-29,-25,-52,1,11,-27,9,-36,-14
+U63336_at,250,228,101,362,352,286,15,-49,-100,327,118,119,192,329,265,146,483,22,216,529,272,-138,359,220,-43,311,381,327,-31,214,228,56,353,186,141,168,296,92
+U63455_at,358,647,440,311,-2,195,319,244,-47,173,224,209,103,256,104,428,449,166,211,267,36,215,265,88,255,-25,366,293,274,-268,257,311,458,154,305,273,409,550
+U63541_at,599,294,231,426,422,337,527,562,873,358,334,285,285,488,175,401,432,302,187,537,301,224,387,506,382,497,122,404,685,180,558,534,589,346,280,468,514,806
+U63542_at,150,-10,-175,-20,112,-7,-198,-122,-59,-68,89,56,17,0,112,-65,-208,-143,-81,100,-26,92,-64,-87,176,-126,-71,160,19,35,45,79,59,-87,174,36,10,2
+U63717_at,363,105,135,189,233,-3,280,-37,329,47,156,10,196,216,260,212,10,-2,62,149,46,-37,243,520,71,46,64,-53,93,307,-34,-19,103,73,201,75,21,96
+U63743_at,168,98,972,1152,195,777,507,251,1129,739,1148,538,556,778,814,114,213,600,49,360,424,10,1210,203,328,40,369,-29,218,122,1306,941,545,183,56,770,960,-20
+U63824_at,-52,-102,-18,-45,40,8,-142,-41,-19,-12,-20,-24,10,-64,-30,-50,-15,26,13,34,-9,37,30,-13,-20,-12,-10,-41,-96,-395,90,-27,158,10,5,-90,-21,36
+U63825_at,248,636,354,765,1194,455,551,698,446,500,4,623,620,1091,1113,435,1047,650,653,4299,27,1846,790,870,656,1107,962,490,375,801,329,365,252,119,762,378,791,616
+U63842_at,762,354,793,460,215,437,614,827,515,355,477,254,395,256,293,611,1022,524,363,379,128,574,493,391,468,620,546,468,519,446,458,605,522,90,332,337,528,1016
+U64105_at,2120,1679,2204,1761,1420,1619,2001,2239,1865,1032,1140,521,1280,2611,1751,1530,2476,612,1123,2264,715,691,1928,1610,838,1671,1203,2572,1796,1965,1099,772,1875,578,1772,1602,2499,1343
+U64197_at,-42,-219,303,80,-223,-234,-213,-257,-216,120,-180,-145,-113,36,-216,21,-184,174,214,99,51,6,-182,-226,-50,-65,184,7,-141,-165,164,330,-250,70,-268,-109,182,-140
+U64198_at,-72,-123,-122,-121,-22,-88,-92,-82,-99,-82,-39,-61,-17,-64,-12,-63,-220,-99,-16,-64,-71,-64,53,-48,-6,-44,-118,-43,-96,-150,-62,-78,-162,-50,-107,-88,-74,-86
+U64444_at,995,987,2049,793,1108,862,814,853,1954,954,1224,560,793,924,902,820,1250,827,667,1077,919,1084,1084,897,759,842,538,911,651,1460,1114,1160,900,772,1259,765,975,1032
+U64520_at,63,25,63,117,68,-55,1,5,56,44,39,4,23,48,57,-6,36,-13,-13,181,72,141,18,139,4,8,-1,18,-2,21,165,181,145,119,22,26,58,218
+U64675_at,-408,284,975,-239,-129,529,-278,-442,740,89,339,-160,-162,-241,-67,-209,-264,-110,-149,-140,-94,99,414,-357,-224,-284,-303,-24,-115,-214,216,536,114,-169,-51,-241,-176,13
+U64863_at,-52,-36,54,-513,145,-483,-210,-211,60,19,292,-117,-13,170,-116,237,-77,114,-118,-295,-174,146,26,-178,-21,109,-10,-411,-62,-31,-305,-585,134,-73,-171,-194,-207,-135
+U64871_at,93,-1,29,72,-37,-44,84,40,-45,-79,-19,-7,51,33,-9,27,-7,-35,24,-27,18,-24,62,-69,-18,48,67,-86,14,-37,-35,-34,-6,-43,-26,-85,-83,-119
+U64998_at,256,-189,-400,76,152,-232,164,-434,-311,-310,-173,-104,-236,-230,119,-181,-542,-122,-205,72,-141,-188,-313,205,-184,-241,-544,-239,-9,1045,23,-290,-304,-90,2063,227,-37,95
+U65002_at,56,20,-22,-15,25,-44,-6,-25,-1,-9,-23,-38,-20,15,3,-32,-12,27,-33,-13,-13,-15,3,16,16,-6,31,-45,-86,-64,9,2,30,-45,-6,22,-51,-28
+U65011_at,-95,-50,-116,-47,-47,-71,-26,-155,-127,-57,-73,-34,-37,-73,-59,-13,-56,-53,16,9,34,15,-102,-50,-64,-52,-32,491,-19,-69,-79,-67,64,-82,-106,22,-33,-48
+U65092_at,28,-166,-237,-8,62,-58,26,-203,44,36,8,126,-38,-152,-81,5,-159,-49,-100,-13,-38,52,-207,-163,-13,9,-86,-203,-165,-122,275,-40,-101,-50,-170,298,-101,-152
+U65093_at,246,886,101,43,462,199,149,-307,275,478,84,455,397,-60,176,223,1088,27,-120,1157,421,-92,70,416,1396,262,-264,343,-514,1275,423,1098,1494,748,677,166,716,561
+U65402_at,1092,930,2383,1002,778,1059,1273,1589,986,1120,1363,1082,831,1507,408,1179,1248,691,871,536,754,939,1597,1148,819,918,1406,1779,1459,1049,1138,1197,1179,-51,895,2013,1316,1863
+U65404_at,-152,-66,-278,155,-133,129,228,53,-49,72,124,198,-19,-125,-56,-127,-3,-122,92,132,188,62,81,213,97,59,123,-124,250,4,357,221,82,266,-91,170,288,12
+U65406_rna4_at,88,48,-10,151,9,151,115,98,50,64,-13,89,57,73,27,47,60,46,50,-39,27,56,112,48,48,65,-39,64,14,26,78,81,79,-21,151,96,120,136
+U65410_at,-166,15,-2,-56,29,-149,-85,-215,52,50,156,-112,202,-32,131,-187,-61,17,13,-45,66,-99,-37,-26,-80,-100,-308,-142,-151,-149,-70,-93,-65,-78,-111,-241,-189,-237
+U65437_rna1_at,7,7,22,-42,-59,-94,-58,-1,0,-33,-31,-21,-31,21,-39,-40,-63,-76,-46,-24,21,32,55,6,-44,-14,-46,-66,28,-71,65,-26,-22,14,31,24,-23,-47
+U65579_at,-53,-188,385,263,562,40,58,-23,726,271,477,357,188,425,660,89,-216,152,286,1008,71,-23,383,255,135,339,10,117,-233,-159,267,97,274,134,311,487,172,-75
+U65581_at,2151,1044,1645,1385,817,1310,1601,1662,1455,1193,1214,925,889,1185,941,1147,3030,1110,866,2504,411,1722,847,1261,970,1618,1545,1358,1991,1389,1564,2538,3095,707,1317,1607,1671,3506
+U65676_at,-185,-33,-232,-79,-88,-94,-379,-50,-648,-237,111,-140,48,-133,-227,-458,-273,-100,-152,-231,67,-218,636,-13,-115,-137,-405,-437,-214,-49,-413,-230,-303,-62,-323,-383,-436,-78
+U65785_at,943,1175,1346,790,1016,890,890,1143,2062,1159,1430,474,1014,917,908,955,1984,983,815,1947,1149,745,575,984,687,866,1237,1157,721,1473,802,1021,1140,468,2908,1296,1107,1304
+U65928_at,369,291,354,354,792,172,233,286,653,219,484,68,621,546,555,482,642,152,216,1266,341,113,243,594,275,281,159,179,180,89,167,224,204,207,131,150,150,184
+U65932_at,1180,85,562,598,699,94,100,29,500,327,154,1332,928,122,319,1439,747,212,3712,207,159,500,148,444,2035,3099,424,298,38,190,134,90,396,254,350,466,121,198
+U66033_at,-56,-26,-61,-85,-8,-108,-35,-152,-46,-25,-56,-22,-33,-12,-51,-45,-105,-4,-36,-68,-13,-15,-110,5,-40,-26,-137,-72,-67,206,0,-24,-34,2,-93,-68,-35,-65
+U66036_at,123,72,217,58,-1,104,126,128,20,67,83,80,53,34,-8,38,22,129,39,55,134,133,36,-40,65,182,86,204,48,177,167,65,130,15,64,82,82,195
+U66048_at,507,357,378,321,148,122,381,346,322,219,185,212,249,389,179,527,688,389,346,50,181,141,208,187,213,296,373,543,168,197,220,276,548,90,322,-2513,301,879
+U66052_at,662,377,755,500,373,179,480,481,475,468,467,198,387,511,251,518,854,312,427,446,339,468,497,388,371,474,672,532,601,469,406,528,651,257,353,536,718,788
+U66059_cds7_at,621,333,816,808,434,1221,719,946,703,356,585,383,329,436,296,516,562,399,340,334,167,524,611,553,587,533,542,585,577,291,780,521,554,270,364,576,413,1056
+U66075_at,-54,-32,-83,-60,-6,-85,-26,-148,-45,-20,-26,-18,-55,38,-11,-6,-37,-4,7,19,26,-54,-51,-17,-25,-12,-48,-25,-79,-93,-36,29,-68,25,-29,-11,-35,-31
+U66083_at,195,223,402,101,105,92,18,278,125,186,50,77,86,87,78,230,518,129,177,57,66,141,283,232,202,353,427,254,-9,155,-8,209,47,-13,153,71,189,143
+U66088_at,230,140,293,93,262,-1,136,203,223,240,238,-10,200,143,62,273,377,133,67,301,27,184,330,325,241,243,217,291,286,195,156,349,348,169,186,69,217,586
+U66198_at,-31,-108,-43,-160,-73,-46,-45,-23,-123,-9,-57,44,-1,-58,-95,-68,-6,-71,-66,-30,9,2,-123,-100,-61,-77,-10,-62,-72,-124,-134,-11,-120,-67,-156,-64,3,-151
+U66359_at,-341,-3,-526,-375,15,-268,-144,-533,-370,-328,-73,-89,16,-99,0,-153,-257,-267,-97,-44,-113,-253,-60,57,-31,-78,-265,-178,-194,-276,-290,-202,-167,-87,-44,-538,-355,-783
+U66406_at,307,369,850,370,447,496,507,667,429,368,413,248,478,516,274,450,1139,347,136,639,-3,483,465,284,446,254,755,182,199,487,448,581,448,181,410,385,796,719
+U66464_at,474,1022,766,118,588,761,581,388,640,237,200,242,912,594,939,728,674,414,519,1163,618,283,790,900,316,602,251,335,170,512,-37,-105,264,199,513,381,803,-99
+U66468_at,89,214,58,151,701,120,243,2,891,56,728,120,121,137,142,65,-17,83,228,565,534,122,91,72,403,77,32,0,755,62,499,444,193,551,141,102,123,439
+U66469_at,241,229,288,53,189,117,196,97,93,258,219,80,306,220,171,146,126,58,171,480,413,232,104,232,110,130,255,147,2,131,171,213,151,134,113,138,211,272
+U66497_at,88,74,152,98,64,-3,65,83,100,25,28,54,0,31,27,18,30,41,1,79,57,87,79,76,49,117,68,34,0,15,41,88,113,42,79,64,25,131
+U66559_at,438,43,222,851,235,787,846,509,-321,184,84,255,186,526,159,578,220,-16,93,34,-13,704,847,350,678,627,603,359,173,347,148,822,3,-262,496,673,-228,204
+U66561_at,65,45,25,9,53,19,10,40,26,93,29,-2,50,13,43,26,35,-24,11,104,128,-14,5,69,33,4,45,17,-24,17,-65,12,78,-30,-3,-14,-2,28
+U66578_at,329,357,559,183,243,279,530,220,146,248,199,80,292,170,40,263,371,185,314,156,41,291,341,50,315,313,497,450,283,382,161,379,391,87,151,249,297,500
+U66580_at,-57,-93,11,-2,-80,-65,-18,34,-73,0,-41,7,-67,-79,-71,-127,-28,-109,-42,-114,-6,-77,-72,-63,30,-71,-20,-103,-69,-112,-108,-73,-9,-61,-124,-83,-70,-90
+U66581_at,-66,-17,-118,-96,-5,-21,-99,-199,-148,-42,-59,-2,-40,-87,-24,-28,121,-26,-80,-9,13,104,-98,-64,-39,-32,-145,-141,-144,-34,-27,-71,-112,26,-17,-107,-43,-56
+U66615_at,1040,674,1069,525,998,618,485,1410,1158,644,1073,421,772,1033,564,920,2021,663,452,1429,341,649,526,1014,292,1132,740,968,721,818,468,529,1308,555,776,911,1027,1298
+U66616_at,719,754,751,404,570,485,811,1033,783,310,627,22,366,658,582,466,1145,299,267,171,307,154,169,916,297,476,312,1445,634,164,166,145,574,285,632,749,719,41
+U66617_at,919,987,1362,1132,679,848,951,1359,1064,843,1201,600,686,991,811,872,1394,636,592,957,401,1021,619,814,740,654,1309,893,904,739,932,1142,652,407,862,1055,1166,1339
+U66618_at,1139,749,944,814,1021,601,495,758,1109,292,768,148,954,521,778,781,1615,589,503,979,189,558,503,1181,827,785,125,732,853,557,606,738,703,490,672,508,727,705
+U66619_at,-1448,-1049,-1489,-1117,-820,-835,-1670,-2145,-1079,-1074,-1152,-807,-521,-1249,-760,-798,-1817,-611,-811,-1223,-574,-1069,-1246,-1039,-1131,-921,-1808,-1375,-969,-838,-1003,-1521,-1442,-560,-942,-1123,-1074,-1776
+U66661_at,124,109,190,219,57,40,169,395,76,97,87,41,96,79,105,86,238,20,153,26,26,244,155,85,224,162,147,168,21,-20,235,194,182,67,161,134,137,329
+U66669_at,30,21,58,38,90,60,-28,13,89,9,-10,54,52,170,65,-2,57,21,40,113,163,43,110,82,41,38,-28,113,48,-3,20,24,25,-13,3,66,9,55
+U66702_at,192,179,168,212,16,119,166,218,184,39,91,149,29,178,114,125,2,57,51,112,212,160,319,165,128,80,331,-75,156,465,133,105,161,27,177,213,162,129
+U66838_at,64,47,371,2995,5008,108,1280,544,326,201,258,461,183,404,1615,237,472,328,217,318,256,111,273,2095,378,233,147,1360,464,506,1818,500,532,955,1166,2997,417,2061
+U66879_at,985,1052,1902,1204,660,960,1036,890,1305,884,1150,689,614,862,864,1019,1185,794,659,940,429,982,805,1136,807,1138,1171,1054,723,983,601,776,949,599,1296,1808,1250,796
+U67156_at,13,-20,0,130,200,-42,253,-116,-24,-41,-43,-20,51,-14,177,27,67,39,23,27,-7,-5,34,252,28,-54,23,42,-26,88,48,45,14,31,91,28,55,69
+U67171_at,1468,2162,8895,793,616,3972,21,833,9668,4390,2727,666,479,3077,1799,481,787,602,206,821,126,193,750,1124,808,404,183,693,435,987,464,418,952,97,1191,796,1161,192
+U67191_at,24,57,-110,-94,65,-131,-199,-11,80,142,62,-77,74,89,9,67,-159,80,-101,35,-18,108,100,72,21,88,73,-11,-31,-243,37,33,124,-85,-80,-193,106,82
+U67319_at,202,183,134,125,201,53,122,194,177,111,174,84,350,117,128,166,307,83,190,303,177,167,68,140,74,128,273,89,60,98,118,162,128,45,242,32,99,64
+U67369_at,517,804,959,702,360,661,762,904,713,739,651,416,442,239,392,315,1030,247,328,696,397,643,1069,547,341,317,765,514,519,543,531,574,376,720,890,716,426,513
+U67611_at,34,71,-30,50,9,14,15,-13,42,-66,34,4,78,3,-11,-49,83,-30,-2,-40,26,47,11,61,33,-21,-32,26,-45,-39,16,-8,-7,81,5,-9,-129,-58
+U67614_at,103,131,181,119,69,128,136,55,65,132,118,120,60,115,33,68,267,87,44,76,19,90,41,83,49,32,222,104,182,135,69,171,172,61,248,86,130,132
+U67674_at,593,494,473,302,313,439,351,269,476,512,248,139,250,271,161,239,701,220,235,418,123,240,229,250,236,327,452,438,430,297,312,383,330,62,217,244,263,543
+U67733_at,-182,-210,70,-131,-92,-39,13,-22,-188,-158,-204,-86,-171,-70,-126,-139,76,-192,-220,-236,-8,249,-290,-212,-133,-88,-34,-381,-226,-200,-172,-194,-17,-215,95,-92,-261,173
+U67784_at,81,1,-68,-33,-10,96,73,-11,20,8,-77,50,266,72,18,-3,-16,-34,-23,0,74,45,58,-11,36,-15,-34,-20,-91,-44,57,-71,12,-29,9,49,-32,42
+U67849_at,508,-486,-341,-726,208,-476,-564,-709,-359,39,140,-277,-152,36,-273,9,-27,-266,75,15,219,32,-313,-144,-233,-246,-1186,-551,-319,-481,-509,-225,-343,-259,-778,-650,94,-524
+U67934_at,337,1,159,17,190,218,45,-220,326,327,230,113,119,186,170,163,278,187,15,330,274,-51,159,225,101,146,125,176,-52,241,51,70,98,213,138,219,91,321
+U67963_at,555,1063,921,348,589,277,509,490,553,609,600,273,576,1016,548,451,1238,1043,345,718,357,568,281,668,510,402,832,1255,880,1863,1260,644,1372,733,2184,783,2100,1571
+U67988_at,-14,-146,-21,-87,-38,-40,-38,-14,-4,21,-77,-30,71,-48,14,-37,-224,-53,13,-84,24,-112,-102,-31,83,-65,-21,-105,-50,-55,-53,-75,-133,-71,-90,-53,-4,4
+U68018_at,392,323,555,170,415,272,40,481,422,324,84,166,750,377,357,380,421,201,296,797,376,291,125,152,302,139,211,241,141,143,175,19,279,126,290,231,463,383
+U68019_at,-188,-62,-465,-203,73,-309,-168,-143,-253,-265,-149,340,122,-212,-142,-10,-308,-80,147,-304,279,431,-208,104,167,405,-312,-220,-240,-14,817,-237,400,387,405,-270,-242,220
+U68030_at,-6,-22,-84,-91,-25,10,-35,-131,-96,-28,-61,-87,-12,-96,-64,-127,-147,-1,-19,-42,-56,-94,-18,-106,-116,-25,-200,-30,-26,168,-103,-58,-87,-22,-91,-27,-94,-97
+U68031_at,-89,-31,-41,0,-17,16,-21,-116,-69,-25,-28,-21,-56,8,64,-60,38,-11,-30,-17,-14,-40,-28,-109,-80,-43,6,-18,-33,-35,-40,-116,-1,-11,33,-52,-45,-27
+U68063_at,1335,2020,1167,903,1985,837,940,952,1767,1026,586,613,1946,1317,1849,1534,2864,497,975,4178,2233,591,522,1941,1561,1046,438,630,379,240,738,747,498,628,811,834,1132,890
+U68111_at,89,138,69,36,123,76,43,14,59,115,58,60,78,40,204,71,130,66,64,258,128,109,49,53,14,132,-31,152,-45,64,135,36,178,86,36,69,180,107
+U68133_at,24,92,94,17,47,1,-8,19,16,0,66,45,-5,107,-14,-15,35,-27,-22,-12,-13,78,39,26,66,-18,-1,-6,64,51,53,109,119,13,-7,3,34,2
+U68142_at,834,463,593,439,823,298,880,947,509,201,230,422,873,505,887,959,930,137,474,1207,369,270,351,1217,1024,639,325,1858,536,371,369,291,211,219,446,572,935,604
+U68233_at,358,342,378,298,737,188,131,308,433,623,654,748,530,620,772,421,194,286,283,365,103,316,712,604,1203,415,398,265,411,-209,401,996,403,205,214,205,246,447
+U68385_at,-52,33,-33,-33,-31,-97,8,-125,-13,-20,-41,-43,0,-37,8,9,-36,-2,-47,-44,9,68,85,5,-7,1,-1,27,-110,-317,52,54,18,26,-4,31,-49,60
+U68485_at,1026,275,467,525,669,355,536,1048,697,475,518,635,1034,1296,618,961,86,878,448,1114,272,1552,803,687,398,1482,503,1106,300,253,815,-13,160,432,825,266,967,32
+U68488_at,-48,-27,-111,-26,50,90,15,40,117,126,-111,-18,43,2,39,11,105,85,25,-29,99,-57,197,75,-26,52,-78,74,129,-69,-89,-151,-36,85,-59,54,0,-71
+U68494_at,249,345,28,93,196,115,325,164,123,190,79,99,109,184,107,182,628,173,149,132,79,88,77,274,189,94,107,165,158,379,316,376,214,354,228,215,91,334
+U68536_at,150,84,90,-74,158,40,52,-104,-53,79,179,51,215,-38,217,76,258,72,98,130,71,71,110,167,38,23,-48,-1,93,86,57,8,39,29,91,2,193,122
+U68566_at,1699,806,1746,974,1360,979,749,799,1785,1123,650,666,1225,907,1354,1459,2044,1039,1198,3249,1205,453,602,1412,1052,1677,322,891,1029,618,191,668,1072,500,752,731,680,906
+U68723_at,710,563,683,358,376,410,58,620,592,135,659,110,555,491,625,205,590,499,287,872,-31,357,528,401,167,228,-142,218,-48,426,-3,-18,320,282,85,368,827,269
+U68727_at,-6,-44,69,-24,38,7,18,-67,-22,-24,3,54,-20,-16,0,-36,8,-32,47,-20,-44,6,-53,-11,12,-16,-7,-45,50,-26,-25,-33,-30,-29,-10,27,23,-13
+U69108_at,-12,20,-35,62,43,-5,-3,64,24,-6,27,14,6,123,25,27,16,35,9,63,-46,-15,123,3,54,17,-45,-63,26,-3,23,29,155,-14,-37,45,80,-1
+U69127_at,130,80,36,69,151,23,25,2,103,85,127,15,161,67,42,131,153,55,114,273,78,102,24,149,10,104,29,59,-40,31,-3,4,65,63,31,-7,54,58
+U69141_at,471,253,391,188,280,250,446,286,436,330,195,179,361,281,487,300,482,207,327,788,181,112,256,408,198,277,109,495,214,172,216,314,158,129,243,287,274,127
+U69263_at,158,185,195,135,0,40,144,160,49,12,224,58,87,141,42,95,216,104,47,33,88,115,218,226,155,207,237,241,125,131,145,143,98,-19,237,177,250,259
+U69546_at,1050,1516,1073,565,1130,428,552,376,978,211,1377,211,1021,2363,1399,503,1233,268,638,928,1175,427,264,1374,517,682,147,1007,913,851,255,553,636,736,929,575,1205,576
+U69645_at,586,341,929,181,414,430,406,467,1002,380,384,126,620,412,494,634,601,343,348,1237,222,425,397,545,359,380,424,496,442,428,384,320,333,43,477,286,704,565
+U69961_at,-159,-43,-217,-160,-42,-179,-109,-235,-136,-55,-69,-44,-39,-22,-45,-54,-166,-30,-79,-16,-208,-102,-121,-6,-78,-27,-35,-57,-103,-107,-123,-143,-126,-3,-3,-236,-174,-235
+U70063_at,-50,171,84,136,257,81,67,173,-17,-16,95,89,21,106,118,121,154,26,48,350,141,-23,72,45,41,-35,76,263,315,741,137,119,108,227,913,-52,678,313
+U70136_at,59,122,80,60,32,19,62,52,-15,43,-51,-4,15,111,35,18,47,10,66,17,24,71,117,31,65,59,154,61,69,82,1,36,55,47,200,6,9,89
+U70321_at,1524,1118,1540,490,539,1010,949,869,998,1131,773,495,576,1027,626,1739,1692,1021,1452,1052,222,878,834,713,913,1529,1846,1238,1519,1160,695,961,1245,611,1730,1026,1691,1392
+U70322_at,469,255,529,381,540,193,287,383,259,291,464,214,527,300,584,451,414,313,390,1293,253,343,379,754,230,471,225,339,163,380,85,395,292,175,253,283,500,347
+U70323_at,740,501,599,824,590,625,685,947,535,272,442,290,423,703,689,529,1021,327,299,916,211,221,246,821,38,400,690,755,581,354,382,272,441,321,486,472,1001,442
+U70370_at,-179,-204,-304,-392,143,-337,-341,-727,-395,-170,-169,-245,-95,-135,-211,-223,-901,-59,-85,-501,-139,-187,-442,-457,-158,-332,-353,-310,-233,-318,-346,-317,-97,-141,-238,-405,-426,-226
+U70426_at,662,422,817,503,656,506,929,709,453,465,252,936,287,573,442,378,712,587,282,859,414,391,417,464,652,502,909,463,577,-17,682,842,601,282,330,279,419,862
+U70451_at,1537,1144,1118,772,1128,723,1102,1320,1299,521,999,415,900,1017,1534,1003,1675,384,477,2308,614,838,412,1364,535,730,951,609,726,1508,1327,919,-166,526,1160,966,1057,2512
+U70660_at,379,395,222,412,782,490,312,221,822,321,469,178,396,519,598,605,828,271,323,1114,313,65,153,348,254,327,510,514,86,523,481,329,488,424,1124,729,330,182
+U70663_at,-670,-266,-696,-603,-72,-570,-598,-635,-857,-88,-588,-114,-157,-435,-164,-179,-960,-336,-295,-249,-53,108,-552,-221,-483,-241,-611,-354,-480,946,274,-613,173,-267,967,-578,723,-385
+U70671_at,1145,1279,1033,670,964,1088,930,767,1489,1426,1759,613,1364,665,1439,920,1966,1128,885,1923,2377,485,1084,1164,1105,1431,880,1502,1122,343,1518,2366,1555,720,891,1122,1339,1413
+U70732_rna1_at,-148,178,-184,-355,297,487,-161,-281,277,165,275,-28,23,131,33,-87,327,220,-275,-323,-219,-198,-214,-71,7,-33,-325,154,158,915,-726,-569,6,174,19,196,145,-289
+U70735_at,1272,1294,1427,1132,1391,969,984,1160,1516,1305,1046,620,912,1129,1369,1076,2070,855,990,1899,443,579,1229,915,1164,1227,1060,862,649,62,1066,941,1136,588,1349,1073,1220,863
+U70862_at,98,17,69,52,37,-5,63,136,122,-3,36,-21,11,11,65,67,133,54,0,81,21,39,51,72,85,10,32,37,67,38,47,82,82,-1,52,88,25,73
+U70867_at,760,217,348,139,190,414,304,602,349,268,551,284,170,324,224,607,614,252,546,126,347,175,752,1038,304,269,145,883,839,760,313,745,790,194,652,689,292,902
+U70981_at,-61,23,35,37,-34,-30,5,10,2,-73,-17,-30,-32,-40,-6,4,-45,2,-24,-32,31,1,-70,-4,-9,-50,-57,-53,-62,-37,-9,21,-75,-63,-15,-60,12,-5
+U70987_at,-471,-250,-471,-250,-115,-339,-151,-623,-210,-146,-215,-204,-30,-224,0,-240,135,252,-147,-88,-178,-206,-300,-225,-257,-116,-203,-150,-197,-275,-345,-483,43,77,-455,-368,-367,-206
+U71087_at,209,131,236,46,143,129,176,158,141,8,125,5,166,70,80,135,102,76,115,258,112,133,159,216,112,114,48,60,64,88,125,175,120,-9,167,70,77,32
+U71088_at,566,442,647,348,367,424,478,523,394,351,414,308,381,312,296,507,552,235,287,528,102,371,389,414,337,490,486,495,428,482,420,472,472,189,300,320,455,669
+U71092_at,-542,-446,-594,-379,-196,-368,-473,-748,-517,-291,-335,-350,-174,-425,-225,-251,-860,-121,-185,-341,-139,-323,-588,-269,-176,-305,-669,-523,-348,-306,-493,-483,-312,-171,-382,-320,-409,-783
+U71207_at,50,-81,-114,-47,-20,-129,-43,7,17,13,3,-58,-41,-116,15,-2,-113,-11,-67,-2,0,-6,-51,67,14,28,20,-60,4,-17,59,51,20,69,-41,-52,-39,42
+U71300_at,113,47,180,140,127,67,129,88,61,59,44,53,101,89,121,169,170,95,84,130,48,39,18,227,99,48,23,91,110,55,75,135,62,49,56,44,96,86
+U71364_at,-114,84,-609,-539,-624,-1,-739,-197,-450,-448,6,-41,312,-173,-603,-68,873,121,-56,-827,-446,-481,-1183,-380,-548,-533,-186,-698,-711,486,-484,-764,-388,-438,289,-1100,-1043,-455
+U71374_at,168,157,232,164,165,120,99,100,105,3,165,79,164,207,202,220,225,90,24,50,47,155,30,137,70,126,125,119,38,117,35,121,155,95,210,113,193,159
+U71598_at,-11,219,90,61,-65,24,20,62,98,14,-68,60,325,125,66,16,72,100,32,295,614,102,182,87,117,36,-67,199,64,83,178,233,79,165,15,132,298,307
+U71601_at,231,147,147,223,178,60,225,164,187,64,86,22,162,143,126,167,251,192,110,190,66,79,264,137,161,133,189,145,153,116,167,143,206,95,125,96,184,174
+U72066_at,839,798,1352,1058,819,801,830,1046,1321,804,744,357,1183,973,1083,869,1304,623,824,1021,647,551,457,1004,396,467,993,635,543,802,899,589,844,556,702,592,759,890
+U72206_at,2098,1632,2217,2349,1567,2162,2471,3584,1635,1601,1225,569,1680,1519,1564,1573,2943,1216,1433,1926,559,1327,1134,2033,1134,1139,2220,2100,1745,2081,1586,1422,1674,536,2252,1852,2103,2501
+U72209_at,278,232,407,268,148,200,149,233,177,200,186,113,120,242,266,199,18,220,112,279,421,187,189,185,129,260,123,130,117,246,261,256,125,166,228,95,152,565
+U72342_at,978,324,855,369,653,449,638,361,576,99,686,-2,1354,901,905,909,1024,171,493,1224,353,128,136,740,-59,295,220,4,117,259,-83,-1,32,173,118,-54,249,380
+U72507_at,-65,-19,441,79,-9,-46,-114,64,115,28,184,-37,70,-75,13,52,56,66,-144,307,239,77,83,153,-39,95,740,-114,79,65,-136,56,-74,-106,-176,-175,-13,-100
+U72508_at,416,356,707,399,307,407,452,358,501,422,458,296,165,341,384,502,902,307,219,491,244,234,495,418,335,371,569,403,358,92,382,399,445,340,454,374,513,621
+U72511_at,1972,2435,1862,2152,4466,2126,1490,1928,4574,2246,2591,1667,1342,2970,4050,2005,2887,1717,1403,5540,169,1197,1932,2895,1957,1763,1455,2100,1779,1254,2356,2288,2685,2640,3207,2775,2241,1477
+U72512_at,1898,1835,2104,1530,1646,1612,1970,1835,2039,2026,1571,1021,1376,1718,1248,1909,1953,1712,1359,1537,550,1517,1284,1192,1711,1650,2494,2211,1226,1775,1636,2427,2058,1014,1758,1876,2151,2721
+U72514_at,-42,27,-50,15,440,10,30,-353,222,54,-80,8,94,143,124,43,248,-91,90,521,36,-49,-121,-20,83,147,-28,-234,14,-76,-32,-214,-82,74,5,-26,-66,-322
+U72515_at,46,-193,86,-434,263,-403,-297,305,146,18,-17,-175,325,229,105,210,417,-225,24,468,-221,22,-254,493,42,228,-1196,95,290,310,732,252,381,293,287,-19,69,-216
+U72517_at,1728,1319,1943,1894,893,1589,2338,2397,2014,1658,1416,737,1321,1565,800,1837,3299,1533,1003,1797,996,912,1320,1430,915,1581,2501,2116,1514,1583,1537,1857,2086,411,1234,1769,1682,2297
+U72621_at,39,151,83,28,46,-64,13,85,50,39,24,31,50,255,74,32,568,17,32,22,31,7,74,54,47,0,195,170,175,620,60,87,129,133,84,88,169,112
+U72661_at,-436,247,-230,-302,-92,-280,-534,-172,-233,-96,-33,373,70,91,-45,-106,-442,-163,-2,70,-67,608,-343,-96,-71,49,-392,-170,-86,1508,3539,20,543,169,2972,9,-123,1749
+U72671_at,68,38,-88,-44,-43,14,-13,40,-1,-10,-69,20,-62,-85,-40,0,-49,8,14,-7,-42,-35,-91,-13,23,-11,-89,-127,-7,7,57,-25,-23,23,-43,-19,75,-108
+U72761_at,38,175,210,27,477,280,198,287,579,420,569,204,273,190,530,252,696,231,129,382,-9,13,235,237,-104,69,-57,213,96,301,215,417,191,207,177,499,121,477
+U73167_cds3_at,-387,-326,-380,-80,-160,-359,-151,-265,-228,-164,-493,-73,-274,-452,-300,-353,-482,-175,-99,-365,-448,-290,-590,-366,-157,-245,-364,-61,-574,-263,-329,-227,-464,-97,-169,-53,-573,-696
+U73167_cds4_at,-363,-352,-508,-262,-168,-410,-527,-517,-288,-264,-284,-117,-196,-223,-137,-46,-601,-216,-179,-251,-192,-150,-205,-172,-245,-148,-467,-69,-257,-309,-250,-449,-354,-59,-301,-243,-334,-508
+U73167_cds5_at,-4,237,554,50,1004,188,6,574,642,-10,393,44,450,385,586,608,1079,47,317,1231,172,-134,146,443,110,588,9,42,-173,57,1,535,124,299,-459,2,-80,-169
+U73167_cds7_at,174,34,287,68,-35,129,236,241,160,56,96,-41,-37,12,34,63,178,30,118,-80,-7,17,91,183,151,-2,81,171,52,109,113,222,0,34,-40,134,160,224
+U73191_at,17,32,130,5,56,16,68,128,84,-6,56,-14,-11,119,26,63,125,91,30,89,33,2,51,1,58,106,34,-48,31,77,4,62,71,-23,-117,190,110,49
+U73304_rna1_at,-35,-63,-33,7,-20,-101,11,172,-14,-24,-6,-45,-19,-41,23,-31,2,9,4,146,34,-53,-72,9,35,-18,76,-54,-26,-19,23,-58,-27,-11,-5,-13,-27,-78
+U73328_at,458,235,450,799,284,629,843,1127,669,698,244,390,165,149,227,261,879,115,555,603,24,355,790,266,178,212,782,439,471,718,643,386,669,302,842,1035,861,1478
+U73330_at,-19,14,-46,-34,6,23,-38,-55,8,-43,-37,18,-31,-12,-9,18,-87,1,-27,-47,-32,34,0,-9,-6,-19,-61,-9,-55,-7,-10,33,-52,2,-33,-1,3,-12
+U73338_at,143,123,174,155,151,19,124,77,206,62,74,106,105,160,56,53,171,36,41,136,104,13,70,100,60,67,40,134,24,159,87,83,49,-19,44,105,134,135
+U73377_at,114,72,-85,67,261,104,99,163,211,44,419,-24,284,77,333,221,201,-80,99,633,9,300,18,153,76,357,-148,146,-72,469,466,441,215,266,391,159,369,42
+U73379_at,1630,798,2108,3025,1721,1561,2115,1433,2376,2372,2773,632,1539,1649,2672,877,1591,2030,1019,1123,578,682,2591,1310,853,889,1182,1026,2260,2725,2085,1770,1685,781,892,1406,925,1707
+U73499_at,-248,-260,-351,-211,-77,-142,-204,-290,-321,-94,-185,-143,-89,-75,-214,40,-84,23,-119,-49,-48,7,-273,109,-186,162,-244,-41,-177,-294,-341,-51,0,-43,-137,-239,-150,-144
+U73514_at,-1862,12,-1772,-1819,226,-76,-252,-1955,-643,-1120,-1136,-314,269,-207,175,11,-1055,-349,-1337,-51,-595,-521,-106,-580,-233,-195,-1148,-2242,-617,-1582,-1936,-664,-1573,-199,-1641,-915,-1955,-2384
+U73524_at,228,119,124,79,204,115,100,305,173,154,174,34,139,131,202,158,191,166,133,255,252,218,85,165,44,149,100,167,238,271,102,252,125,199,119,92,218,207
+U73682_at,77,145,149,171,195,113,126,155,83,71,115,66,234,75,146,81,251,60,73,264,407,-10,47,373,77,43,4,110,45,136,58,82,112,47,124,109,162,222
+U73704_at,18,-6,37,139,44,-12,18,55,32,-36,-12,-43,136,-6,13,22,20,-21,-28,112,-53,43,81,19,36,16,31,12,43,23,36,36,172,-31,2,27,52,25
+U73737_at,258,219,230,477,676,62,453,454,192,172,282,76,739,288,910,167,236,258,326,1306,1203,107,87,1322,86,243,342,64,72,73,133,162,147,109,99,56,141,123
+U73799_at,77,-60,1853,-100,188,-275,-546,-1587,-12,-79,43,-183,-22,-355,-100,32,-1477,-268,71,-817,-221,-60,-153,100,-104,125,-848,-614,-170,228,-243,-65,52,-3,-486,-368,-154,180
+U73824_at,3528,6372,5192,1848,4983,2242,2175,4850,5730,1704,4853,924,2794,2008,3969,2416,4805,877,1020,7916,2738,1838,2013,2441,1531,1717,2048,3144,1914,3061,2870,3449,2971,1942,3899,3086,4074,2737
+U73843_at,36,127,-39,376,-1,432,45,-355,459,266,324,209,-189,178,209,-132,44,195,-132,-171,252,228,-250,323,36,21,264,-164,64,28,-288,34,21,-6,214,-1051,209,142
+U73960_at,-102,162,204,204,263,17,112,221,-107,73,35,126,34,78,-9,83,275,103,32,251,39,32,-34,97,-16,-19,342,178,189,328,255,233,665,564,1723,231,176,376
+U74612_at,-109,-100,-68,-52,55,49,-141,-257,407,318,415,-110,306,-282,14,-193,-196,-29,46,-123,97,-156,239,-67,-66,-13,-215,-434,-266,319,-72,-116,50,142,-97,-39,-284,-292
+U74667_at,443,437,63,916,305,704,294,-262,212,381,764,45,-306,297,103,928,-475,165,298,760,-186,221,402,5,421,180,710,-20,40,355,854,376,687,313,50,563,831,329
+U75308_at,110,-27,-31,96,95,81,10,88,158,-41,-4,-28,121,164,126,127,-66,-39,42,250,89,-77,55,117,20,1,-39,-70,31,27,-33,-54,-12,-39,8,5,38,-118
+U75362_at,586,266,518,489,428,220,152,614,406,-6,268,234,274,318,501,175,284,264,302,368,226,252,264,492,287,334,208,297,286,-46,294,387,475,202,106,221,328,485
+U75370_at,111,788,-51,166,430,389,68,-148,738,-4,360,-47,568,427,384,374,852,0,234,749,114,-95,159,508,156,342,-140,112,175,37,-52,20,228,-62,-44,294,-177,322
+U75679_at,462,440,457,307,707,117,235,208,651,309,474,313,792,434,652,214,818,389,380,749,703,281,296,693,561,266,281,248,259,288,246,541,569,348,292,340,196,265
+U75968_at,1497,595,2095,800,580,1198,719,833,1173,1851,792,267,860,1307,733,810,2506,856,1137,1291,216,323,1193,825,898,1151,1470,1260,577,784,971,1060,979,432,841,548,510,1402
+U76010_at,1182,828,1628,1023,875,254,1297,1203,577,849,855,392,762,652,655,664,2175,744,699,1078,183,873,925,815,892,1084,1420,964,752,838,972,1217,929,118,578,995,1103,1275
+U76189_at,-41,146,209,15,98,32,30,89,181,54,-29,0,-60,295,11,69,144,-38,39,103,154,-87,34,107,-7,-8,125,53,100,-94,-53,-42,-26,2,38,24,80,-146
+U76272_at,329,737,18,94,26,62,36,454,82,25,212,34,284,110,-58,410,150,2,221,377,63,108,-7,-71,156,355,84,-13,31,39,200,124,1,-14,73,94,44,272
+U76369_at,69,-36,-87,-6,58,-94,-87,-131,-68,-43,98,-56,177,57,-12,-242,-282,112,178,153,111,-117,222,-27,87,80,95,37,199,220,-226,83,-56,-77,-164,-62,185,224
+U76421_at,-118,-37,-59,6,-31,-39,-73,-62,-24,-43,-23,-71,-28,208,-9,-5,33,17,-32,-64,2026,73,34,-89,-87,-67,394,-65,26,-49,-69,-28,-21,0,-22,-40,19,-119
+U76456_at,145,-12,52,-20,26,-113,-129,46,-72,-10,-7,21,-20,-25,-46,1,187,11,37,-9,-1,44,41,63,21,62,-65,215,-52,-93,-62,237,2,-14,-165,179,-26,202
+U76638_at,389,267,401,432,353,400,193,556,380,425,1104,159,313,397,651,243,334,292,139,515,513,192,421,643,93,263,51,182,199,318,312,127,172,166,145,119,263,232
+U76992_at,1242,919,924,383,660,577,354,436,1134,870,973,268,1150,663,583,588,1289,350,336,991,1105,363,402,875,367,495,395,548,271,570,481,699,558,478,590,519,747,499
+U77129_at,223,122,240,172,186,72,164,437,142,103,171,25,150,187,81,130,283,115,101,358,84,100,191,125,82,145,100,106,122,67,133,203,198,61,131,81,201,247
+U77180_at,-638,-151,-648,-306,-96,-480,-569,-710,-347,-269,-329,-182,-276,-192,-200,-286,-236,-302,-22,-152,-146,-230,-419,-249,-466,-209,-194,-414,-639,-456,-336,-210,-422,-170,-450,-534,-353,-518
+U77396_at,332,837,-687,53,224,-26,13,98,367,57,121,514,83,53,150,83,105,992,283,179,153,377,-37,-228,36,378,-184,511,283,1102,1573,314,1108,418,1996,125,1341,4224
+U77413_at,-149,93,26,212,606,353,329,88,-17,-35,-23,96,297,1048,373,549,603,38,137,646,11,-147,-43,274,99,-93,-372,791,141,122,130,412,219,94,356,224,74,-95
+U77456_at,461,833,350,326,960,291,411,241,994,456,426,-66,1089,1085,1408,447,1060,699,503,2105,-256,172,121,431,261,207,-334,39,113,263,292,1105,481,285,-31,-57,339,169
+U77594_at,-218,-278,-54,-165,-55,65,-92,-19,-210,-28,-97,-84,-53,-290,-53,-9,30,-98,-133,33,-154,-66,-229,-101,-75,-126,-228,-202,-341,-118,-141,-98,-121,-89,-225,70,-51,-48
+U77604_at,996,1071,1090,1618,1111,956,2028,1794,964,765,941,898,1057,1131,1459,802,535,647,1070,1346,1015,1016,1101,1296,989,678,1779,1201,1260,1964,1675,1350,1419,992,1444,1667,1952,2169
+U77643_at,86,-82,-242,95,-98,83,-107,-74,167,-22,12,63,-214,6,-43,-89,-192,-300,22,93,-34,-11,-226,31,54,86,190,-1,79,177,70,-97,112,6,-91,-53,-4,449
+U77664_at,75,106,143,152,176,92,179,35,135,152,123,57,168,208,135,57,335,89,69,139,59,24,-17,158,18,145,156,69,81,27,163,17,21,154,61,66,106,73
+U77665_at,255,127,330,279,382,263,157,188,394,321,283,77,315,263,341,246,412,205,139,549,213,159,157,221,196,184,225,154,201,172,248,261,239,206,148,211,240,186
+U77718_at,730,697,781,639,1146,693,836,931,668,630,1159,386,1398,702,1372,814,1559,365,797,3095,1256,451,480,1026,939,298,369,932,901,437,529,1143,1160,604,385,622,795,872
+U77735_at,322,850,110,115,116,81,-26,140,100,-82,3,612,75,356,348,283,695,1179,327,335,18,266,-15,79,2523,123,75,-106,-168,312,413,430,2182,30,21,7,391,1027
+U77827_at,524,477,656,587,454,490,515,598,585,427,385,300,325,490,302,588,760,717,390,557,354,380,383,431,454,416,519,499,473,662,691,623,605,351,534,527,567,767
+U77845_at,377,307,463,372,231,378,373,563,291,56,321,235,-55,266,263,65,71,282,85,274,334,255,39,-168,234,37,553,62,-45,392,382,441,402,178,240,338,226,372
+U77948_at,1114,1238,1176,1685,1502,691,1278,1545,1166,402,1044,257,1054,1220,2117,1571,2482,608,513,2628,916,757,693,2224,580,865,655,546,769,404,407,610,613,484,438,517,1232,190
+U77949_at,-97,-40,-106,-12,44,8,-146,-122,105,-76,178,-61,109,-77,91,-54,-121,-90,-41,-52,-39,-14,-1,52,-40,-98,-164,-127,-48,-46,-65,-87,44,-30,-97,-86,-149,-143
+U77968_at,4,708,159,333,69,597,282,-935,773,241,128,-63,-106,47,350,-444,364,190,-106,99,-32,-31,-15,-207,311,-65,237,22,110,89,559,882,141,516,79,37,656,887
+U77970_at,-442,-349,-494,-347,-131,-167,-455,-323,-416,-280,-258,-214,-178,-164,-234,-367,-342,-95,-168,-260,-68,-98,-235,-294,-278,-102,-373,-105,-247,-238,-453,-440,-332,-142,-453,79,-394,-433
+U77975_at,191,154,238,280,151,142,206,259,135,171,118,-175,100,113,64,151,47,156,136,78,119,167,72,155,140,148,322,165,76,49,208,172,189,133,188,124,116,246
+U78027_rna3_at,13706,9660,7706,8763,10422,4923,5719,6731,8414,8435,9052,9520,11960,9640,9607,10142,15678,7934,9497,16997,15947,5745,6182,10460,9695,12520,7815,10760,7360,6302,7653,8908,12202,13174,12700,6232,8089,10126
+U78027_rna4_at,1993,335,310,1068,1210,56,783,628,115,28,39,556,1126,144,1330,671,869,328,521,2026,143,207,43,1052,560,478,344,314,516,608,248,145,780,215,484,640,383,403
+U78095_at,935,1863,1074,1094,1436,531,1186,959,1288,1143,1597,574,1547,888,1177,1358,2124,1413,1671,2229,1023,1976,982,1267,1053,1443,1078,50,262,1048,452,1074,1277,1034,209,2315,3827,783
+U78107_at,212,303,386,310,114,177,161,244,161,198,385,123,140,30,92,229,324,140,116,274,29,211,252,93,224,136,292,228,91,289,385,522,232,147,371,170,278,342
+U78180_at,-195,-105,43,-233,-106,-10,-156,-355,-23,-28,-37,-112,-106,-233,-90,-190,-122,-59,-119,-289,-52,-146,-93,-200,-141,-253,-280,-354,-149,-306,-272,-48,-206,-185,-106,-344,-301,-250
+U78190_rna1_at,41,643,63,-579,4,49,-541,-245,277,333,-364,-413,213,-148,35,-22,211,156,215,310,223,201,-353,-225,-92,189,-597,-351,-254,103,-473,-178,-91,-187,-95,-277,103,-316
+U78313_at,121,-80,7,-133,-2,-19,-77,-101,-55,-9,-54,-79,207,-104,15,-11,48,38,207,-48,-16,-7,39,-28,-56,24,-82,-76,9,-73,-190,33,-26,-78,-98,-68,-58,-52
+U78521_at,2837,2241,4030,2553,2405,2580,2878,3643,3639,1782,2641,1388,2462,2973,1909,2695,4631,2215,1817,5229,1196,1921,2445,2461,2193,2010,2825,1697,1902,2418,2522,2277,2293,676,1152,2295,2995,3382
+U78524_at,376,590,621,451,423,417,433,436,592,400,834,260,305,447,625,325,465,251,178,497,286,384,406,497,257,175,129,358,403,317,319,271,516,226,438,231,723,370
+U78525_at,533,782,847,719,1006,1175,1208,713,1676,760,926,438,1113,1333,1608,749,1442,485,584,3204,116,370,792,634,-5,1054,466,911,651,833,1382,1700,722,893,184,1489,1376,1228
+U78551_at,-685,-745,-1034,-1079,-270,-627,-715,-1077,-655,-428,-614,-481,-406,-725,-639,-496,-500,-343,-537,-651,-610,-410,-706,-517,-440,-592,-1060,-682,-853,-552,-818,-360,-494,-556,-903,-1043,-640,-376
+U78556_at,468,386,631,331,185,275,435,748,396,531,312,196,232,487,149,218,703,311,325,330,189,449,463,364,283,226,927,343,702,991,348,526,348,177,683,285,339,791
+U78575_at,713,400,853,716,651,553,861,1069,407,564,616,239,408,325,459,395,696,343,392,816,96,440,414,689,318,385,614,514,747,630,571,552,727,279,553,423,488,1304
+U78628_at,308,238,323,305,18,309,122,385,293,200,178,104,98,170,-31,168,85,70,138,-94,3,57,75,56,103,122,251,261,180,259,317,303,417,149,349,87,369,421
+U78678_at,1209,1531,1454,887,1260,1705,1915,1481,938,1655,1285,692,987,1000,900,1554,821,1026,1265,1660,747,1333,1542,1048,1085,1278,1353,1250,1151,1068,1891,1769,1374,999,1165,1475,2580,2304
+U78722_at,41,34,-109,122,78,24,102,157,16,61,17,45,83,75,79,52,212,10,57,48,118,79,39,79,58,84,153,103,149,35,24,126,116,29,94,111,99,104
+U78735_at,-10,0,127,-34,-21,101,-35,13,44,56,100,33,62,-1,-64,110,-57,72,268,-46,2,102,20,125,78,256,37,37,117,203,115,190,290,93,16,-2,164,402
+U78793_at,695,511,716,489,241,567,561,700,506,443,454,214,425,466,293,506,887,461,196,502,202,375,326,413,358,395,876,591,319,410,585,635,528,269,432,618,711,868
+U78798_at,540,153,339,309,261,392,591,526,271,317,235,206,320,127,184,579,837,105,118,435,87,251,210,221,452,369,112,578,298,521,354,552,540,135,268,350,741,245
+U78876_at,-404,-274,-544,-316,-87,-120,-562,-595,-520,-500,-160,-109,-327,-371,-209,-684,-1383,-498,-264,-799,-182,70,-370,-268,-281,-480,-547,-186,-319,-540,-561,-592,-396,-392,-347,-453,-325,-608
+U79241_at,422,-42,-37,-130,407,-76,99,-62,-152,124,-37,133,142,108,227,263,-138,-103,185,409,87,137,159,138,-41,346,-97,163,-93,-128,-115,99,-33,-125,-131,-176,-138,-239
+U79242_at,98,86,118,98,24,62,95,64,147,132,12,84,120,104,68,91,197,48,42,136,33,75,172,154,32,21,150,107,151,111,123,87,111,54,142,39,124,179
+U79245_at,-159,-117,-262,-258,-70,-140,-240,-368,-145,-128,-121,-142,-93,-130,-140,-118,-404,-161,-99,-151,-123,-126,-87,-152,-100,-144,-283,-185,-161,-178,-147,-148,-100,-135,-105,-256,-201,-286
+U79246_at,-19,-26,-29,-18,26,-37,-21,-55,10,-35,28,12,17,63,19,17,1,5,-3,48,48,-11,-43,60,-38,-31,-18,-13,-21,-20,-5,17,19,-27,-12,-9,-27,-62
+U79247_at,110,106,39,12,21,35,28,74,24,-26,-7,17,14,101,0,5,203,-3,117,69,-4,75,77,41,73,14,28,-29,156,33,75,168,80,19,105,-24,39,247
+U79248_at,108,45,-9,-18,101,33,53,-137,36,-14,82,-28,110,44,26,80,-33,0,65,104,64,11,195,75,10,31,-25,21,24,-53,6,41,77,-47,-36,92,76,76
+U79249_at,46,-24,-61,55,-9,-69,-18,20,0,-47,-72,-5,0,43,35,17,50,-9,-22,44,39,30,20,-1,-12,-4,20,10,14,-21,37,62,-21,-73,60,-5,-4,-5
+U79251_at,73,134,628,106,162,1,90,127,98,131,28,133,91,78,37,198,282,58,266,242,-13,184,55,-3,245,148,239,113,81,112,236,458,145,-22,209,100,169,452
+U79252_at,797,460,717,622,555,510,667,857,726,372,431,106,431,579,471,682,1009,286,439,851,264,521,581,551,438,258,560,611,415,604,589,742,849,86,539,392,772,993
+U79253_at,-482,138,-1,88,74,549,260,-140,388,241,258,-446,-298,130,289,-253,97,-267,-396,-500,-119,24,199,75,-326,-247,-204,205,69,104,204,174,162,-241,205,133,121,82
+U79254_at,554,482,464,554,1435,122,663,470,779,178,686,91,1358,894,1082,898,1905,174,640,2449,1881,461,353,1277,293,652,134,404,177,184,140,896,376,227,279,94,230,124
+U79255_at,428,-73,896,471,-241,-51,-482,121,-159,-51,51,165,-334,-508,183,-331,-364,-175,98,563,524,109,-119,-824,94,-129,-918,474,281,-495,-259,72,73,13,-109,1045,-1062,-580
+U79256_at,252,209,257,173,239,-103,13,238,349,195,264,-135,310,192,36,174,165,182,-150,22,63,398,62,125,134,143,86,-114,-72,312,163,50,216,0,179,173,181,253
+U79257_at,205,111,126,25,86,-16,62,172,132,84,126,4,132,138,59,89,250,81,92,188,32,138,37,40,66,62,100,135,36,119,69,153,50,75,143,45,148,215
+U79258_at,5,46,3,25,134,112,36,11,40,74,2,66,-11,96,51,70,60,23,36,79,131,92,-75,252,-9,110,240,-8,4,-1,-56,-72,43,6,81,66,-11,-30
+U79259_at,603,578,1292,831,419,691,1396,581,544,369,1155,508,76,522,605,683,350,570,512,547,788,1262,609,1052,703,801,727,480,336,431,382,684,724,230,147,506,735,818
+U79260_at,891,896,997,851,936,743,883,1317,835,634,568,422,778,1069,679,834,1587,722,851,1355,770,847,535,1155,528,854,1057,718,800,680,877,1474,941,271,956,810,1140,1298
+U79262_at,1013,690,1757,1011,899,946,1068,1397,1324,940,796,567,904,1071,1179,895,1194,743,590,1320,302,558,1035,1068,769,609,1018,696,817,754,927,957,796,364,813,885,781,1066
+U79263_at,137,95,184,39,153,32,38,-5,10,118,122,-2,70,52,95,87,164,59,37,148,31,68,64,139,59,37,-50,36,86,59,106,230,145,114,35,1,24,154
+U79265_at,237,533,479,198,259,-88,394,236,325,198,462,117,400,417,128,152,1083,243,238,362,159,256,-117,374,194,279,603,691,288,443,319,289,387,364,307,456,792,730
+U79266_at,618,401,942,387,521,625,707,460,906,885,965,214,327,508,551,474,493,452,314,513,519,388,1158,785,258,401,-62,762,1137,457,251,429,493,246,416,502,888,639
+U79267_at,119,273,167,37,148,119,33,91,189,129,194,10,492,105,270,169,202,34,79,493,273,61,72,274,51,175,87,192,96,143,115,109,55,241,342,129,209,71
+U79270_at,61,259,278,24,160,206,68,-14,238,199,245,68,242,248,163,88,288,99,93,515,660,6,180,67,78,38,73,94,0,37,69,25,96,158,71,34,168,28
+U79271_at,-75,-82,26,-77,-34,49,-136,97,62,-55,51,-56,59,-12,7,-110,-4,-53,-62,167,69,-65,-55,23,-163,43,-283,-68,-72,-197,-80,-129,-118,10,-204,-64,-21,-196
+U79272_at,68,76,112,-33,31,78,-35,-38,119,-13,-12,-27,91,21,78,4,-12,29,-7,200,42,6,1,67,16,192,-71,-2,24,-4,5,1,-31,65,59,48,29,174
+U79273_at,511,1664,523,592,1360,585,895,1311,466,287,227,776,1915,703,735,614,1081,137,556,3824,-141,324,250,1456,1144,804,436,2090,1171,767,607,867,898,175,2609,528,373,753
+U79274_at,618,363,485,663,829,410,547,754,501,243,230,445,653,766,1090,615,2200,516,336,1655,509,196,474,754,477,560,854,367,355,214,324,363,474,183,221,307,315,424
+U79275_at,465,410,567,417,381,394,598,523,556,413,401,415,284,370,159,457,622,357,364,220,353,423,429,447,310,343,179,739,437,258,718,654,581,282,347,546,866,986
+U79277_at,-14,-62,-2,-104,-80,-85,-136,-91,-15,-36,-52,21,133,-64,30,-25,-252,-53,-92,-51,-61,-7,30,-151,-111,29,-291,-68,-105,-88,-126,-126,-284,-39,-30,-68,-80,-337
+U79280_at,334,-59,198,207,-94,58,361,371,234,-42,52,135,-67,86,-106,-63,-33,-47,-30,-394,-7,129,231,263,16,-191,-100,167,399,182,144,216,157,-197,26,222,88,552
+U79282_at,47,109,209,118,118,71,84,97,214,85,96,81,1,173,123,174,184,99,30,244,139,61,96,209,66,27,40,86,105,87,55,72,107,26,75,104,98,111
+U79285_at,422,183,51,490,498,264,416,343,321,-70,247,40,711,124,543,172,402,102,138,1560,148,10,210,476,72,364,-64,91,60,-2,-70,-243,-14,-29,-88,-22,167,156
+U79286_at,-173,-94,-198,-182,-62,-145,-104,-220,-187,-166,-114,145,-107,-63,-18,-204,-283,-166,-191,-167,-133,-73,-176,-106,-130,-153,-236,-226,-189,-267,-185,-168,-175,-95,-265,-164,-142,-218
+U79287_at,755,1186,733,834,746,833,534,1069,1471,634,1409,418,892,443,1410,311,442,229,230,1686,11,340,723,917,561,649,6,384,418,261,218,540,445,416,384,664,737,176
+U79288_at,412,195,595,287,282,410,252,364,335,374,200,218,442,338,236,485,504,395,330,497,137,-64,191,458,175,382,237,473,466,286,387,216,437,130,66,292,460,539
+U79289_at,-11,0,49,20,106,74,36,106,165,33,17,20,-19,33,29,48,24,-19,34,190,14,-34,26,73,41,61,-40,50,31,29,1,-43,283,9,-24,5,22,-3
+U79290_at,51,26,82,15,62,23,8,-56,24,30,47,7,8,91,60,75,108,-33,-11,89,2,49,56,103,-14,32,31,-51,-26,-40,66,58,34,-21,-46,52,49,72
+U79291_at,180,186,330,165,500,133,184,241,414,62,311,40,439,283,419,342,477,161,169,811,263,69,98,324,135,130,136,66,52,19,77,157,89,102,97,137,235,95
+U79293_at,79,3,30,-83,1,104,-13,11,25,89,28,-12,-11,-35,1,-4,168,-8,-32,43,-17,-60,-68,2,4,-20,173,1,43,-13,-41,103,6,-90,50,-62,-16,60
+U79294_at,1175,1389,1535,1058,953,1066,1255,592,1236,1106,818,707,996,1555,1094,829,1575,818,721,1407,594,812,1312,978,1111,981,1258,1025,803,1334,1597,1343,1307,692,1694,974,1093,2405
+U79295_at,37,-48,394,99,-59,62,85,115,-102,-26,-8,117,53,-37,144,18,100,93,164,139,-2,108,112,7,63,55,106,10,60,-131,-7,51,153,91,-65,167,131,-14
+U79296_at,171,88,151,147,211,136,285,5,190,65,80,45,212,113,234,105,227,97,14,169,108,91,13,209,94,83,29,104,7,58,7,16,92,21,85,79,132,184
+U79297_at,383,280,197,155,277,101,149,113,359,103,270,25,459,406,321,219,558,115,116,588,97,142,98,433,107,149,168,207,180,73,128,67,75,102,312,107,56,133
+U79298_at,-144,-48,-26,-94,66,55,47,10,-72,49,21,24,50,-34,-17,-46,-40,-78,-71,-58,106,-88,123,-7,-71,-27,-20,21,-9,47,24,255,36,22,55,13,5,42
+U79299_at,-217,51,394,114,-34,-131,50,-88,-135,140,-168,-178,19,122,-64,42,-25,-104,73,211,-201,61,75,190,-233,181,-57,44,211,-128,-196,281,-152,46,-225,85,182,152
+U79300_at,-21,30,7,5,13,62,1,19,42,-9,-20,10,26,7,47,-39,-4,10,39,-1,-11,6,13,-17,43,4,82,-23,26,43,48,14,-57,6,37,-40,-7,-10
+U79301_at,-24,3,-37,33,-29,35,-67,-73,-5,-37,-50,28,-32,-34,-54,33,-35,11,9,21,-22,43,3,42,27,1,14,-68,-33,-41,47,32,-32,6,11,-58,-163,-66
+U79302_at,-121,-19,-110,-12,-132,-60,42,68,-137,-71,-83,41,-182,-55,-149,-170,67,-55,-6,-121,-123,52,-96,-133,-17,114,314,-99,-14,-174,57,-47,42,-130,266,137,-65,281
+U79303_at,1390,65,993,229,425,778,885,298,121,651,726,515,648,720,593,678,-160,290,440,-286,258,66,676,806,334,223,106,419,223,33,636,250,839,311,1185,756,931,76
+U79304_at,-23,-19,-117,15,-32,-28,-73,-10,-8,-36,-16,-61,-30,-21,-25,-22,-86,-30,-38,-40,-39,-13,-100,-21,-21,-33,-100,-18,-74,-70,-13,-28,0,-57,-60,-43,-11,-50
+U79526_at,3,28,58,20,-11,-5,-82,145,-29,22,1,14,-12,22,-37,110,117,-33,5,-143,97,-13,49,-26,53,-71,35,-45,-12,-69,151,118,-8,66,94,-99,-67,121
+U79716_at,382,241,521,199,183,181,225,589,381,164,267,172,161,277,221,271,553,224,141,253,204,221,153,241,243,9,478,310,293,299,354,441,287,177,114,287,330,449
+U79718_at,655,605,855,539,979,270,554,680,805,432,371,393,431,624,849,403,1042,495,418,1052,318,459,174,593,744,858,833,717,269,342,582,682,649,279,506,449,359,831
+U79725_at,437,496,733,581,199,218,406,430,520,425,138,229,130,204,227,477,2468,383,64,471,302,138,524,-30,312,285,915,284,548,264,71,144,466,177,520,511,463,584
+U79734_at,-290,-70,-204,-205,110,-23,-52,-428,-193,-132,-92,-51,-148,-117,-84,-148,-201,-62,-182,-112,-147,-126,-125,-156,-128,-196,-236,-25,-274,31,-9,-119,111,58,75,102,-111,230
+U79751_at,-157,-27,-141,-181,-21,-144,-161,-137,-96,-105,-73,-83,-68,-13,22,-98,-25,-78,-54,-2,-34,-122,-83,-66,-59,-109,-165,-177,-139,-124,-80,-64,-133,-27,-86,-103,-103,-105
+U80017_rna1_at,40,58,38,172,434,81,40,62,62,65,25,44,277,274,304,265,249,91,213,446,46,30,189,452,7,74,28,86,62,-21,17,183,38,37,26,23,33,69
+U80017_rna2_at,189,-5,257,-21,169,138,57,190,139,-4,52,-17,61,456,319,66,497,92,-57,292,63,35,1,38,64,33,65,195,129,117,37,-25,41,-54,-3,11,97,185
+U80017_rna3_at,249,209,499,273,646,330,206,320,408,486,659,192,554,564,536,399,793,271,426,986,436,204,239,778,219,329,350,436,226,397,303,379,551,404,409,500,560,539
+U80034_at,-355,-96,-423,-320,-150,-199,-473,-559,-148,-237,-295,-158,-139,-199,-154,-194,-617,-266,-342,-366,3,-248,-311,-174,-405,-115,-480,-264,-408,-74,-427,-664,-318,-242,-318,-133,-283,-508
+U80040_at,696,946,752,532,859,567,495,413,1197,678,718,396,531,677,1153,612,1476,453,360,1290,742,374,514,569,554,696,441,357,403,628,526,455,436,301,939,635,571,323
+U80073_at,547,408,552,135,488,247,436,685,417,269,804,206,501,402,534,390,756,237,286,815,-9,320,165,408,560,160,256,1209,271,910,612,960,596,275,808,568,741,938
+U80184_rna1_at,-194,-122,-493,-476,401,-161,-225,-1046,79,-536,-209,-150,83,12,363,-287,-1063,-281,-488,-268,-257,-346,-273,41,-75,-305,-868,-461,-105,-120,-508,-278,-666,-3,15,-487,-571,-642
+U80456_at,-270,-21,-309,-404,-165,-183,-283,-421,-130,-260,-193,-97,-214,-220,-35,-229,-94,15,-116,-92,-206,-266,-186,-256,-2,22,-100,-236,-329,-31,-179,-87,-92,-102,-120,-49,-105,-128
+U80457_at,109,28,759,603,63,-104,-667,746,90,431,576,-222,505,-115,447,617,803,258,68,578,183,479,108,309,207,645,436,-235,216,-75,-197,-271,-240,250,-260,-41,105,-358
+U80628_at,251,-106,41,-87,-26,-3,60,-56,-64,193,-50,-53,-20,4,-45,-2,264,0,53,-319,51,-58,-112,89,2,37,97,154,146,-45,-50,226,-6,-9,-19,-48,6,364
+U80669_at,528,491,-277,427,-62,430,431,413,368,-68,-274,251,-73,131,130,-86,77,-211,-193,21,-281,166,22,-79,212,-141,541,-193,-175,-270,500,265,-149,31,89,234,466,547
+U80811_at,11,-114,-253,-138,-49,-1,-206,-248,-148,-126,-76,-148,16,-118,-83,-42,-124,-121,-41,0,-21,-60,-136,-215,-78,-31,-272,-220,-168,65,-78,-50,16,38,-129,-184,-225,-314
+U81001_at,460,808,601,348,477,259,78,308,385,248,823,218,270,845,490,366,321,214,265,793,453,389,577,715,555,251,226,224,113,287,8,406,304,131,258,-124,491,371
+U81006_at,384,221,217,400,612,120,462,122,205,43,129,0,230,350,613,348,1601,99,206,903,0,115,96,619,47,41,109,239,180,445,217,214,97,191,418,117,358,89
+U81262_at,32,-21,-216,-55,-75,-117,-129,-161,-46,-76,-72,12,-43,-46,-53,-28,-156,-83,-68,67,-107,53,-58,-71,-61,-92,-70,-54,-163,-104,22,-56,-59,42,-77,-109,-93,-37
+U81375_at,502,584,774,675,281,734,514,1043,1184,612,363,162,658,266,237,427,864,359,443,378,289,398,516,415,567,305,452,576,952,749,734,406,818,303,668,358,473,1492
+U81523_at,195,119,116,-209,172,-407,-536,-328,-386,310,-201,-90,61,-159,78,23,255,-118,93,121,226,-75,-197,112,-54,68,255,202,-14,63,28,-28,80,134,177,-485,-196,273
+U81554_at,208,529,372,212,501,234,344,449,840,167,714,135,270,498,612,170,31,86,150,575,680,146,279,550,119,49,106,686,348,604,725,359,527,514,820,592,813,565
+U81556_at,1605,1059,1482,743,887,1248,954,1143,1896,1173,1577,251,1953,1584,1278,1330,2524,680,1606,4541,985,422,512,1272,325,1345,411,459,319,965,316,344,764,406,901,571,955,824
+U81599_at,287,305,390,423,155,332,272,470,398,136,368,396,118,294,286,209,552,251,232,301,149,185,186,276,427,179,522,266,290,425,421,520,464,201,359,236,272,748
+U81600_at,1050,389,1492,884,673,629,522,1623,814,692,903,-22,493,636,109,1037,1565,663,531,788,599,530,36,599,740,141,1234,1282,851,1084,559,1021,997,338,914,435,573,1224
+U81607_at,430,-52,30,44,-20,49,1,949,33,-25,278,214,212,-60,-43,251,-86,52,380,2529,341,422,96,-54,2,173,14,-44,2,15,-54,-79,21,0,39,-58,-37,814
+U81787_at,380,185,440,175,127,222,332,379,249,271,137,204,138,156,198,298,417,252,165,308,167,167,94,87,164,150,306,180,177,323,373,219,215,47,287,154,282,490
+U81802_at,509,827,645,682,601,496,685,947,859,336,969,117,409,603,752,639,1436,513,523,1020,178,306,680,779,500,685,375,535,302,819,916,946,541,251,598,555,691,921
+U81984_at,296,-202,175,-106,353,40,40,88,233,314,341,-178,292,58,20,371,363,347,217,96,383,138,-56,299,-47,181,-356,435,233,289,-321,158,291,158,-225,-278,-30,52
+U82010_rna1_at,855,655,780,764,543,801,732,1151,800,425,718,396,582,760,592,648,1456,847,346,1023,426,411,554,1078,565,616,823,669,697,643,586,510,707,257,547,621,662,751
+U82130_at,206,139,1,189,409,51,109,40,90,-2,62,-15,174,281,355,189,172,-46,98,502,304,128,-121,416,50,168,0,-1,-55,128,262,225,46,230,83,66,47,118
+U82169_at,362,374,586,316,199,172,285,773,406,207,307,136,156,148,122,258,187,156,75,210,174,308,264,181,401,363,143,333,670,572,255,604,445,325,40,252,217,873
+U82256_at,140,146,140,116,45,88,199,371,227,170,97,27,140,143,90,169,257,138,199,47,76,156,184,152,54,152,190,203,113,167,131,150,249,22,-31,37,269,296
+U82275_at,927,140,-140,534,385,-10,583,101,-107,60,-21,122,1311,-20,1017,909,310,114,360,459,497,669,-5,1070,776,1326,-143,123,33,1152,246,-28,119,74,595,86,436,20
+U82303_at,354,383,632,293,255,286,362,574,317,390,340,126,291,312,209,343,750,561,196,528,192,168,275,439,368,545,740,228,336,297,226,535,289,167,334,223,284,461
+U82306_at,-108,-76,-44,112,77,106,151,277,24,82,-54,172,-107,145,131,214,-208,67,159,-99,52,-68,112,-53,46,-14,-161,33,-28,44,300,249,-38,-43,42,14,-21,-38
+U82310_at,463,276,272,126,88,140,258,286,211,186,158,130,125,136,95,138,219,165,69,113,126,155,359,164,41,139,37,377,269,233,159,249,325,30,83,211,234,248
+U82311_at,1538,1275,2060,1173,850,1122,1567,2374,1800,1020,1110,629,949,1141,866,1317,2885,1123,829,1366,489,1243,1189,1317,1177,1237,1966,1564,1457,1801,1232,1605,1404,503,1740,1254,1675,2466
+U82313_at,-86,-68,-116,-93,-1,-110,-80,-86,-68,-26,-37,-44,-67,-55,12,38,-51,-10,-25,-57,34,-74,-22,-72,17,-8,-190,-113,-86,16,-81,-68,-73,-45,-4,-124,-156,-176
+U82319_at,101,123,38,141,84,122,53,44,112,43,134,43,31,123,67,72,172,83,7,29,39,45,-43,87,6,45,107,131,84,113,151,197,101,17,105,70,-15,230
+U82320_at,-525,-510,-697,-464,-286,-545,-646,-695,-575,-364,-397,-232,-293,-434,-245,-355,-726,-320,-351,-485,-209,-460,-535,-442,-388,-481,-718,-570,-476,-589,-587,-526,-495,-166,-540,-593,-635,-918
+U82321_at,-3,-29,-150,-121,43,-24,-137,-52,-111,-24,-2,-2,34,5,62,128,10,40,0,92,-36,-32,-81,-79,88,91,87,-12,-125,-117,-79,-75,-104,23,7,-56,-56,43
+U82468_at,-1728,-1410,-2001,-1375,-763,-1358,-2004,-2344,-1235,-1148,-1015,-856,-998,-1322,-865,-674,-1686,-374,-750,-1122,-794,-1183,-1388,-1333,-955,-974,-2595,-1262,-1024,-1584,-1577,-1654,-1617,-711,-1401,-2007,-1641,-2368
+U82532_at,114,25,33,-233,30,-135,-283,-271,-75,-108,66,-357,-89,117,41,22,42,-1,-7,-35,151,26,47,87,96,-89,-200,-218,-98,-65,-459,-19,-58,-91,-265,-164,136,-30
+U82535_at,364,-49,5,265,34,190,329,86,257,132,-32,64,75,-84,206,203,287,-15,24,-78,26,34,34,258,14,81,43,234,69,229,-421,-252,247,-221,109,209,-50,-162
+U82613_at,106,317,-25,319,20,229,255,626,-104,330,243,-252,-19,446,-131,458,438,76,267,418,356,-163,292,77,59,454,194,-171,-45,-56,179,440,-43,17,-40,223,-216,-604
+U82668_rna1_at,-11,-8,-55,-39,-21,-21,-20,43,-53,-16,-69,-11,-41,-30,-27,-14,-121,2,19,-78,-62,-58,-72,-80,-56,-74,-29,-9,-103,-27,-64,19,-34,-26,-1,-71,-39,-184
+U82671_cds2_at,228,167,15,314,84,206,663,631,10,84,-35,239,49,242,129,198,600,86,226,-60,-53,170,210,259,121,-76,472,213,276,723,221,5,71,85,413,672,59,-1
+U82759_at,393,118,667,410,119,147,735,248,258,409,306,15,87,188,99,67,-226,102,432,359,149,160,366,770,267,59,-187,652,262,618,805,673,822,1137,1050,1157,1083,1099
+U82818_at,135,-43,83,204,89,147,169,181,112,164,-6,107,60,41,50,157,-90,76,117,137,167,-24,117,94,-3,141,90,54,16,58,18,-25,12,-2,-103,69,91,83
+U82970_at,-381,-348,-544,-525,-33,-419,-522,-307,-62,-262,-417,-356,-228,-197,-197,-161,-856,-260,-291,-273,-176,-409,-265,-308,-460,-335,-654,-480,-605,-521,-455,-626,-442,-221,-496,-465,-499,-557
+U82987_at,-181,-101,-414,151,-396,42,-732,-337,13,111,287,-487,-128,-171,5,303,-558,321,-9,-596,342,-113,148,-200,-473,-191,-445,-154,-216,-221,269,566,-218,89,184,-320,-825,-417
+U83115_at,1028,477,701,331,443,526,399,356,1347,253,958,142,917,437,458,926,2424,214,400,1121,328,78,100,419,311,390,270,314,274,631,755,367,312,219,1145,278,281,373
+U83192_at,422,404,384,34,309,273,379,227,223,256,134,173,212,50,221,252,551,134,141,343,-126,163,214,243,336,219,564,207,96,445,301,255,337,190,305,341,435,634
+U83246_at,3347,2407,2031,3101,1719,1899,3058,3428,3070,378,2108,1457,2486,3028,3873,2490,2735,990,1941,5277,228,904,1269,2526,2290,1835,1700,2517,1267,1971,715,1523,1387,1178,752,2434,2113,1948
+U83303_cds2_at,-58,291,57,257,-56,56,-154,125,-282,206,103,117,194,7,-52,43,625,220,-97,227,173,-30,161,-63,116,166,571,-442,-339,-46,204,-102,-367,107,-256,36,278,415
+U83410_at,271,237,265,155,416,126,183,298,160,123,222,57,365,213,365,285,321,187,81,482,253,45,79,342,322,184,82,135,103,164,77,171,163,110,101,71,76,158
+U83411_at,-686,-403,-720,-968,-175,-481,-929,-854,-725,-247,-532,-385,-348,-527,-315,-474,-772,-256,-323,-841,-351,-683,-718,-381,-393,-313,-649,-774,-704,-340,-778,-529,-377,-618,-351,-725,-610,-1403
+U83461_at,205,140,234,137,101,48,208,278,176,101,96,87,159,154,34,205,399,95,39,163,16,88,108,194,130,168,161,240,182,328,241,111,211,169,167,142,155,193
+U83463_at,269,692,323,139,434,81,181,260,356,350,510,113,478,399,220,172,814,79,114,514,387,130,195,313,169,40,98,215,149,640,353,379,448,382,896,149,327,930
+U83600_at,-504,-580,212,-2,-178,-631,-614,82,-550,-350,-451,-474,44,-629,-56,-336,-926,-311,-396,-607,-147,-460,-39,-190,-401,-330,-730,-664,86,-646,-60,-752,-644,-315,-706,-750,-698,-1103
+U83601_at,-238,-135,-301,-170,-63,-304,-277,-431,-210,-113,-130,-188,-114,-192,-33,-133,-133,-7,55,-189,-101,-227,-178,-46,-138,-109,-197,-177,-134,-92,-283,-361,-198,-75,-242,-202,-155,-213
+U83843_at,603,598,1058,782,1633,668,693,493,1286,1080,886,379,830,736,1117,627,1184,390,515,1341,73,214,668,913,439,597,370,317,327,436,328,302,643,315,646,642,453,342
+U83908_at,5,-19,10,51,75,32,1,88,49,-6,44,11,88,103,84,53,315,84,110,127,-27,-5,17,73,51,-24,-48,43,2,33,79,140,157,137,56,28,63,15
+U84487_at,-174,-17,-123,-53,-87,-19,60,-125,-37,-44,-64,-17,-3,-55,28,-67,-370,52,14,-87,1,-40,-34,-19,6,-320,-20,-143,-100,-154,-83,-73,-103,-110,-131,-68,-72,-172
+U84540_at,33,-76,-27,-23,25,-53,-16,95,-55,-20,-68,-58,-13,12,-26,1,-79,-1,-37,110,-44,-70,-49,42,-39,-2,-37,-61,-28,-11,-34,-75,-61,5,-30,-23,-69,-24
+U84551_cds2_at,-260,-183,-233,-209,-66,-85,-189,-313,-220,-1,-103,-143,-48,-114,-129,-80,-63,-53,-6,19,-9,-160,-26,-116,-115,-84,-6,-62,28,-73,-10,-245,-133,5,-2,-125,-185,-178
+U84569_at,977,764,1548,953,896,931,1056,1085,1336,849,1115,605,1116,1766,863,1198,758,738,671,1210,598,625,989,1153,716,865,301,1085,1570,1708,841,1203,1243,959,568,1287,1437,1813
+U84573_at,-128,-24,-83,-33,-84,-28,-38,-119,-42,-80,-55,-34,-28,-19,-37,-23,-194,-43,18,-85,-38,-78,-72,-137,-70,-19,-78,52,-103,-23,-45,-4,-75,-3,-37,-22,-73,-8
+U84720_at,-108,290,-147,-245,417,44,13,-316,65,157,869,-149,420,158,679,223,32,5,291,1421,1123,35,264,234,86,-370,-555,-709,-146,303,279,769,65,402,17,-56,89,25
+U85193_at,444,303,493,269,267,320,287,440,319,345,243,218,267,324,246,356,340,239,205,330,223,230,330,264,160,273,472,232,377,309,226,330,347,157,277,277,298,396
+U85245_at,543,370,595,493,417,254,551,712,492,311,344,152,432,421,372,427,546,261,290,466,119,291,383,405,371,330,517,475,461,492,310,378,522,169,442,355,682,390
+U85265_at,126,103,184,49,9,96,159,232,191,84,117,43,74,0,46,57,-100,1,-19,-87,12,61,32,61,65,32,50,56,194,81,10,109,26,-15,-101,45,-27,150
+U85267_at,139,97,138,221,25,295,47,11,308,-16,73,86,-24,327,188,114,7,35,-38,11,43,130,334,207,192,9,6,48,-19,122,160,411,95,-87,93,-49,7,187
+U85430_at,182,190,294,217,228,211,126,112,179,97,97,83,192,455,364,105,184,62,48,188,129,170,243,547,82,118,158,201,64,140,59,99,121,53,222,45,120,142
+U85611_at,498,1691,2242,649,870,1475,1127,796,453,1944,814,505,547,767,1018,600,316,377,392,641,387,630,1183,854,533,633,470,1147,846,1668,559,1254,649,627,1306,703,905,726
+U85658_at,346,351,498,175,242,522,221,271,284,315,361,146,320,134,238,227,495,193,247,392,134,163,191,204,134,230,132,271,163,317,240,171,346,185,218,231,353,425
+U85707_at,-33,-16,-107,123,213,-126,404,-151,-56,-49,-71,37,-52,-37,223,-56,-96,-64,-40,-47,7,-26,-72,475,-55,-24,-97,69,-52,21,17,152,24,14,33,65,30,-73
+U85767_at,175,123,-12,233,10,-131,-146,-47,306,-97,103,27,-35,41,124,-124,-170,-4,103,302,-3,247,-47,-151,81,-27,114,297,596,1044,662,144,271,535,3686,-231,391,616
+U85943_at,211,42,138,211,149,192,223,-8,19,183,202,112,109,70,159,131,226,87,109,68,123,-30,226,10,237,-70,297,333,158,110,152,240,157,82,313,167,305,462
+U85946_at,323,235,414,231,364,216,206,296,257,161,190,73,301,241,237,259,522,252,176,292,26,130,146,252,181,114,220,125,134,122,238,247,263,89,225,136,292,419
+U85992_at,461,229,449,806,302,396,361,569,286,274,354,429,252,315,215,402,614,342,276,200,174,207,362,369,246,381,513,555,512,413,685,410,433,42,281,584,411,521
+U86070_at,627,880,727,548,459,304,517,571,464,543,787,304,403,549,496,507,778,589,419,465,331,316,613,455,394,384,470,251,694,785,410,665,414,374,652,444,506,1003
+U86136_at,119,101,86,261,193,-19,122,491,212,148,171,116,121,43,159,147,496,199,77,133,111,112,161,189,203,220,413,310,372,322,94,260,141,85,311,102,210,353
+U86214_at,91,42,-19,146,67,-48,179,-194,104,20,3,40,-52,57,-67,65,-7,169,-7,-12,-34,-26,186,-11,71,24,128,-18,55,-45,100,-2,157,69,43,40,155,118
+U86358_at,-174,-567,-891,-1455,-368,-1054,-1250,-1409,-704,-646,-541,-189,-519,-535,-70,-506,66,-619,-392,-739,-296,-686,-1139,-631,-325,-580,-1161,-834,-795,-691,-723,-749,-717,-424,-783,-1309,-740,-1031
+U86409_at,679,592,516,607,424,497,710,656,639,495,549,479,270,475,385,593,819,353,528,602,26,498,596,428,679,464,890,559,704,316,505,657,704,330,424,546,378,735
+U86529_at,1067,896,1261,1145,946,661,1024,1335,915,654,808,360,787,508,783,1039,1451,818,900,1455,543,818,824,909,1071,1096,1093,1022,1120,903,1253,1446,1072,1164,964,706,1111,1602
+U86602_at,364,523,653,629,1138,332,408,353,790,107,280,191,374,483,878,521,602,274,327,1622,554,145,180,523,131,523,358,498,391,343,236,214,462,169,139,337,268,126
+U86782_at,220,232,361,230,471,119,236,71,325,158,283,89,205,97,371,253,392,200,136,343,263,103,138,305,147,144,172,122,86,80,115,108,207,158,172,125,185,139
+U87223_at,186,214,268,236,102,184,162,325,281,256,170,71,250,130,80,113,-7,172,142,222,31,2,330,199,153,187,375,248,72,37,365,198,176,27,457,126,337,460
+U87269_at,-186,-158,-257,-230,-125,-140,-339,-595,-256,-201,-137,-251,-130,-239,-148,-137,-170,-157,-161,-22,-202,-328,-191,-263,-119,-93,-211,-298,-158,-183,-329,-66,-265,-230,-128,-190,-365,-415
+U87309_at,28,41,36,29,18,46,-30,-29,-12,-19,-17,-44,6,10,7,49,16,23,31,0,-16,-13,7,35,-21,-11,54,16,-86,2,26,-20,-6,-18,6,-37,-26,-49
+U87408_at,852,395,1137,581,483,394,715,775,589,520,484,319,521,444,432,697,579,492,492,693,485,453,569,501,440,704,859,680,444,646,520,750,557,222,233,576,852,1066
+U87459_at,840,652,903,741,517,618,704,803,666,628,625,388,519,515,455,643,654,472,540,643,281,313,687,502,525,565,790,573,536,654,765,642,789,467,476,647,972,996
+U87460_at,8,63,86,26,-29,-5,-48,70,73,-43,-5,-10,-8,18,3,24,6,26,2,31,11,-54,41,-122,-30,-26,57,42,-28,-49,-4,47,-1,-15,55,18,-23,4
+U87964_at,76,-169,27,-89,240,168,18,-238,62,183,140,-152,-60,27,-87,207,497,217,170,-413,7,307,393,18,370,267,50,105,211,22,193,276,282,-198,-73,189,13,402
+U87972_at,-332,224,376,-179,-147,46,357,551,412,-152,-50,68,-213,262,-155,-133,143,64,-282,-247,659,-128,34,263,-161,-221,262,-227,363,282,-308,-250,-212,10,-478,-23,-301,-392
+U88047_at,954,-65,268,607,337,359,433,526,534,198,349,168,228,730,302,295,352,788,312,270,84,175,286,453,215,371,378,451,317,789,362,1122,467,551,511,388,528,946
+U88629_at,166,327,617,474,260,240,536,292,467,171,389,149,330,420,325,393,180,418,491,235,162,411,214,236,289,177,145,656,718,650,515,551,666,163,266,219,563,612
+U88666_at,277,228,417,185,196,195,99,196,305,211,162,21,196,343,197,289,168,123,176,343,229,126,260,175,100,128,136,39,57,81,106,101,118,37,96,136,183,135
+U88667_at,921,49,-118,105,-101,35,265,535,108,-141,-44,-205,-162,233,-145,-56,-287,57,7,-269,-74,-202,-17,4,77,-334,-308,43,341,250,196,257,234,145,-335,-290,793,-190
+U88726_at,200,72,285,83,142,240,-8,229,106,78,89,67,78,40,108,99,95,85,71,79,9,113,72,145,80,31,71,186,16,174,112,93,214,47,121,128,310,122
+U88871_at,-64,-21,-75,-69,23,-48,15,-86,-31,-30,-38,-47,-21,-51,53,-4,-44,-16,16,48,67,9,-83,9,-43,-25,-89,-53,-67,-19,21,-12,-64,14,-18,-17,20,-29
+U88892_at,-348,-383,-294,-27,-332,60,-25,-370,-195,-182,-113,-71,-156,-149,-171,-520,-602,-254,-31,-364,-301,-87,-157,61,38,-230,-909,-360,250,-224,100,35,-312,-113,-687,-109,-148,-234
+U88964_at,3230,767,1457,1416,1562,1088,991,2230,1551,723,763,1179,746,607,2107,1704,793,1112,1880,4013,865,732,710,1307,2188,1357,632,270,562,476,1889,1004,969,547,488,580,890,3131
+U89012_at,-82,-32,-51,-22,-3,-74,30,44,12,-2,-13,1,-29,6,47,-38,-61,-10,-6,17,-138,-43,-13,5,20,-7,-48,111,2,52,-47,-8,-14,-13,3,-17,-58,-9
+U89278_at,1246,802,1206,828,685,1017,1097,1418,1356,880,839,691,975,1007,935,1101,1707,597,803,1845,382,775,957,988,708,1031,1134,813,673,1179,1370,1045,1208,825,844,969,970,1981
+U89326_at,-163,-170,-294,-290,-61,-232,-250,-305,-171,-62,-176,-129,-121,-105,-154,-37,-242,-135,-28,-163,-132,-73,-144,-91,-101,-87,-208,-64,-158,-177,-160,-190,-186,-54,-89,-221,-126,-107
+U89335_cds2_at,365,285,272,397,279,-222,319,553,372,194,204,244,224,325,200,303,476,230,276,352,131,349,210,354,288,213,233,338,358,359,326,490,361,213,357,408,344,478
+U89336_cds1_at,2545,2371,2120,1047,1378,1571,1156,1706,3046,1253,1448,878,1741,3058,1364,1948,3670,1440,1082,2775,447,980,1219,1625,1500,1925,708,1605,1036,2982,1373,1047,1516,887,2561,1896,1996,1327
+U89336_cds3_at,734,751,1043,522,423,602,863,961,837,559,509,304,526,601,352,756,1498,559,459,788,347,670,668,519,664,511,945,719,651,602,799,707,657,217,693,557,782,761
+U89336_cds4_at,1088,113,1123,471,959,462,648,2152,938,809,238,183,1757,650,1070,1409,2006,739,465,2486,56,1034,759,1289,860,519,1012,1342,1168,863,-328,847,977,-5,623,232,540,1026
+U89336_cds6_at,180,233,192,53,72,236,267,299,171,137,146,127,191,177,163,165,375,131,153,383,37,94,286,296,112,71,201,201,298,-4,269,735,289,102,62,35,322,123
+U89336_cds7_at,-86,-183,-217,-752,8,-533,-878,-290,-679,-30,-295,-441,-39,-47,-44,140,-242,-161,82,-101,-143,-96,0,342,-31,128,-472,-82,-783,-454,-33,313,198,147,-325,-387,-335,-961
+U89336_cds8_at,269,6,317,362,223,133,346,458,212,242,81,57,197,157,103,261,440,171,215,71,183,87,349,355,41,223,286,270,382,190,93,250,285,273,121,245,268,439
+U89355_at,359,191,-1,267,276,56,186,325,24,83,257,100,365,149,153,118,288,115,216,268,603,291,102,284,120,194,225,90,108,114,142,233,294,131,163,5,133,216
+U89505_at,925,604,1260,810,1186,592,924,1308,1144,507,1301,369,828,1069,1241,1247,1251,83,587,3880,197,615,1062,924,494,896,663,320,69,286,723,395,715,348,557,473,772,563
+U89606_at,-540,-320,-619,-440,-230,-343,-413,-419,-505,-187,-303,-176,-167,-333,-347,-269,-351,-124,-277,-399,-154,-298,-328,-401,-315,-119,-328,-532,-543,131,-192,-419,-280,51,-107,-273,-360,-467
+U89717_at,-886,-643,-816,-799,-396,-282,-420,-1652,-887,-543,-537,-497,-274,-754,-367,-448,-491,-77,-146,-145,-391,-466,-744,-563,-611,-457,-963,-938,-964,-734,-834,-768,-680,-344,-1031,-381,-1088,-612
+U89896_at,616,568,670,576,416,396,415,890,580,228,631,237,386,850,458,378,713,180,277,823,31,593,359,568,552,347,219,290,461,519,241,132,575,58,549,453,707,564
+U89916_at,-6,30,119,-20,29,112,1,26,-40,9,76,-7,-7,15,11,24,55,-47,46,-18,102,54,98,85,-50,5,93,-45,19,1,16,32,45,31,-18,-68,-15,6
+U89942_at,64,-48,-10,36,-68,3,53,83,-106,-59,-64,-24,-38,-63,-68,8,87,10,-107,-34,22,-124,-68,-132,-31,-21,-139,-31,-50,106,-129,-94,-93,-130,-43,40,-69,29
+U89995_at,-64,35,33,-2,6,-16,-11,-91,17,65,13,-66,-21,19,-9,-38,-12,-8,1,-63,51,20,37,-14,9,42,-51,8,0,-79,78,96,46,34,-50,-28,9,41
+U90268_at,-38,-131,-70,-1,-76,-67,-171,-113,-23,-78,-125,-58,13,81,102,28,-119,43,-163,336,-68,-113,-150,35,-1,-65,-120,-173,-43,-105,-99,-145,-151,-90,-207,-121,-98,-1
+U90304_at,190,64,68,118,38,-96,173,98,216,228,53,-175,30,-88,22,102,33,54,137,20,144,78,100,101,72,-17,-173,62,-105,106,50,86,153,117,-166,35,75,-53
+U90306_at,377,428,466,346,81,464,536,598,152,449,292,278,287,429,146,398,496,212,293,344,227,53,370,246,70,126,613,324,435,232,447,544,23,71,438,753,630,679
+U90313_at,1112,2015,2293,1275,1171,1390,1211,967,1921,1247,1084,859,1155,949,1368,1271,2028,992,468,1414,1334,707,1160,997,843,880,830,1133,1676,1494,1692,850,1382,1649,1361,1510,1299,2273
+U90336_at,-560,-152,-789,-728,-83,-659,-710,-754,-156,-131,-200,-383,-114,-398,-186,-62,-45,91,-179,-71,-38,-358,-220,-222,-384,-346,-430,-454,-226,-232,-364,-118,-161,-185,-342,-807,-460,-393
+U90426_at,710,1308,1562,646,899,937,641,1049,1236,1680,2149,353,894,1197,992,758,870,371,722,1205,663,768,1278,1100,411,854,747,1547,1098,1745,688,644,1238,512,1935,822,988,713
+U90437_at,115,88,-1,166,10,37,30,5,111,20,28,1,3,37,-32,28,214,-22,10,157,-11,19,-1,80,63,90,42,-40,24,-61,119,70,23,-14,75,15,53,8
+U90544_at,15,21,-11,106,20,76,21,-71,22,-18,86,-14,-61,-44,-24,-39,-15,32,32,34,28,-22,11,-77,6,24,-15,35,-81,-148,13,-33,-40,-14,-14,-13,-91,-30
+U90547_at,1441,700,1234,822,355,745,747,734,572,350,203,314,860,338,1187,1021,577,129,416,1554,875,364,273,158,1930,1435,799,282,502,625,625,906,306,363,348,392,432,1129
+U90549_at,315,818,488,487,830,215,406,442,1505,1091,529,199,943,517,1486,491,1097,281,182,1944,842,163,186,419,258,65,168,-1,161,136,91,229,155,478,398,307,235,56
+U90550_at,868,609,994,913,471,673,704,1707,818,512,591,398,746,648,692,582,825,961,237,1141,467,659,778,710,454,1029,1591,958,896,610,671,642,771,559,471,905,942,1255
+U90551_at,718,169,374,317,673,60,774,64,175,214,20,379,949,202,530,1382,2144,-35,114,1576,264,43,119,766,449,500,198,465,-7,21,53,319,-29,235,854,75,298,-88
+U90651_at,254,54,197,293,309,172,169,226,224,186,214,30,292,301,488,261,533,706,173,449,409,121,233,314,98,196,162,102,110,226,165,253,100,198,133,112,77,284
+U90716_at,198,157,398,147,157,211,231,323,329,305,252,97,147,228,95,217,191,124,177,266,156,51,381,268,174,288,64,135,206,126,402,381,206,189,278,215,216,408
+U90878_at,812,541,1154,1697,1516,583,677,6784,606,465,456,1250,3701,822,2660,4453,1420,2133,1500,7079,1171,1758,676,1977,2025,2466,1999,1759,2219,1001,938,903,1742,1454,1628,1342,1047,1014
+U90902_at,0,30,-62,-54,-55,-1,-183,-214,-2,4,-43,41,338,161,43,36,162,16,20,-9,64,-53,18,-25,39,-25,62,-117,-168,-35,-28,-133,-83,-85,-100,-7,-121,-71
+U90904_at,367,499,371,460,565,332,210,101,322,65,489,183,508,506,903,442,776,528,217,1320,1164,502,224,474,304,312,363,88,-86,197,365,364,300,266,386,69,334,221
+U90905_at,133,30,61,149,65,80,114,77,63,50,71,107,102,94,81,136,123,81,71,80,49,78,60,96,99,65,70,126,84,116,114,105,62,115,125,49,86,106
+U90907_at,580,397,869,411,314,492,404,635,618,501,459,162,303,360,347,460,621,413,454,383,457,401,473,469,335,520,794,393,473,289,343,453,400,117,387,325,402,506
+U90908_at,-229,1,-287,-169,43,-279,-277,-668,-123,-33,-189,4,32,-159,-47,191,-302,-123,145,-19,43,-94,87,73,-44,105,-395,297,-72,-210,-330,-163,197,-67,-107,-99,308,-4
+U90909_at,800,1169,610,491,872,275,564,568,929,880,1252,349,1327,640,678,489,1123,524,606,1316,2062,1488,626,811,637,1036,633,610,428,965,714,1091,1081,668,1144,541,774,1907
+U90910_at,3,62,181,11,23,39,63,-89,2,106,24,58,35,-10,-10,86,29,64,18,138,-47,120,9,35,5,66,97,-16,81,-58,-6,-13,-40,-45,-19,32,47,71
+U90911_at,371,311,320,165,291,74,78,220,206,195,490,94,613,272,323,338,438,222,195,785,322,243,17,443,165,665,54,103,84,246,290,421,151,158,404,154,347,440
+U90912_at,140,241,207,157,80,110,109,86,254,93,198,107,304,314,76,251,347,59,161,353,178,96,77,93,62,76,140,107,100,63,136,78,108,55,31,48,118,193
+U90913_at,-218,-578,-439,-521,-59,14,-510,-899,-123,-253,-300,-369,-15,-627,-121,-456,-602,-295,-274,431,211,-482,-197,-77,-312,-283,-630,-429,-413,-603,-522,-703,-490,-468,-303,-221,-528,-1084
+U90914_at,40,43,188,-25,151,90,70,23,79,159,13,61,202,146,86,47,282,128,11,-26,83,0,51,-52,59,-13,39,-13,91,243,128,-19,21,166,284,95,47,24
+U90915_at,3970,5018,4859,4276,5157,3618,3537,3012,7358,4506,6179,2517,2997,4979,5713,4165,3893,3695,3454,9425,4026,3776,2469,4752,2928,3848,2530,3251,2327,6678,6217,4476,4270,4584,8758,3496,3975,4721
+U90916_at,53,836,189,280,454,90,532,161,95,88,121,56,482,585,672,357,2805,9,348,440,218,121,30,887,108,209,35,250,699,147,102,226,208,170,12,112,618,118
+U90918_at,65,112,130,58,73,7,236,124,153,150,71,54,48,143,92,60,367,13,81,50,14,159,24,293,106,-53,112,267,348,237,179,50,168,-33,231,77,156,781
+U90919_at,149,300,177,-10,192,-14,60,14,244,235,509,71,345,172,107,69,228,68,44,268,136,136,96,116,126,98,-48,176,117,201,341,296,323,259,401,60,146,477
+U91316_at,-289,183,469,-200,319,87,-243,-271,141,717,-8,37,223,112,364,-74,-21,190,79,-79,137,11,96,283,-65,179,-100,-108,-98,-64,-125,-152,19,-30,146,-105,-172,-328
+U91327_at,376,302,1268,214,1392,497,346,791,897,590,982,155,596,648,1066,583,645,294,590,1442,61,136,311,764,289,241,635,347,144,344,479,466,805,570,553,334,322,642
+U91521_at,7,10,65,-40,2,8,30,-59,2,-9,-39,2,-60,-6,-46,-42,-4,-9,22,46,21,18,-1,-53,46,5,87,-69,33,29,-23,-20,-39,19,-24,-19,16,-24
+U91616_at,-278,-271,-488,-158,-265,-302,-226,-443,-467,-60,-262,-136,-194,-576,-210,-437,-324,46,-266,-334,-132,-209,-288,-418,-277,-407,-42,-29,-399,-247,-159,-237,-51,-162,-71,-104,-249,-398
+U91618_at,5,2,85,-8,7,58,45,101,98,19,18,35,-35,6,-15,-66,28,-27,2,-36,11,6,58,13,-20,-74,70,61,-134,-77,21,14,20,-35,3,-92,-2,35
+U91903_at,-48,-8,-66,141,-33,152,99,50,16,-18,-31,64,-42,65,66,-68,-7,73,44,-58,-81,57,-5,176,14,373,118,-85,31,-132,-93,-20,-51,-70,14,-30,5,-54
+U91930_at,678,395,328,484,627,485,583,371,625,254,478,300,341,465,1112,465,937,591,422,948,692,269,170,848,337,584,125,385,175,598,353,542,467,422,394,171,648,151
+U91931_at,4,140,72,595,143,218,376,995,267,131,146,287,194,525,361,137,483,157,136,556,173,321,132,366,279,158,29,317,245,44,305,284,242,175,494,272,276,236
+U91932_at,896,692,620,808,1344,378,870,500,1174,882,781,563,1707,743,1348,1521,1064,852,1080,1534,1339,211,340,1143,397,988,528,739,351,1417,850,618,789,724,1659,799,449,1180
+U91985_at,-209,56,274,157,546,188,-21,209,74,49,207,47,270,394,488,223,421,172,14,687,17,-79,100,393,322,203,-298,294,113,4,-446,39,345,-45,-115,-19,39,-211
+U92014_at,530,747,228,383,311,163,257,395,261,433,318,159,611,252,494,455,810,154,240,876,981,486,319,725,634,403,131,354,262,456,419,826,823,286,714,146,221,521
+U92015_at,226,178,250,363,202,78,166,317,236,165,205,136,139,128,163,280,337,247,141,240,116,286,317,344,103,334,391,231,394,142,208,221,227,182,151,408,422,306
+U92436_at,345,442,677,528,360,145,283,403,566,353,603,139,385,202,474,602,1149,195,329,552,458,226,264,389,151,288,53,348,466,259,223,338,218,226,350,194,468,215
+U92458_at,-12,40,-7,-23,29,-35,-72,-7,2,-22,8,5,3,36,-35,-54,92,10,-44,66,-77,-24,-32,-20,-31,23,70,62,-57,-38,33,-29,26,-23,-3,-32,-46,-3
+U92459_at,-59,33,-41,-8,-65,12,-77,-35,-73,-43,-44,-74,-26,-19,-28,-83,-18,-29,-67,-20,-63,-28,-37,-27,-53,-35,7,-107,-180,-73,-63,-57,-137,-35,-96,-44,-56,-60
+U92971_at,434,-6,528,330,138,314,777,266,217,865,356,308,73,227,123,381,68,350,295,145,282,364,381,80,244,108,226,388,216,293,313,403,333,111,70,491,495,781
+U93049_at,299,605,2124,-320,-17,1964,-194,19,244,333,460,20,-103,870,20,-93,14,-124,-139,-98,-83,-180,1647,-134,-115,-223,-223,110,476,354,-55,16,-111,-67,42,75,16,-157
+U93091_at,-20,44,-27,58,49,35,75,32,23,7,-19,11,4,51,0,9,28,34,-38,48,8,-7,-37,63,-13,12,21,-1,-16,152,-6,76,-19,-5,17,23,33,1
+U93205_at,6722,5853,5489,5853,8056,3010,4385,1758,8972,5956,6589,3622,5120,5198,6254,5609,5751,2696,1144,6609,94,1853,2371,5507,2715,5490,1718,6080,1413,7011,6442,3528,6812,7556,9710,6195,6508,7870
+U93237_rna2_at,828,391,958,698,1001,752,840,965,964,462,550,195,593,1201,1226,698,1558,446,452,1510,291,193,790,909,476,689,910,557,459,516,436,468,669,210,577,578,786,547
+U93553_at,65,-87,5,-59,119,-87,28,-38,191,31,92,81,87,-17,66,99,67,72,83,41,16,-94,3,144,-19,22,23,-8,173,-99,-7,5,96,57,-56,-91,60,-38
+U93867_at,109,103,189,137,151,74,134,157,203,135,101,87,166,166,198,366,301,83,81,309,197,193,102,191,167,162,161,138,50,69,86,104,99,53,127,90,133,219
+U94319_at,687,1664,571,184,641,817,255,320,1607,985,374,153,1110,783,1135,913,1612,843,921,1522,976,159,765,580,311,348,204,270,250,339,305,388,660,351,328,383,962,279
+U94320_at,-51,-20,-138,-90,8,-17,72,-76,-39,-53,-116,11,33,5,37,-26,-45,1,-57,4,17,-31,-123,20,-44,21,-134,-71,0,-50,-131,-20,-20,-25,-29,-94,-13,27
+U94332_at,138,98,123,117,-12,74,104,116,48,105,25,20,59,76,21,95,134,40,32,35,-41,77,28,14,41,40,136,129,84,150,70,126,45,-17,80,56,96,143
+U94333_at,-308,-206,-761,-749,-71,-252,-645,-502,-461,-228,-182,-209,-216,-204,-161,-265,-382,-308,-241,-246,-509,-244,-296,-201,-223,-222,-472,-335,-673,-412,-591,-365,-516,-293,-107,-724,-752,-363
+U94585_at,1456,643,1187,1333,1139,780,1438,1656,1416,759,1059,398,1104,1176,1311,963,1300,788,580,1412,687,774,929,842,478,1109,1079,925,1226,995,722,1560,971,502,640,998,1208,1530
+U94586_at,1621,3419,3856,1607,2935,1678,1325,1323,2437,2648,4119,760,2416,3236,2353,2188,2591,1479,1230,5440,5695,1620,2093,2612,1134,1048,1275,1691,1748,2407,1559,1277,3192,3067,3218,2292,2837,1837
+U94592_at,3009,1112,4646,1145,2434,3166,1429,2001,2603,5052,1659,267,1097,5880,3638,2633,1590,1377,2323,4506,2522,1262,1151,1023,937,4536,1431,1349,1752,1617,3968,1741,1057,2350,4395,3073,4498,1563
+U94747_at,-116,-74,99,69,143,218,8,-340,49,-303,-145,-498,35,-167,222,-192,-1184,-141,-265,-267,-905,-142,-324,-427,-843,-644,-591,-71,-555,359,-305,-496,-72,402,-783,-39,-226,43
+U94831_at,523,263,395,124,472,392,278,-74,83,196,405,198,549,375,520,430,725,210,304,665,-4,119,36,623,314,102,-75,576,310,557,-194,-299,350,46,-52,638,358,473
+U94855_at,3785,3794,1425,2568,4749,2260,2369,2313,4941,2526,4713,2813,6266,2958,6025,3966,3056,3509,2210,8391,2947,2160,2110,3511,3656,3415,1948,2136,1281,1769,2801,2350,2346,2851,3302,2329,2582,2313
+U95006_at,-345,410,318,369,728,419,240,343,1169,436,592,336,1049,593,694,274,705,181,412,911,-161,-68,387,143,448,434,230,433,831,247,361,505,301,82,197,234,72,307
+U95020_at,-222,-520,-776,-461,-135,-467,-704,-1190,-574,-370,-366,-215,-281,-323,72,-312,-800,-199,-344,-423,-321,-252,-326,-298,-204,-270,-791,-305,-516,-515,-639,-690,-518,-290,-439,-425,-303,-685
+U95040_at,4220,4951,4689,3711,4150,5457,5282,4695,8667,3889,7221,1881,4691,3677,5916,3922,7612,3041,3901,7651,689,2556,5712,4744,2325,5673,4276,5340,3241,3600,2831,4978,5357,2600,2940,4260,4762,3726
+U95090_at,254,57,201,39,84,37,126,122,258,73,23,-45,158,-11,163,88,169,127,76,90,-33,77,112,117,49,242,136,277,156,85,32,181,192,5,92,41,131,283
+U95626_rna1_at,133,58,58,-135,42,-92,-273,-256,-36,-36,-108,-80,-47,58,-13,-87,47,35,-152,74,-51,-66,-210,47,-92,23,-107,-101,-252,-77,-160,-228,-74,-41,-5,-129,-134,19
+U95740_rna1_at,342,248,191,335,424,92,211,424,370,64,345,140,392,380,571,399,1057,52,126,1119,114,253,121,746,348,73,20,167,60,88,167,590,191,178,77,43,405,212
+U95740_rna2_at,14,-47,119,68,36,62,84,-73,49,-9,12,148,-49,31,-2,-40,18,62,28,79,645,87,-30,-27,50,-3,78,23,16,55,121,1,87,-13,38,43,107,-15
+U96094_at,353,41,50,-87,436,1,-48,109,318,183,334,241,211,400,394,360,-319,289,356,-243,-146,73,-592,433,499,349,-1278,435,449,414,365,590,650,282,-83,-120,239,645
+U96113_at,421,393,363,211,255,151,225,308,189,222,316,60,548,238,242,215,695,256,114,466,94,167,205,182,180,273,245,246,307,144,132,221,247,34,231,180,365,474
+U96114_at,420,221,465,295,293,384,386,545,228,321,289,241,291,266,326,564,481,277,339,507,204,244,383,366,305,358,445,421,435,450,331,357,399,155,445,268,432,379
+U96115_at,251,54,356,195,88,167,268,154,148,102,0,90,30,138,115,75,429,117,84,4,87,143,201,178,192,101,383,239,240,154,242,217,268,11,194,95,197,318
+U96191_at,-42,-38,-70,-106,-56,-32,-94,-122,-6,-64,-39,-86,-41,-64,-61,-165,-98,-32,-102,-71,-36,-41,-28,-70,-36,-74,-89,-5,-115,-15,-106,-86,-67,-47,-78,-48,-178,-131
+U96629_rna1_at,-51,93,94,-303,504,312,-369,-170,39,-1,138,-103,359,409,243,129,153,239,174,314,28,10,-102,-14,-186,27,-317,296,327,-89,11,89,-264,62,-522,185,-280,245
+U96629_rna2_at,458,331,853,412,345,574,218,395,482,321,460,192,374,219,572,397,843,250,86,598,264,262,412,290,370,352,406,203,45,616,294,380,438,247,698,228,475,687
+U96769_rna1_at,203,-48,-806,-41,-379,94,352,-83,-904,280,-155,57,-468,-259,210,-266,-766,-197,208,268,-332,-151,360,117,425,-169,-71,-205,141,-471,144,202,-422,89,-574,248,-485,230
+U96781_cds1_at,140,121,278,159,132,55,194,364,124,280,160,168,28,417,431,233,155,150,327,484,441,19,283,425,404,349,117,274,343,268,28,201,290,175,71,146,304,109
+U96915_at,641,2175,1497,601,2210,743,423,317,1633,1502,2369,754,944,815,2202,1038,1234,564,546,2509,960,720,668,1408,1306,467,178,569,319,891,1005,566,1590,1154,1276,711,1046,545
+U96922_at,-110,78,-119,-128,-97,-35,-85,-100,-355,-43,-47,-35,-74,-56,-26,-48,40,-21,-68,-44,26,-65,-41,-109,-55,-50,-68,-108,-60,-65,-103,-81,-33,-73,-54,10,-75,-104
+U97018_at,38,93,140,30,49,-14,11,50,17,54,132,-30,47,179,47,49,99,48,89,57,97,10,89,-90,-2,49,128,120,88,93,17,44,115,-6,114,153,151,118
+U97105_at,2799,432,1038,930,2097,476,737,422,1661,1002,609,285,3347,589,1576,1226,199,394,651,1123,662,104,438,1604,786,1724,422,100,84,551,115,204,84,143,336,151,1309,267
+U97188_at,118,-2,35,85,302,-28,126,1,-13,48,-64,21,2,40,244,146,-16,115,-19,101,-18,68,112,319,50,12,50,13,-19,-47,25,31,43,11,8,1,36,21
+U97502_rna1_at,40,6,93,-133,150,261,-1,-70,-71,43,-19,-53,93,346,261,7,7,106,136,527,-11,-91,-24,-20,93,148,-70,-79,108,-49,-139,-10,-101,49,-152,-158,-129,-40
+V00503_at,69,53,112,-14,60,24,18,44,23,27,36,24,37,36,93,39,27,3,-6,52,29,24,56,-3,33,43,75,81,62,2,7,35,21,50,73,40,39,65
+V00563_at,2969,776,526,2635,2457,455,3804,1166,439,508,235,1257,5283,454,2778,5371,609,10833,2301,4724,5852,4522,402,2879,1451,5513,2351,651,327,663,1214,361,2838,426,1389,923,5014,1667
+V00571_rna1_at,45,65,117,60,95,16,40,-149,63,78,59,-4,14,0,62,68,121,60,-48,66,-8,45,51,52,43,37,118,132,-4,-23,56,58,24,54,49,19,91,-9
+V00572_at,2933,6754,5513,2232,5538,4157,2745,2866,6815,3880,4468,5402,5584,4386,5017,3391,11422,3665,1924,4659,4496,1114,1903,4150,2480,2904,2783,3834,2589,5522,3221,2507,4298,3060,5474,4044,4526,5740
+V01510_rna1_at,-429,-899,-1182,-573,-171,-442,-863,-1208,-629,-345,-306,-619,-406,-531,-461,-600,-1806,-537,-553,-111,-326,-477,-980,-611,-899,-508,-1114,-611,-730,-943,-1091,-1225,-1188,-451,-754,-799,-1118,-1673
+V01512_rna1_at,1383,5615,393,677,5073,421,4182,1030,1414,2046,1039,1727,5205,774,5480,2270,3930,898,2753,6410,5759,1672,178,3534,12449,7583,1725,2339,233,5850,4364,1371,8231,941,3991,405,3956,7376
+V01514_at,6,-32,-3,-80,30,-67,6,-128,-86,-39,-8,-51,-31,-25,-4,6,-169,-13,-73,2,-84,22,-121,-9,32,-2,-81,-56,-201,-1,155,75,-21,39,-82,-137,-76,-55
+V01515_cds1_at,235,167,254,21,7,144,218,31,217,201,177,117,134,30,160,-14,387,45,-18,167,63,100,186,-7,180,130,303,189,-50,159,280,219,196,1,-5,181,119,298
+X00129_at,70,78,77,-59,18,23,-124,113,40,25,-77,15,-53,76,17,-80,158,68,7,66,91,23,-9,7,71,-26,131,29,-7,20,37,111,108,22,-5,-7,18,67
+X00237_at,65,-21,148,15,61,72,35,7,49,109,93,-28,-17,43,-21,105,106,135,67,35,-46,34,108,-6,132,144,125,69,194,70,33,132,114,98,40,-31,173,65
+X00274_at,19748,7657,1032,13356,13769,1749,10249,21435,1432,2273,461,12114,22819,3274,17537,15787,11030,24727,20755,17110,14610,22207,860,9988,14158,19291,9892,5093,14177,15576,13094,943,13274,9065,17428,16544,15837,17511
+X00368_xpt2_at,128,66,139,43,41,56,55,106,29,-48,23,-4,4,-8,15,34,73,95,33,97,-14,235,74,103,72,109,136,34,100,23,78,-5,7,49,82,14,31,75
+X00371_rna1_at,232,124,307,89,26,158,142,-305,204,153,197,103,146,137,117,-28,67,129,11,-109,33,137,191,119,-69,183,90,260,36,249,-192,22,140,-105,54,218,31,33
+X00588_at,-310,-96,-310,-160,-96,-65,-275,-85,-180,-26,-56,-163,-144,-178,-33,-173,-253,-45,-16,-30,-91,-218,41,-187,-19,-123,-190,-5,-60,-209,-35,-74,-85,22,-123,-214,-72,-141
+X00734_at,-445,-556,-843,-515,-432,-296,-270,-535,-342,-402,-301,-172,-332,-284,-251,-381,-824,-261,-331,-442,-131,-244,-372,-396,-301,-253,-679,-494,-355,-297,-649,-537,-410,-113,-704,-389,-479,-656
+X01057_at,-12,-29,-44,0,5,-21,5,157,-22,-15,-34,25,37,-19,8,-16,-26,7,-1,-20,-58,34,-26,35,3,45,34,57,-72,44,73,-11,-31,-17,20,9,7,-13
+X01059_at,56,-43,14,154,87,170,26,83,315,62,141,120,115,190,116,26,55,137,89,88,-36,111,267,91,88,146,-64,32,302,162,133,178,-8,18,196,52,219,158
+X01060_at,352,2238,813,427,560,369,623,707,605,513,456,617,254,694,487,249,1855,1569,690,2080,404,248,986,499,1279,233,6,596,1752,652,4168,5609,1915,2793,1445,639,691,3354
+X01388_at,876,1072,1159,1174,816,641,1058,1265,851,1038,681,365,952,862,630,1078,1554,782,889,1049,69,1044,683,1060,586,616,815,1033,545,1153,591,939,1481,362,1042,616,1104,1381
+X01630_at,115,223,217,549,235,224,613,136,145,225,81,145,247,636,313,253,351,273,300,106,-92,77,360,140,-28,239,-46,231,-64,44,67,242,483,135,137,257,46,157
+X01715_at,404,298,549,367,259,74,482,623,405,379,337,73,282,332,170,380,745,374,272,361,102,349,404,278,298,250,694,476,399,458,313,437,613,131,462,464,408,934
+X02152_at,2824,6881,8648,4850,7811,5512,5427,1893,12329,6141,6884,4621,5028,6143,6167,4963,11687,7235,5040,9241,2402,1509,3611,7049,4960,4296,2822,2968,3282,7068,2899,2304,5189,5445,8553,6226,6164,7107
+X02158_rna1_at,-118,-96,-150,-114,21,0,-134,-226,-136,-102,-133,-61,15,-8,-79,-29,-160,30,-37,-91,-28,-268,-85,-123,-6,-84,-170,-83,-173,-80,-224,-194,-36,-27,-217,-57,-115,-233
+X02317_at,1598,2925,4255,2087,2236,1726,1271,1371,3107,2244,3077,6234,4869,3577,2848,2162,3910,700,1906,3281,3871,648,1837,2354,7059,1294,1038,1097,860,1527,2395,1762,2733,1186,1961,1492,2188,1385
+X02404_at,193,49,230,66,41,72,159,199,170,144,67,94,20,89,81,81,63,98,128,121,28,11,170,-4,99,52,15,46,57,98,174,199,162,101,79,112,102,96
+X02530_at,4,65,167,82,22,-96,-57,-103,0,-55,36,27,91,60,50,90,-84,2941,6,-10,26,-20,102,5,69,74,37,-52,72,2268,155,63,26,50,-34,35,17,94
+X02544_at,-325,-217,-272,-253,-175,-328,-189,-247,-208,-340,-157,-126,-251,-157,23,-147,-382,-42,-114,-109,-321,-359,-214,-185,-130,-195,-496,-172,-250,-245,-233,-87,-279,-78,-245,-413,-470,-459
+X02596_at,565,745,440,1010,1018,572,1451,743,500,410,896,221,1166,415,1305,1116,589,374,958,2262,728,549,459,1493,585,1087,793,750,596,716,152,149,951,562,-88,521,2115,714
+X02612_at,35,27,195,-41,-5,39,42,386,207,4,93,51,-120,191,56,30,37,57,123,93,114,70,110,38,64,87,197,44,69,55,43,68,74,26,-17,-5,32,84
+X02750_at,544,509,690,715,332,464,863,800,576,466,452,564,422,432,762,526,785,342,463,520,553,422,581,674,783,396,951,316,363,759,895,653,289,447,656,885,713,954
+X02751_at,98,117,187,30,271,81,-40,125,197,108,294,57,42,54,139,59,173,-15,3,114,77,37,115,121,58,-46,14,87,103,-44,129,137,137,55,139,52,196,101
+X02874_at,142,97,140,102,102,-110,174,188,134,44,49,-22,-32,176,91,99,328,91,2,981,21,22,-7,127,183,80,168,75,120,74,108,89,40,63,14,102,74,111
+X02910_at,71,237,7,-125,30,-129,-178,-97,545,105,275,112,41,-57,-129,-47,-181,110,-48,-19,-64,9,-74,-76,678,254,-104,25,-134,864,-45,-112,-157,-1,77,-96,-111,-106
+X03066_at,970,428,767,529,366,453,668,839,576,486,358,254,341,438,382,582,861,902,413,680,293,306,448,654,505,529,808,617,413,584,538,581,495,255,349,532,616,716
+X03072_at,659,487,229,530,211,449,776,947,193,579,131,277,152,450,291,273,858,35,321,379,243,253,672,468,363,437,832,738,574,510,457,-4,184,198,611,497,510,992
+X03100_cds2_at,9110,1538,672,2989,3667,844,2056,4460,719,609,538,2096,8133,1396,6700,2794,2083,6581,6392,9510,4198,2250,400,2402,2690,3906,1675,2000,4210,2976,2529,644,3117,1679,5167,4583,4649,3944
+X03168_at,-378,-1188,-1580,-1324,-141,-1255,-1310,-2352,-400,-844,-198,-352,-248,-1136,-331,-193,-1999,-136,-1044,-1444,244,-400,-1162,-899,-1161,-212,-1539,-339,-1998,-389,-1008,-1830,-453,-1278,-1644,-506,-703,-2342
+X03342_at,21379,22493,20708,23566,23755,15301,21307,22930,22492,24276,23138,24322,22446,22332,21837,24183,23463,22776,24177,18991,23719,22504,23174,23188,24471,21797,24385,22790,22721,19746,22541,25402,21881,27487,20861,22590,23326,23145
+X03473_at,-38,664,158,10,30,19,-57,224,190,483,83,-20,47,30,23,11,264,22,112,506,68,9,37,230,249,100,173,-64,31,53,57,389,106,106,41,44,242,748
+X03484_at,1049,857,921,782,619,510,888,799,1066,659,715,352,465,631,917,765,1676,339,512,1099,465,825,877,712,523,348,68,849,365,1074,891,1342,895,672,1190,439,607,959
+X03635_at,-91,33,-103,-49,-35,-69,-60,-43,-133,-16,-33,-71,-41,48,-25,-31,-8,-8,-12,61,-53,-62,-108,-66,-24,7,-12,-78,-91,0,-13,-20,-40,-29,6,-41,2,-119
+X03656_rna1_at,-128,488,599,19,518,-51,557,-113,442,502,437,566,403,562,619,720,685,466,264,945,316,346,150,-8,-153,321,120,-66,-103,1568,391,779,546,436,818,-5,638,130
+X03663_at,-121,-19,-238,66,425,-21,114,-349,316,-8,156,137,-57,97,212,-160,-79,104,-44,35,-104,-14,47,250,16,-111,-192,176,24,19,13,11,362,159,136,302,8,239
+X03934_at,623,7662,11301,474,345,7159,547,779,11288,7950,7169,390,410,5557,698,571,6502,384,343,518,341,248,6799,367,522,414,629,499,379,410,307,679,589,274,318,419,485,582
+X04011_at,1049,58,117,76,262,58,30,340,73,88,-33,139,1642,360,35,725,872,4,55,2312,57,96,288,-72,555,199,-9,106,223,658,131,168,71,2,57,418,132,393
+X04085_rna1_at,1057,1395,823,1655,2000,537,6133,775,633,463,628,294,1220,662,1990,1143,2474,220,1271,4004,1781,350,431,3970,747,773,115,5878,2140,5162,2887,4681,3077,6000,5065,7260,2027,3072
+X04106_at,3259,2496,2189,1668,3796,2076,1774,2142,2813,2844,2973,1608,3601,2923,2982,2727,2918,693,2637,2911,1840,1685,1892,2281,2753,2785,987,3035,2164,4528,3323,2987,1717,2766,5339,4328,3279,2247
+X04143_at,-219,39,-174,-58,110,-307,-416,-319,-51,-79,106,-129,127,-19,44,158,-110,48,-62,113,0,-188,-20,-96,13,137,-125,-223,-141,-34,-5,-44,46,54,13,372,94,-55
+X04145_at,-66,342,582,-106,-9,449,-137,-202,2608,248,791,-136,-61,375,-41,-199,-241,-64,-74,-88,-123,-47,566,-155,-95,-59,-248,-105,-141,-148,-210,-195,-148,-73,-21,-194,-54,-212
+X04201_at,763,410,523,-111,319,40,52,380,515,167,510,290,-57,213,-117,49,421,119,-73,-171,44,343,-174,221,101,290,165,270,-12,524,20,289,278,-182,142,22,272,150
+X04297_at,-71,106,74,31,91,156,60,-140,-109,0,20,28,31,55,85,31,25,10,101,3,57,-35,-5,47,29,-59,-162,-87,144,8,-154,-34,-26,38,-28,-15,109,66
+X04325_at,549,395,139,516,291,96,16,-49,20,-39,327,60,39,312,241,158,86,43,3,232,239,345,100,352,64,48,461,32,108,-194,38,-2,32,51,16,-79,32,-67
+X04327_at,137,146,192,189,134,188,139,710,117,107,106,10,151,179,30,101,74,163,336,777,61,150,112,160,341,76,42,75,187,131,401,599,75,242,161,78,240,547
+X04366_at,816,356,517,485,963,209,357,200,539,373,537,38,528,440,720,576,807,366,381,440,-39,128,210,534,379,583,270,700,334,486,226,137,351,34,504,524,743,84
+X04391_at,376,885,886,592,144,793,588,608,625,606,669,191,122,799,210,296,370,115,277,228,372,445,638,152,240,79,392,511,706,201,576,422,294,229,385,588,641,316
+X04412_at,1298,-114,-663,152,1391,-222,1176,-539,-406,-130,-157,296,663,-274,1351,1534,363,-103,690,312,-56,-179,-262,979,398,1598,-389,195,201,685,-307,-196,816,793,821,1123,1025,-10
+X04434_at,-81,-10,2,-205,70,-14,-78,226,54,3,-23,1,93,-6,-77,49,-78,86,116,355,-74,-94,96,-3,25,-204,-137,-22,-209,-191,47,-222,27,-46,-139,-190,87,-60
+X04500_at,749,1104,111,118,833,51,134,1115,-75,161,35,1076,3268,-62,55,170,-43,76,64,850,-183,576,64,-80,1397,227,101,0,-192,25003,5526,122,204,83,3847,-7,1578,10583
+X04571_at,113,88,26,-51,20,-19,47,19,-14,0,-40,-14,0,-7,-45,2,109,-41,4,22,-51,-18,77,-18,27,-6,147,-122,-50,22,51,102,-24,-30,58,-71,59,60
+X04688_at,2,0,10,-45,-5,3,6,-10,-11,-19,-6,-73,-16,6,78,-46,45,-15,-7,-24,-69,10,-56,28,-8,-10,82,-25,33,-9,26,34,60,-23,-43,31,19,43
+X04707_at,132,142,145,55,96,72,99,143,155,84,-5,64,164,57,-8,146,101,261,179,149,-2,22,199,47,97,49,39,112,113,176,85,72,76,82,6,196,60,138
+X04741_at,-528,-418,-823,-556,-228,-394,-488,-649,-562,-295,-359,-426,-305,-515,-453,-525,-992,-60,-163,-277,-24,-404,-330,-269,-450,-322,-970,-336,-694,-608,-707,-591,-98,-454,-615,-425,-456,-140
+X04828_at,1801,1462,540,683,1380,695,435,238,1336,666,452,1023,1240,873,1514,1303,1500,936,625,2061,197,676,436,594,1091,664,-603,1027,226,4234,1763,67,1351,1964,3133,2364,3259,1438
+X04898_rna1_at,-187,346,-315,-286,-120,28,-97,-556,-281,-188,-146,116,-24,-259,75,-125,-67,-134,-173,-257,52,-239,-64,-262,-196,-186,0,-963,-351,-378,-215,-26,-235,29,110,-239,-283,-535
+X05153_rna1_at,-400,306,-443,-158,-3,120,-16,104,-158,159,7,156,149,168,184,255,276,-451,-60,-560,59,-27,212,-234,134,295,-226,-149,12,-50,256,-130,-175,121,280,-62,-3,288
+X05196_at,309,565,447,311,188,289,341,-100,741,-8,303,179,292,295,120,133,18,2268,-32,74,353,88,167,430,32,191,-118,492,201,386,-83,150,143,66,187,209,233,211
+X05232_at,101,-23,27,-132,-53,-23,-52,100,-23,-24,-4,-126,-33,-77,-104,17,-76,27,-81,-29,16,-111,-117,22,-58,39,79,-211,-115,-11,9,16,-18,-29,71,-48,20,-8
+X05246_at,81,11,-53,25,58,-46,73,139,98,48,35,-11,66,-25,36,127,89,54,71,0,-6,65,62,22,29,62,23,-80,-40,75,9,17,76,6,65,24,29,78
+X05276_at,1323,3229,1541,3723,2855,622,1875,3656,1102,570,718,1928,1496,1318,2673,2691,4020,1301,2047,5212,147,863,731,3461,1896,832,289,498,752,364,964,1905,1611,975,915,1552,2403,2400
+X05299_at,-1995,-1036,-1494,-2653,-755,-1708,-1959,-1287,-1408,-799,-1128,-1608,-653,-1418,-747,-595,-2269,-792,-702,-638,-547,-1612,-1231,-952,-1213,-482,-2401,-1274,-971,-1724,-1916,-2489,-1742,-640,-659,-1718,-1465,-2146
+X05323_at,708,747,493,396,261,151,275,341,257,167,167,260,382,113,572,320,859,174,186,292,231,304,218,190,436,141,331,73,173,148,65,155,161,21,155,211,406,230
+X05360_at,97,-27,111,206,94,0,18,95,146,105,28,35,339,139,228,33,115,223,127,1,-18,28,112,79,5,-8,158,10,62,67,78,209,153,-2,62,45,43,108
+X05409_at,-131,121,-104,-104,-56,-46,-136,-94,43,33,-2,53,6,158,9,-135,75,71,-49,73,-2,-98,-18,-15,-220,-120,-220,-39,7,-52,-20,134,530,5,107,600,2323,286
+X05608_at,56,34,100,25,15,-7,-23,71,75,117,46,-21,15,20,49,57,26,-5,27,50,38,52,60,16,51,18,100,-8,81,9,-7,49,21,13,37,45,50,15
+X05615_at,-28,0,-317,-151,19,-65,-52,-242,-177,-62,5,-74,-52,-36,-46,84,-12,-45,-203,-75,-76,-64,-136,179,-149,-122,-136,-163,-230,-143,-133,-41,-20,-17,43,-52,-106,-315
+X05908_at,-58,900,3918,124,1534,533,-77,-61,2758,2660,2117,109,-35,1483,91,1,2115,-60,-36,-52,-1,32,-20,121,-49,-62,-51,1798,343,3877,3447,828,73,1638,10438,2128,968,3038
+X05997_at,134,11,145,39,39,88,-6,133,-38,28,-14,-20,66,4,44,128,12,15,28,90,-18,49,148,45,113,67,-46,41,9,100,22,76,58,19,-27,6,163,31
+X06256_at,-198,-328,-409,-43,-112,-152,-312,-491,-296,38,-225,-189,66,-233,-147,181,-15,-106,-65,133,-111,-262,-397,-234,-225,-27,-414,-103,-437,-208,-133,-292,-239,33,886,-341,-184,-86
+X06272_at,283,151,245,429,214,257,351,305,294,227,408,148,162,388,428,200,432,214,270,201,131,340,199,352,141,213,269,398,245,513,541,436,331,129,414,252,490,420
+X06290_at,58,0,85,21,7,37,-28,74,37,16,40,-31,-51,83,-42,22,42,57,-18,37,68,57,-41,32,9,31,23,-1,60,100,21,81,21,-37,4,43,6,44
+X06323_at,234,485,537,456,726,206,379,169,439,294,102,117,351,703,577,413,588,146,269,782,597,81,210,589,133,109,298,322,233,261,113,70,184,38,293,315,239,253
+X06389_at,-134,-83,-321,-132,-106,-136,-188,-247,-36,-179,-122,-103,-112,-179,-167,-120,-176,-52,-180,-78,-71,-62,-239,-158,-87,-74,-97,-146,-194,-167,-151,-75,-188,-34,-197,-120,-220,-270
+X06482_at,76,75,-67,-23,45,115,8,221,-100,64,49,-56,-4,42,93,-14,162,-14,174,443,-14,28,-26,-130,121,168,151,85,103,-110,407,1037,127,646,57,54,155,176
+X06562_at,125,37,104,22,26,33,67,91,17,59,11,38,52,56,25,51,120,27,-28,75,-33,57,96,11,33,55,56,45,31,56,62,33,40,-5,24,52,103,86
+X06614_at,-449,177,-298,-9,335,7,-151,179,152,363,92,342,62,519,-41,354,95,102,57,1244,863,292,-153,169,-107,200,106,307,-125,89,873,165,761,1009,1548,350,843,2165
+X06617_at,19910,16862,19583,20830,22607,23246,19701,23741,19378,21768,20868,24501,21692,20015,20364,22268,16509,16974,21924,13751,22892,22447,21799,19823,23431,21464,22919,19916,16786,17563,20995,23038,19969,24751,17890,21155,21096,19333
+X06661_at,6,-48,-19,42,19,49,95,29,-38,22,-6,15,55,14,35,60,86,38,44,40,86,5,13,44,26,69,46,-47,-50,34,-33,44,37,-21,-1,47,102,-41
+X06745_at,166,116,310,177,230,-5,174,110,299,179,-26,31,721,133,282,263,369,157,143,259,179,-69,150,339,56,72,-46,167,137,61,94,90,53,-5,54,117,154,-23
+X06948_at,59,52,57,71,86,30,87,43,74,55,81,11,43,62,59,142,41,39,36,76,79,92,45,176,39,61,158,45,161,35,134,78,283,50,99,103,318,60
+X06985_at,384,398,1042,-39,439,87,954,259,435,80,352,-18,186,6,-83,541,563,488,752,265,548,283,142,225,436,-54,120,327,848,1017,1324,1070,456,346,1756,672,734,2077
+X07024_at,657,410,571,497,314,348,551,683,492,330,342,238,307,514,239,430,603,400,284,403,268,324,381,398,344,374,633,528,411,434,513,425,437,211,336,381,490,689
+X07109_at,4150,2942,1358,1191,1282,679,581,1874,1766,452,469,725,913,2542,2614,2165,4785,103,1172,2885,762,217,524,721,1188,1120,-142,492,1014,2353,82,-305,799,265,1753,595,2620,350
+X07173_at,143,85,-19,90,58,-5,58,-14,105,-4,61,-44,26,82,50,86,212,76,58,133,-3,69,-18,89,20,90,97,124,38,148,134,127,71,18,-25,69,99,138
+X07290_at,597,633,603,295,458,172,80,271,280,172,585,265,417,606,435,607,467,399,309,580,309,414,300,341,553,447,425,276,257,603,556,789,440,364,857,217,617,649
+X07315_at,687,329,546,481,425,334,651,700,1064,426,685,211,724,163,544,732,1012,374,485,785,-64,164,482,513,443,113,316,279,214,337,264,291,409,311,473,453,496,-249
+X07384_at,51,21,-29,141,73,62,-203,-682,311,-51,182,-21,-89,60,-103,67,-248,1,-68,-229,-54,158,241,116,-3,23,-383,134,144,-59,-72,2,200,-285,-24,-39,-124,-50
+X07495_at,-134,-17,-51,51,77,-149,-11,-110,-118,-1,-93,-5,8,44,70,136,-157,-102,93,63,41,-22,-75,33,2,68,-325,11,-40,-105,-5,-34,37,26,-88,-28,-22,23
+X07695_at,303,372,-161,62,295,-19,72,38,120,-60,212,271,-169,82,150,-536,-500,110,-132,-330,377,-333,336,-443,358,47,364,-122,-88,-445,-221,307,-500,243,517,83,221,-8
+X07696_at,-100,-83,-598,-94,-85,-103,-70,-77,-144,-171,-109,-70,-164,-110,-134,-38,-280,-47,-168,-130,-167,-52,-70,-143,-97,-148,-82,-274,-98,-56,-156,-81,-56,-85,-213,-142,-162,-111
+X07732_at,-422,-297,-567,-219,-85,-408,-562,-695,-362,-396,-282,18,-241,-358,-423,-251,-522,-171,-299,-469,-151,78,-195,-110,-274,-259,-316,-374,-418,-327,-664,-396,-326,-186,-212,-447,-455,-358
+X07743_at,160,204,51,239,360,-56,85,61,101,68,62,474,292,34,153,86,1136,4,141,109,57,88,30,97,610,55,-75,748,218,4004,683,536,754,431,2733,1094,459,1379
+X07767_at,567,311,347,-14,337,225,-21,-10,1147,202,397,86,932,332,393,131,183,93,24,537,142,-9,98,224,112,676,-230,169,-76,1193,37,-218,-81,-101,418,139,228,-174
+X07820_at,85,114,71,90,94,56,62,86,169,49,80,87,38,133,35,89,113,7,108,78,69,64,214,56,156,81,87,-20,9,22,48,99,43,70,183,-11,52,89
+X07834_at,-75,4,43,58,46,39,-16,98,87,22,3,43,110,26,26,44,85,-67,48,226,74,273,-13,-34,116,77,18,36,57,1321,593,68,214,126,424,113,212,467
+X07876_at,245,72,323,214,138,83,257,254,206,218,125,14,12,145,140,160,113,114,102,36,23,128,188,77,12,90,395,147,149,135,137,80,92,34,111,143,312,164
+X07948_at,350,263,296,345,155,183,157,401,106,214,314,116,116,358,245,404,465,249,115,392,377,287,406,230,322,332,363,159,137,198,426,212,366,213,293,336,356,365
+X07979_at,2069,2671,1892,1222,1433,903,1858,977,1999,994,647,827,2935,4488,1254,2050,2396,495,1638,2296,1069,547,984,1304,839,1176,527,1237,1827,2419,845,836,1797,210,1151,1300,1770,1859
+X07994_at,51,38,-126,-110,-23,-17,-122,-262,-134,-8,-95,-27,-187,-9,-123,-184,-154,-105,-168,-124,-121,-1,-28,88,-93,-171,-234,-135,55,-168,-78,55,-105,-142,-105,-69,-33,-204
+X12433_at,400,253,492,172,296,252,388,467,360,292,272,119,233,220,185,269,281,287,186,207,242,306,100,325,81,306,514,439,158,262,282,225,442,195,403,434,634,647
+X12447_at,1930,4851,3097,3499,6697,3703,4879,1361,8382,8790,4987,5472,5597,4222,8104,5847,8693,8516,5471,9718,1676,1333,1994,3317,3635,6590,4388,8223,4008,12061,9229,4846,3261,6032,8374,10577,7245,7730
+X12451_at,149,14,95,197,70,378,260,328,331,247,21,179,-10,-9,131,173,87,97,137,159,176,129,110,149,207,145,350,208,312,725,4456,332,536,323,2747,340,119,676
+X12453_at,35,77,65,180,50,30,215,196,133,103,9,44,55,140,43,93,189,103,22,70,231,134,151,81,74,74,291,34,88,148,106,118,68,-17,181,167,59,89
+X12458_rna1_at,26,-220,-91,-408,-355,-96,415,-203,-115,64,-238,-127,-83,-169,346,-113,-1079,-268,-72,-640,111,-44,157,-52,-358,-101,-392,-134,319,-21,-349,-267,-82,175,-368,-355,-242,55
+X12492_at,694,541,820,651,427,688,754,478,764,472,496,429,500,244,244,525,1120,425,189,516,530,264,663,486,579,511,863,780,620,685,638,656,659,426,642,758,800,1228
+X12517_at,-1370,-613,-1533,-1593,-426,-585,-1471,-3156,-553,-201,-538,-296,-65,-1242,-497,-631,-1996,-668,-895,-48,-98,-958,-39,-687,-1622,-938,-2850,-1179,-858,-1340,-1908,-1000,-819,-500,-1966,-715,-1562,-1487
+X12556_at,-16,23,-65,-6,-155,28,-109,-61,-95,-71,-66,-68,-61,-40,-24,-50,-205,-97,-139,-68,-101,-105,43,-121,-13,-31,-42,-110,33,-76,-38,-22,-41,-66,-62,-77,-56,-84
+X12662_rna1_at,38,31,18,-42,19,-17,-3,20,34,8,6,-8,-5,2,-5,-43,26,-33,10,29,22,-11,5,75,42,18,21,24,-21,29,60,135,8,37,50,5,40,139
+X12791_at,1022,605,1191,1035,936,622,767,989,715,663,1098,301,499,731,1066,977,1081,570,469,1511,1592,538,695,1111,659,685,594,552,569,909,237,954,625,562,630,722,520,1055
+X12794_at,549,423,743,625,319,510,495,680,354,335,383,487,493,511,356,278,535,232,281,309,301,707,602,586,287,376,564,355,793,365,191,719,235,290,328,719,359,678
+X12901_at,14,43,-28,-75,13,-33,3,-173,-137,-68,-43,-28,-11,-127,1,-23,-78,-3,-55,-17,17,-41,-94,-33,-25,12,10,-105,-105,-103,-113,-11,-119,-54,-49,-124,-37,-76
+X13227_at,270,325,50,418,275,238,199,296,253,382,218,77,98,445,269,591,157,143,258,211,13,270,398,340,212,328,452,327,574,76,244,382,60,121,359,395,497,262
+X13238_at,2248,3202,4452,1774,2946,1458,1300,991,3143,2112,4149,1330,3383,2512,2877,2668,2881,1707,1161,4750,5715,1303,2122,1920,1463,1482,1189,1037,1161,1862,1646,1308,1803,2261,2228,1476,1682,1932
+X13255_at,310,65,123,88,218,222,159,274,290,186,99,48,86,58,53,55,259,27,51,199,66,-105,-41,57,118,142,123,153,209,123,26,251,200,86,173,130,135,211
+X13293_at,262,417,432,205,308,496,-198,101,1062,1076,975,158,810,31,665,94,-508,1378,126,259,21,649,710,162,286,295,363,-23,-221,485,1404,1757,516,837,396,151,-263,237
+X13334_at,-1046,103,-1938,-993,-267,-563,-1174,-2712,-1103,-751,-718,-560,-682,-451,-562,-893,-2646,-644,-737,-1066,-474,-1136,-1145,-727,-871,-616,-1395,-1101,-1079,2571,-1302,-1231,-751,-398,-1373,-889,-1041,-473
+X13444_at,1739,892,1690,1316,581,905,1643,1808,1354,1006,958,767,749,872,545,967,2009,881,623,915,450,741,913,905,807,804,1805,1295,1086,1471,1697,1007,943,431,1191,1152,1078,2270
+X13482_at,722,799,997,402,667,636,226,449,876,584,1155,504,506,601,613,455,665,454,379,848,815,882,729,600,974,430,305,572,351,585,374,747,725,390,633,487,457,474
+X13546_rna1_at,3535,2886,8399,3145,4057,5921,3002,757,10994,9238,5547,2241,6595,3570,6641,2125,6516,1169,2694,3639,3644,2476,5338,4311,2841,2010,1650,1329,2154,5843,4752,3750,4239,3006,6808,2767,2983,2500
+X13589_at,-76,-76,-85,-87,-31,-21,-154,-191,-67,-51,-98,-54,-14,-70,-32,-83,-68,-14,-97,-77,-53,-60,-28,-10,-47,-45,-50,-131,-98,-98,-72,-56,-32,-73,-78,-68,-113,-94
+X13794_rna1_at,2583,6125,8616,3363,5697,3965,2765,1907,9147,5822,7147,1369,2681,7458,4386,4146,10508,4332,2584,9570,3641,1921,4394,4301,2432,1722,2406,4843,1175,2147,3020,2149,4957,4623,4590,3347,1495,2658
+X13839_at,-140,-141,-279,-46,195,-165,-124,-242,-167,-82,-182,-43,-96,0,136,-180,266,30,-174,-224,-104,-117,-182,5,-78,-81,-112,26,783,111,-106,-39,266,49,20,525,-163,-242
+X13916_at,-29,184,190,-62,197,119,-25,-305,74,45,273,63,68,65,120,60,212,138,-37,198,171,60,155,103,113,129,-165,53,-134,343,56,186,95,77,148,-173,96,291
+X13956_at,316,406,30,514,320,307,593,-134,41,372,522,231,173,98,563,232,512,-84,268,824,397,491,522,228,400,256,275,152,201,161,-176,252,199,171,371,143,-138,138
+X13967_at,545,1319,639,512,137,490,601,520,432,333,364,313,236,417,338,347,210,283,177,305,312,502,524,359,540,388,571,452,572,552,299,349,399,41,490,482,500,919
+X13973_at,480,678,540,538,588,423,567,532,641,632,828,291,396,834,491,653,892,450,658,1356,291,247,368,926,447,237,281,824,870,1424,793,637,388,672,2238,826,1196,1428
+X14046_at,2813,4960,482,1242,2238,2466,720,3097,2371,1617,1986,560,3037,3159,6303,1447,3207,3743,955,4229,43,1756,866,1421,2434,3212,1411,5135,2152,7010,3072,1942,4701,2853,6254,4057,8111,3745
+X14329_at,637,622,1019,669,443,672,767,902,501,658,769,402,488,417,448,625,1483,496,328,403,248,447,598,345,833,441,963,505,714,92,1044,1171,802,466,698,791,767,942
+X14346_at,-270,-105,-217,-202,-227,-78,-112,-698,-281,-118,-194,-89,-92,-245,-61,-91,-178,-154,-149,-183,-273,-57,-157,-88,-209,-71,-220,-167,-199,-148,-111,237,-83,-270,-101,-108,-151,-269
+X14362_at,-44,35,-41,-31,-47,1,-70,-73,50,-37,-23,-106,-19,-70,85,-52,-82,11,0,14,-58,-2,11,-29,-27,-25,32,0,-16,-52,11,-8,-71,-38,-98,-31,-139,-41
+X14445_at,187,233,104,-72,103,-83,132,280,242,363,361,-38,34,149,-144,162,286,95,88,34,-152,113,172,5,52,35,-28,65,21,85,387,271,170,-31,211,184,212,252
+X14448_at,1563,912,1137,1530,986,759,1361,1362,1291,823,930,1112,874,602,1160,436,1988,857,409,1180,127,959,607,1095,1023,490,1145,1191,1046,1178,1159,1151,1419,781,1806,1101,922,1345
+X14675_at,651,468,825,695,327,483,742,1069,534,330,441,494,393,309,389,572,621,352,256,498,118,579,740,544,575,492,450,468,680,583,425,473,564,205,133,510,590,803
+X14787_at,-24,54,1,-27,-32,39,-18,-26,7,-36,-29,-22,-23,-19,-42,4,-129,-38,62,-39,-36,-14,-56,-75,-52,-35,-61,-12,-48,987,901,11,150,33,146,-3,9,248
+X14789_at,599,279,414,500,430,408,381,472,371,449,391,231,427,289,274,489,601,288,382,554,172,332,243,396,403,333,222,607,442,425,354,365,588,273,311,446,656,899
+X14813_at,-38,384,-159,268,512,-122,186,7,-102,208,191,-250,193,341,665,-30,604,52,91,945,-176,-303,-440,307,168,253,12,-127,-86,-113,116,365,51,209,271,-154,-302,219
+X14830_at,165,146,166,130,209,156,80,32,148,292,115,125,114,407,178,108,171,162,34,224,-57,74,142,135,112,118,129,344,187,69,197,110,128,73,131,102,167,153
+X14850_at,751,879,1533,1788,1354,1627,1456,724,3470,1857,1526,319,2586,1748,2321,438,1456,1024,960,1123,620,235,1500,1443,461,1048,622,32,341,670,797,806,851,680,242,574,239,687
+X14894_at,16,-49,55,-46,-18,-33,-68,13,-64,-22,-24,73,-2,9,-11,-29,-40,-20,-29,-32,-18,-26,-3,-3,-42,-16,-59,-62,-48,-17,-32,49,5,-62,-41,-20,15,-87
+X14968_at,-217,-229,-262,-280,-98,-245,-267,-325,-204,-170,-245,-94,-75,-170,-115,-177,-252,-141,-104,-214,-38,-236,-26,1,-195,-135,-320,-260,-199,-232,-279,-290,-169,-89,-196,-158,-146,-288
+X14975_at,176,185,6610,336,-61,3295,445,407,2134,2466,379,12,-34,80,92,62,399,46,101,194,-84,-10,3531,141,89,221,178,168,170,195,218,32,96,78,157,27,187,72
+X15088_at,-90,10,-50,-1,21,-56,-95,-32,3,-61,31,74,-4,-44,27,-54,-76,-26,16,-12,34,23,60,38,-8,5,48,39,-88,-41,34,49,-5,-53,-46,-26,-126,-43
+X15183_at,4243,8548,11553,9425,8511,5811,5430,6677,10096,13098,8438,5259,14431,6763,10198,7075,11970,2410,6683,13116,13571,2984,6911,6424,9712,5613,3190,5142,3238,3223,6033,4537,4861,4404,12584,4784,5557,6500
+X15187_at,716,902,1138,975,1742,551,688,805,1195,1539,1751,1125,1938,541,1775,1139,1393,656,1044,2828,1290,733,716,947,1644,859,658,1031,490,2278,1338,2191,1396,1093,3526,1642,1551,1138
+X15217_at,-27,-54,-93,-131,-17,10,-120,-133,-20,-94,-50,-10,-6,-82,-70,-67,-99,-21,-72,-79,-3,-45,-68,-135,-35,-62,-161,-109,-55,-146,-70,-74,-73,-2,-91,-75,-118,-122
+X15218_at,-264,-383,-385,-376,-11,-199,-364,-287,-92,-76,-143,-169,-74,32,-303,-98,-422,26,2,-57,-89,-231,-18,-326,-5,62,-170,-390,110,-342,-222,22,-189,29,91,-452,-309,24
+X15306_rna1_at,50,166,244,104,108,33,151,260,-160,66,-4,37,111,70,52,111,54,95,154,129,143,151,26,137,40,3,170,159,149,52,69,202,108,101,189,66,65,85
+X15341_at,4290,6798,8825,4051,5084,4890,3456,3232,8540,7790,7804,2786,6259,5654,6167,5794,5141,2688,3767,8689,5546,3119,4730,5583,3389,4499,3001,2565,2621,4966,4809,4193,3604,4555,6620,4117,3944,2914
+X15357_at,715,262,471,2,384,144,285,611,416,392,281,81,601,210,359,451,302,154,295,354,173,183,303,139,311,537,50,316,31,144,73,219,245,222,170,44,198,218
+X15376_at,103,42,44,40,72,39,43,79,332,61,107,262,-6,58,199,112,64,32,-21,114,-47,27,32,89,64,135,162,26,40,59,96,-6,130,317,76,507,79,94
+X15393_rna1_at,877,860,1069,645,483,915,878,1611,779,567,692,520,532,746,480,696,681,514,855,827,177,712,816,456,1032,680,970,579,668,873,1862,1502,841,768,871,1241,1129,1858
+X15414_at,1999,1092,2106,1159,1847,1397,1265,1404,1637,1465,1061,625,1910,1250,2073,2039,775,1221,961,2536,1357,635,1453,1475,1135,1638,1254,643,464,1069,406,224,1180,158,1393,395,919,648
+X15525_rna1_at,393,257,622,358,233,295,312,427,166,223,238,142,392,404,235,287,239,173,336,399,267,228,262,258,169,167,162,309,180,534,290,122,311,178,286,363,559,399
+X15573_at,-2135,-1906,-1157,-786,256,-1582,-1621,-2739,-2930,-558,-899,-1152,301,-1187,480,-1101,-2175,-185,-842,2311,-893,-1422,-792,689,-1658,-601,-3040,-2510,-1988,-3007,-4001,-3133,-2368,-1173,-1971,-2019,-1937,-4491
+X15722_at,-138,-101,-103,-109,144,-90,-216,-328,-113,-44,-77,-225,-60,62,95,-124,-205,24,-20,-81,-113,-111,-17,-41,-90,-277,-81,-206,-259,-135,-131,-108,-111,-63,-42,-179,-226,-324
+X15822_at,2095,5601,4913,1902,4269,2795,1996,2575,5750,4441,4683,1790,3450,2901,3499,2594,3639,1758,1537,8154,5455,1038,2112,2454,2296,2683,1639,2307,1291,2694,2520,2743,2459,4131,3602,2292,2367,1942
+X15875_at,321,59,322,385,196,284,218,275,358,228,430,53,21,85,327,-7,861,5,118,260,97,228,79,308,271,-87,591,315,55,-25,264,521,260,98,284,183,246,365
+X15880_at,444,277,623,1415,17,782,300,1388,232,-312,412,232,74,624,430,-354,-347,15,360,-73,179,523,689,535,-38,-102,1120,650,387,111,-148,151,106,-155,737,-134,-388,918
+X15882_at,243,219,190,114,200,181,178,272,251,217,55,175,71,1779,153,163,141,172,238,337,131,130,170,75,395,191,114,423,774,119,252,572,246,193,293,527,177,356
+X15940_at,16669,18441,15841,19541,18931,15068,21395,18736,17667,17606,19222,19701,15582,18294,18378,18785,19546,16727,17932,15909,25949,18280,15896,18692,19645,17015,19876,19830,21788,15531,19072,20307,17679,20807,18204,18346,18034,19910
+X15943_at,-78,-63,-128,20,-49,-55,-87,-80,-13,-28,0,-35,-66,-34,-22,-28,-55,-77,-14,-25,-26,-10,-13,-120,8,28,23,-32,-19,29,54,0,-64,-15,-13,-41,-62,-87
+X15949_at,277,104,91,403,416,46,267,314,210,97,27,-2,588,307,747,393,822,515,339,748,201,48,-36,598,163,169,104,35,79,71,14,64,64,35,-5,23,59,33
+X16064_at,21116,21199,21911,22535,22059,21473,25789,28072,19725,19525,22266,23236,21759,21121,20200,20828,21130,17369,21558,18390,23336,23350,23247,23942,24479,20940,19971,22730,23875,22272,21094,23343,20093,19336,21217,20570,22209,22714
+X16135_at,3490,3312,2657,2535,1419,2437,3394,3061,5308,3282,3174,1569,3570,3069,2518,3388,5654,1875,3400,7062,2667,2181,2437,2472,2099,2428,2387,2130,1837,2523,3104,3305,2861,2004,2487,2880,3412,2685
+X16282_at,-193,-328,-241,102,115,-101,-102,-314,-12,-43,-138,64,-155,-119,81,-293,-157,71,-506,-437,-119,-266,-326,6,-190,-283,-211,-129,-38,16,-102,-29,-54,-301,-123,75,-166,-574
+X16316_at,2148,1459,1951,2164,923,1516,2537,1416,1740,1103,991,965,2032,1702,2040,1501,4112,895,1230,2258,457,825,1481,1424,1382,1505,1023,1342,1079,1385,1145,939,1110,655,1498,1680,2262,2057
+X16354_at,199,-20,160,24,78,-83,105,193,98,48,-16,18,30,105,81,-26,137,77,129,-27,18,81,72,48,82,-48,14,18,-26,74,74,130,65,91,83,83,154,231
+X16396_at,88,351,171,137,713,21,60,158,449,364,172,18,600,384,418,63,508,1258,296,1247,1008,44,0,338,221,195,134,29,79,244,94,112,859,290,471,60,-5,790
+X16416_at,708,180,565,569,692,417,608,976,678,212,627,290,732,583,776,392,491,229,1247,876,77,844,550,432,493,940,106,737,610,287,335,782,670,446,235,415,613,1000
+X16560_at,4108,2874,5520,3023,5874,2877,1828,1701,6135,3918,4746,2228,3402,6187,5239,4512,4405,3827,3845,8948,8932,1887,3947,3325,3133,5062,2060,3378,3056,2281,2682,2534,2142,4219,4836,2775,2816,2192
+X16662_at,-70,-109,-98,-59,-32,-64,-43,-22,-46,-32,-52,2,-62,-57,-68,-51,21,-4,-99,-145,67,-54,-108,4,-60,-21,-93,-20,-1110,-68,-204,82,-21,-19,-19,-19,-105,-179
+X16663_at,1454,1802,2121,1945,1595,1708,1759,1115,1951,1364,656,689,1556,2337,1867,643,3522,1239,759,1427,238,925,1233,1733,1041,1218,1461,1629,1019,3557,1062,497,1630,821,3433,1782,2374,1938
+X16665_at,133,355,534,98,252,80,235,1,525,332,129,71,37,332,188,67,665,123,92,60,63,151,132,349,87,336,713,674,144,456,906,459,511,544,726,559,153,282
+X16667_at,69,17,333,121,95,257,440,131,-111,163,117,219,38,294,-46,126,16,165,301,22,172,30,161,290,301,139,-50,312,134,295,643,421,200,388,439,156,262,353
+X16706_at,-390,3,-244,12,120,-172,126,-1085,-161,175,-333,428,53,-449,-138,245,15,-73,-36,-382,-134,-332,182,-388,683,181,-531,435,127,-177,189,520,2763,865,1486,37,-448,3755
+X16707_at,-1282,-889,-2347,-2956,-132,-2133,-1675,-859,-2021,-242,-1335,-790,100,-310,-1163,-88,-3163,-533,-1128,-2832,-323,-506,-402,-673,-1211,-650,-921,-229,-658,-2038,-994,-1307,-326,-289,-1655,-1551,-383,-540
+X16832_at,1153,1618,544,-31,68,1008,178,175,381,762,-111,63,13,1271,182,-18,92,2275,162,-233,2913,156,79,3,152,-65,-28,332,245,1765,618,297,374,816,2617,252,1139,977
+X16901_at,-20,63,-62,-14,49,-33,48,-41,-7,21,21,4,44,0,23,28,6,20,27,21,17,13,-11,70,12,23,-15,-48,-9,-22,14,-28,-26,-21,-1,-49,-52,-37
+X16983_at,332,353,799,714,673,572,1045,458,113,140,158,25,333,315,1370,519,985,84,463,458,32,111,503,1630,93,45,-35,130,264,149,-18,1,340,167,118,143,648,60
+X17025_at,155,43,14,75,630,71,124,38,-85,51,216,79,673,129,644,34,-295,142,31,867,2463,88,64,1472,212,94,-226,-267,-84,185,58,-248,-225,135,52,-344,145,-229
+X17042_at,177,3460,416,392,7972,597,403,140,848,1094,1343,5252,2408,2525,2133,1232,1150,1232,1519,180,1912,354,178,1687,3711,1750,291,8518,3628,10603,8479,1285,7858,8859,11003,5849,3259,8855
+X17094_at,0,474,61,52,85,-49,33,113,101,-31,132,402,125,0,46,51,379,61,189,-131,46,87,-5,54,206,141,-300,44,-48,600,804,375,1381,849,220,206,273,1655
+X17098_at,-161,-101,-203,39,-16,83,-50,-214,-257,-159,-160,-232,-80,45,-143,-167,-219,-58,49,-247,-138,-61,-241,-59,-144,-19,122,-118,324,3,182,-156,-106,-74,174,-342,-187,-255
+X17206_at,22525,24045,21956,24663,27143,29898,29492,25858,23594,27518,25966,29507,21499,24068,24111,24226,23997,28109,23933,20657,17827,24093,25272,25469,24589,25361,27327,24409,27111,21527,26301,29169,25145,27311,23082,27503,24716,26725
+X17254_at,325,250,561,128,415,448,174,358,582,-102,454,349,321,303,680,222,640,247,369,167,266,570,324,948,457,529,126,984,394,588,908,1325,536,467,-182,493,328,679
+X17576_at,55,89,39,25,139,7,-53,143,212,49,62,79,41,113,139,-9,182,38,5,224,2,26,157,30,-1,-53,71,15,-48,10,37,48,-31,135,26,-10,24,-32
+X17620_at,770,1405,1702,1095,3334,1219,1093,1281,1963,2328,835,823,2554,1514,1942,1367,2818,860,1397,4320,2386,453,976,1870,1320,1637,1497,1705,1192,1547,620,1165,1459,1162,1672,1580,1023,532
+X17622_at,268,264,585,230,176,165,354,307,281,192,215,93,133,198,139,228,403,346,144,242,64,256,115,318,223,238,491,236,312,304,200,383,403,98,320,306,328,580
+X17648_at,19,38,183,197,92,92,72,227,50,72,49,102,57,102,46,64,204,77,46,-4,96,143,-41,39,75,83,92,324,74,172,301,103,228,-15,121,102,137,153
+X17651_at,558,-187,371,545,-50,250,216,718,451,129,299,175,196,11,-46,110,-240,142,49,-110,106,149,123,427,213,42,-309,619,533,295,292,211,334,2,-256,170,144,318
+X51405_at,-33,1,69,0,16,-90,-23,-1,39,16,7,15,-19,7,20,-15,30,1,-22,14,84,-14,-37,0,52,-18,-3,-18,-36,-67,3,4,10,34,-15,-6,49,-52
+X51408_at,122,53,369,138,40,275,68,521,315,77,74,109,-3,254,58,26,27,95,33,6,28,78,20,40,101,111,76,137,322,114,70,110,64,-9,31,111,149,163
+X51417_at,-677,-388,-989,-427,-231,-524,-366,-637,-550,-311,-91,-419,-325,-251,-407,-335,-1989,-248,-136,-193,-431,-328,-469,-81,-213,-95,-1051,-558,-264,-567,-349,-387,-254,-41,-371,-604,-170,-494
+X51420_at,-204,-188,-175,-311,-87,-8,-174,-56,-57,-1,24,17,-141,-28,-55,-160,15,-119,-104,-52,11,24,-283,-129,-106,-104,-139,94,132,92,-28,113,-247,34,-80,51,-7,-3
+X51466_at,12044,11970,10116,13014,15389,10185,15937,10865,12896,13241,15692,7787,12270,13296,12687,12412,11805,13823,13398,13969,3736,13278,11893,14634,13342,12050,7141,12726,9142,10796,12306,14203,11695,9635,11773,12534,11890,12082
+X51521_at,3989,2774,3694,3637,3245,2272,3321,4253,8351,4430,7186,2951,4956,1806,4438,2005,3782,3429,2568,4760,2264,11801,1480,4330,2358,3872,2065,989,1009,1444,1199,1460,2345,792,2580,1001,2039,3314
+X51602_at,-80,-59,-107,-114,-61,-81,-73,-112,-69,-99,-70,-64,-58,-74,-60,-76,-88,-36,-75,-44,-36,-77,-123,-134,-56,-115,-125,-98,-57,-83,-39,-97,-47,-57,-49,-103,-90,-189
+X51630_at,74,116,7,207,270,40,346,86,78,56,13,30,120,147,51,165,172,71,24,325,114,31,94,296,105,58,68,110,334,28,53,159,56,223,-17,-11,40,144
+X51688_at,335,-106,99,301,221,110,243,-152,186,269,200,-11,148,158,161,21,-143,160,-71,-14,116,92,482,-189,16,-42,-275,-121,-52,244,137,290,175,153,-209,57,-151,13
+X51730_at,-23,17,-31,10,-15,-10,-21,41,22,-13,-31,-24,7,15,11,1,-15,-5,-29,-12,-19,9,47,-34,21,-11,-7,-23,16,4,49,47,-15,-18,-23,-17,-11,-17
+X51757_at,62,-19,-15,-119,-1,64,-95,-59,-61,129,-143,-37,-103,65,-38,-105,-205,-36,-95,-8,3,14,-47,-29,1145,-47,-198,39,-105,-21,-57,17,8,-74,69,-6,-177,-92
+X51801_at,-110,-55,-208,-219,57,-64,-218,28,-71,-117,1,-84,-95,95,-56,-101,-48,-19,-77,-52,79,-130,-110,-52,20,-104,-143,-127,7,-117,-35,-113,-136,-62,-102,-138,-209,-192
+X51804_at,93,154,31,170,174,120,141,100,93,355,268,168,363,142,238,307,464,90,225,393,189,185,243,72,103,75,499,92,233,256,410,336,242,306,297,248,282,369
+X51952_xpt1_at,-476,-482,-609,-306,-306,-309,-329,-736,-545,-124,-428,-242,-312,-435,-360,-195,-702,-271,-152,-468,-218,-511,-389,-326,-447,-324,-682,-470,-577,-431,-517,-692,-458,-189,-603,-541,-804,-910
+X51953_at,-255,-92,-93,-159,-36,-129,-191,-130,-200,-251,-129,-273,-65,-33,-138,-72,-331,-39,-135,-51,-81,-51,-83,-58,-183,-49,-145,-37,-84,-105,-11,-50,-85,85,-143,-463,-483,-126
+X51954_at,24,78,-76,-27,21,17,53,-10,3,-49,-124,37,-19,112,-32,-13,-12,22,107,12,-62,-105,24,-3,10,-27,-67,18,-16,32,59,14,95,-21,46,64,-12,152
+X51956_rna1_at,-66,237,476,-54,43,5,-42,-10,611,359,460,18,-47,-25,35,-16,-57,205,73,174,18,-15,157,-167,1,-25,106,-44,-134,37,52,152,70,11,99,-58,97,269
+X51985_at,-339,-334,-383,-327,-429,-307,-336,-493,-102,-268,-245,-377,-447,-342,-402,-730,-639,-171,-294,-631,-313,-622,-309,-467,-461,-307,-464,-968,-644,-449,-539,-1070,-652,-414,-499,-324,-431,-509
+X52001_at,-10,15,-17,-14,2,-56,-18,118,-38,-4,-13,-28,-34,17,-49,-36,113,-49,-46,42,-8,-17,45,16,21,-67,25,-11,-93,-74,33,-76,-37,1,13,-47,19,-58
+X52003_at,333,-104,260,33,105,40,112,487,339,131,-29,81,70,-19,89,48,-54,111,-53,176,6,-75,199,183,-18,-1,23,158,96,58,60,309,54,242,-76,-112,39,51
+X52005_at,21,-73,118,-98,57,87,164,290,212,14,28,-83,56,38,24,21,-107,74,-40,-34,56,27,49,26,-47,10,-125,-34,36,58,130,13,-83,23,-53,27,104,-84
+X52008_at,18,219,-307,-317,180,-352,-492,268,-277,43,109,-231,95,34,69,33,25,62,-13,564,568,-215,-110,89,28,269,-132,-6,-223,37,146,113,26,106,-295,-240,-141,-273
+X52011_at,247,120,341,30,102,72,142,172,79,16,11,-15,146,94,168,117,519,47,-33,120,89,-19,17,187,3,135,270,79,125,67,-8,-1,175,13,24,64,166,277
+X52056_at,-267,421,-1046,5,484,-743,-189,-247,-548,-408,-504,-159,495,-298,818,-311,400,-445,-267,233,-233,-370,-896,604,-138,64,-1118,953,31,2910,1500,-324,225,1359,2147,651,595,865
+X52142_at,107,-114,-13,190,361,26,191,179,240,96,69,-87,269,159,499,260,214,-10,184,326,122,14,142,277,-46,105,109,-75,-2,-26,-84,-263,2,-23,-49,-10,-36,-212
+X52151_at,334,267,325,155,513,240,198,368,229,344,313,221,170,286,598,418,369,110,301,424,167,205,317,213,489,469,165,737,346,791,323,281,257,382,541,332,467,296
+X52192_at,1166,397,709,969,1196,890,1285,1712,997,372,475,912,540,608,948,831,867,498,519,911,286,614,106,1063,930,767,456,1879,880,1451,981,1112,1629,606,1668,1319,1196,2442
+X52221_at,202,-284,-489,146,222,7,122,-505,178,45,-85,22,-579,204,157,-308,-1730,-22,-290,-1137,92,-85,146,-43,213,-141,-82,-280,-132,192,101,-567,128,-356,-749,15,73,-734
+X52425_at,364,540,1186,358,476,588,415,1112,1406,318,1469,540,623,333,526,211,306,1243,417,1051,41,557,292,325,352,416,386,329,-28,1352,1131,489,404,378,658,296,428,1360
+X52479_at,331,224,624,418,242,328,362,514,256,345,119,202,321,115,258,501,691,264,266,233,158,189,305,255,280,351,541,349,351,364,316,372,344,202,369,321,422,632
+X52520_at,30,50,95,62,67,149,70,109,80,55,80,20,41,60,55,327,214,60,13,21,73,122,13,32,83,43,208,62,33,56,51,33,72,33,24,83,98,123
+X52541_at,77,258,17,1465,649,51,875,142,717,283,187,24,156,154,1080,58,191,306,869,118,869,337,-110,474,455,674,3675,327,-168,2410,520,1,3995,-23,608,260,1065,2455
+X52599_at,76,-7,142,14,-142,229,48,277,115,-74,-121,103,-159,55,55,-97,-383,-39,-40,-143,-89,-52,37,-140,155,-81,37,-246,-64,69,-4,-8,38,-11,91,-256,-281,6
+X52638_at,-29,-72,310,-152,86,-144,-15,376,378,80,-7,-58,395,138,151,147,-377,99,418,8,129,15,-96,-48,56,-112,-430,782,779,204,-351,-16,-139,-11,408,92,0,-27
+X52730_rna1_at,1507,1416,1537,1059,1255,878,1041,2328,1683,1283,1421,510,1118,1261,942,1437,670,926,1220,1355,512,1004,1223,1170,1376,1185,1118,1410,1373,1665,947,1462,1288,920,1035,1599,1338,2027
+X52773_at,-54,-149,-185,248,147,-284,-436,-394,253,-202,219,30,110,296,29,-202,-226,-105,-185,-259,-128,132,121,-142,-174,-188,-255,-99,-98,695,20,-422,-293,-217,379,15,-76,-590
+X52851_rna1_at,11370,12714,17967,10577,13723,10909,8535,11072,15432,13261,13034,6001,10173,13239,13382,11269,12825,8316,6450,13608,7740,4060,10707,12022,6613,9409,5972,7240,6648,10282,8234,6675,9505,7226,11767,7806,7944,7047
+X52882_at,1127,1709,1498,1159,2041,782,636,1085,2454,1764,2068,343,2466,1894,1761,1012,2330,756,1095,3791,2126,882,883,1608,1113,511,621,1096,610,1009,850,1461,1321,832,2796,808,893,925
+X52943_at,293,291,642,200,208,305,699,569,471,230,283,-22,227,282,385,303,438,200,229,278,204,299,351,365,400,285,402,248,601,487,451,481,421,139,335,439,531,585
+X52947_at,12,-24,-12,47,43,-32,-16,43,-36,-7,25,21,-37,22,46,-23,1653,-7,20,-20,-73,-37,13,-45,18,7,29,-64,-55,-8,-1,17,14,27,78,-5,9,355
+X52966_at,8900,10842,9652,9961,10216,7123,7663,6539,10768,9512,6339,5575,5740,10611,9648,9952,8128,7577,8793,12866,13268,7648,8046,8162,9670,7903,2982,9755,7420,8466,9216,12478,10959,5914,10000,9137,11473,10865
+X53331_at,266,316,437,570,233,250,505,700,284,172,364,84,283,248,367,361,325,222,194,354,143,330,334,374,185,267,496,390,567,380,387,338,558,199,404,432,407,741
+X53414_at,-290,-285,-334,-167,-47,-62,-396,-250,-380,262,-214,350,325,144,300,310,117,-36,-119,-101,-26,-262,359,381,-103,327,170,-66,-98,-153,-218,-32,-325,103,107,575,-249,-206
+X53416_at,529,816,985,468,1495,995,742,526,3785,1269,1635,1457,618,5127,549,259,2078,670,-40,176,-6,81,514,1072,-17,464,-1,2573,456,5244,1900,404,899,1121,6817,1735,2460,2753
+X53586_rna1_at,383,123,96,0,22,103,11,1131,86,95,44,163,249,190,62,25,1074,14,1259,8421,16,494,98,38,198,575,139,48,278,82,136,86,91,54,115,117,176,129
+X53587_at,-504,-604,-447,-571,-147,-577,-801,-775,-438,-179,-293,-455,-196,-377,-408,-258,-835,-84,-388,-555,-183,-413,-332,-323,-514,15,-774,-466,-464,-560,-887,-716,-423,-139,-478,-571,-370,-751
+X53742_at,-494,-277,-549,-673,-238,-528,-497,-506,-587,-207,-223,-357,-263,-307,-430,-236,-871,23,-327,-390,-128,-391,-522,-391,-144,14,-477,-382,-74,-591,-530,-390,-388,-198,-329,-799,-500,-541
+X53777_at,13517,13586,7367,12530,16087,5316,5887,9640,13969,10312,14291,10989,14547,15205,14177,15575,15495,8325,14591,17890,15679,9342,6013,13448,14107,13503,11134,14383,8505,5582,13343,15955,12719,12777,12924,10188,11177,10625
+X53793_at,232,329,707,419,1065,460,283,311,1186,518,481,168,412,676,622,284,842,308,171,653,212,83,398,611,331,148,322,142,216,113,219,245,493,330,315,286,150,140
+X53795_at,619,-168,133,684,-5,643,184,271,111,-165,186,464,148,124,133,-44,-369,-40,-37,322,406,204,495,244,311,47,-397,330,175,379,237,-202,293,243,-269,578,265,-239
+X53961_at,-589,-592,-622,-242,-63,-170,-504,-1235,-735,-257,-650,-156,-315,-580,-200,132,-388,-376,-286,-200,-308,-741,-421,-698,-701,-478,-780,-1108,-1002,-313,-175,-1113,-619,83,-591,-90,-509,622
+X54131_at,-107,-38,10,82,-87,46,147,149,-12,33,-6,15,-92,-13,-19,55,20,-39,-1,-46,29,-62,70,-18,121,-104,131,-163,62,-79,58,6,43,-21,122,24,19,79
+X54150_at,-60,65,67,35,25,30,23,5,17,22,17,-64,23,42,7,89,83,-8,36,13,22,24,28,21,49,19,54,40,-21,124,77,13,49,1,53,32,4,242
+X54162_at,-164,-90,-179,-257,-9,-288,-275,-328,-260,-78,-47,-277,-52,-113,-113,-14,-135,-7,-57,-52,-181,-111,-273,-115,-74,-5,-259,-168,-72,-57,-183,-59,-85,-31,-53,-260,-149,-58
+X54232_at,524,497,523,358,322,152,351,-20,68,333,329,155,377,325,431,812,1005,647,506,1139,465,292,378,319,409,675,763,-284,-170,834,446,648,558,265,964,389,462,958
+X54304_at,1145,1012,1890,1758,1657,741,1013,953,1434,975,756,753,1148,1911,1733,1952,1239,739,747,1332,2208,359,611,1302,693,842,943,770,615,916,836,220,758,1181,743,1081,1475,840
+X54326_at,258,171,226,263,500,152,245,278,399,153,301,47,209,328,325,245,280,186,203,740,323,98,231,406,142,172,294,199,108,154,108,189,193,118,201,83,192,105
+X54380_at,-91,-30,-163,-51,55,-76,-42,-62,-84,36,-42,-54,37,-88,-48,-54,-284,-66,41,-77,3,-45,-167,3,42,-49,-212,-125,-72,-28,-190,-47,-46,19,-172,-19,32,-6
+X54637_at,761,767,555,888,676,433,418,976,407,318,575,343,602,657,718,525,890,507,498,874,293,647,596,545,603,542,621,658,923,1039,1081,750,419,334,1368,939,1156,780
+X54673_at,-272,-156,-15,2,-183,-88,40,80,-58,-59,12,-20,-96,-5,-79,-42,-196,-102,-63,-69,44,-23,77,-203,-217,-125,6,55,9,-46,38,71,-32,13,76,26,-12,-51
+X54816_at,285,203,-417,318,152,234,371,377,301,91,225,150,115,173,80,91,269,137,84,235,-9,120,400,191,17,199,328,188,254,256,270,287,21,114,136,291,327,9
+X54870_at,596,351,809,1431,2549,364,1599,707,519,573,266,232,1458,1615,1789,491,635,380,426,6462,281,537,465,1447,945,341,585,549,480,463,415,695,408,153,439,410,564,727
+X54871_at,107,-29,22,156,52,85,58,-59,156,-149,-9,-2,50,51,53,3,-9,-32,22,30,-112,-48,-74,-15,-13,-220,-209,-74,-240,-194,75,-122,-81,-49,-197,200,55,-48
+X54925_at,-41,31,-31,-6,-17,-76,48,-40,-3,7,-23,-50,-16,-37,-40,-10,-67,4,-12,41,-42,5,17,16,-47,-50,-45,-31,-28,-40,-25,-37,5,-30,4,-14,7,-55
+X54936_at,250,30,352,79,-30,87,-8,320,234,85,161,183,129,165,59,154,19,89,62,179,-32,235,119,82,237,-26,-42,187,264,218,359,232,237,119,86,206,272,373
+X54938_at,604,113,798,763,95,177,747,772,637,672,375,372,892,565,428,811,719,545,287,860,790,387,438,685,552,902,710,921,1204,1576,236,868,759,311,-67,600,915,1055
+X54941_at,635,285,1012,530,489,266,426,-38,807,630,1151,150,1136,329,830,268,562,490,169,622,371,57,541,417,217,318,203,114,259,648,417,345,580,318,155,309,-11,61
+X54942_at,563,199,471,748,1104,163,248,295,336,2135,1013,300,1766,413,1250,705,962,1119,638,965,677,134,1128,472,145,509,1056,112,293,376,393,389,1059,570,501,105,247,455
+X55079_rna1_at,473,394,506,463,290,480,668,890,390,300,290,278,384,412,264,486,490,368,290,225,288,479,750,441,686,338,438,419,680,1387,672,212,551,656,1014,446,627,557
+X55330_at,7,53,36,15,14,-33,-33,-62,67,-12,-14,-25,6,66,40,-6,71,0,-18,19,94,1,-17,-5,10,-5,-64,-25,0,68,-77,-35,-25,-9,57,-14,-31,-5
+X55448_cds2_at,-58,20,-21,-138,55,-71,11,-229,182,-61,142,53,175,15,4,244,182,22,139,196,-116,11,-62,-13,1,123,-71,-9,-31,-79,-196,-96,-43,75,89,90,164,-226
+X55544_at,75,182,166,63,129,147,112,89,115,85,-32,93,127,98,101,145,351,40,97,177,29,-53,-39,85,99,70,248,56,28,70,216,48,81,145,56,90,130,153
+X55666_at,1004,1631,2160,1102,868,638,962,1536,1204,991,890,613,1188,755,979,1364,2848,650,941,2602,384,663,340,891,930,1517,1375,1220,418,2256,1555,1936,1427,792,1405,1013,1715,2255
+X55668_at,153,-248,-34,-155,43,-184,-194,-322,-195,-15,-197,-145,-227,-186,-80,-131,-652,-84,-125,-128,-137,-202,153,-26,-115,-50,-381,93,-26,-267,176,-97,-31,1831,505,1123,-24,1945
+X55715_at,15190,12910,14514,16832,18566,13407,12244,16441,16953,17443,15080,16617,15762,17078,16605,18450,17756,16908,16480,15334,13202,14978,10616,15259,17432,16573,21167,18735,15641,16717,18885,21404,18197,19296,17806,16871,16014,19876
+X55733_at,2260,2392,1336,2432,2687,2164,1875,2836,6183,2160,3527,2369,2625,3049,3282,3281,4113,3969,2862,8004,3875,1723,1531,2068,1804,4456,3157,2706,1084,1351,2952,2046,4194,2486,3077,2970,3647,3264
+X55740_at,736,-24,-15,105,105,-71,-3,95,-26,-20,-34,41,79,-25,98,815,-103,-10,195,22,53,-10,-140,7,289,761,425,-25,-60,-46,-25,-12,-6,9,-6,22,-12,19
+X55777_cds2_at,-264,-233,-273,-262,-156,-160,-376,-370,-210,-199,-212,-86,-277,-197,-237,-249,-766,-248,-143,-228,-138,-145,-271,-193,-236,-212,-453,-134,-192,-244,-217,-260,-276,-123,-217,-235,-284,-426
+X55885_at,1078,440,411,1246,217,796,841,952,380,9,481,452,128,839,364,30,512,-58,-176,718,-192,400,484,548,435,101,458,24,81,651,41,-265,406,-33,765,238,671,-287
+X55889_at,16,96,177,19,32,69,57,73,37,9,86,66,49,70,138,125,-16,-9,84,-4,62,66,96,202,87,82,264,78,57,26,2,27,8,31,85,43,70,-15
+X55954_at,15895,15047,14756,16878,17483,12273,14181,15678,15080,15810,16940,16421,15839,16363,14445,16907,15360,13989,17799,14887,18850,15891,15991,15137,15365,15301,18695,15649,13434,13880,16136,16653,14813,16574,15464,14962,15430,14817
+X56199_at,266,279,283,237,611,133,420,832,223,82,160,536,434,176,792,201,184,128,129,67,54,241,161,146,94,216,345,999,658,120,497,182,548,130,117,463,210,1042
+X56253_rna1_at,1123,1552,1843,1309,1316,921,1245,1021,1339,614,826,807,1071,1516,1308,1033,4053,1138,1324,2110,562,928,835,1082,858,774,1455,1494,1481,1827,1242,1487,1107,1875,1031,1595,1644,2103
+X56411_rna1_at,178,183,166,131,141,151,245,77,205,119,107,-7,153,206,56,225,234,255,82,308,183,39,113,232,95,297,291,121,33,11,81,94,9,-10,84,5,127,47
+X56465_at,-64,147,15,-53,18,-3,-72,-55,2,28,415,-63,105,-37,-7,13,-110,-58,11,-139,28,-14,3,-1,-106,-85,-76,-99,-110,-100,24,3,-116,-14,-83,-60,-145,-29
+X56468_at,2689,3072,4174,1894,4091,2133,1545,2012,5840,3042,4144,1521,3147,3041,2927,3088,4061,1641,1880,4740,4687,1667,2226,2657,1685,1114,1232,1219,1108,1376,1863,1618,2105,1280,2612,1644,2065,1917
+X56494_at,2634,1846,4335,1645,2066,1876,1483,1839,10435,3845,5519,2606,3313,1867,3620,1824,3796,5730,1527,3296,113,1377,1702,1896,1896,2557,1985,4610,908,8417,3523,303,3066,2231,6586,2056,1886,4131
+X56654_at,-245,-151,-250,-50,4,-88,-95,-148,97,-33,-136,-145,31,15,-62,-15,91,-249,-92,-89,-59,-44,56,94,-155,-42,-203,11,4,2,-70,-179,-75,-37,124,-86,-117,-406
+X56667_at,414,274,573,344,355,161,262,566,287,465,266,51,473,168,93,424,896,222,308,515,48,231,296,415,214,483,508,549,204,241,142,117,379,125,654,232,447,609
+X56677_at,28,-279,117,1,-47,74,53,-7,230,42,-40,67,87,111,27,-11,-105,-78,-67,-19,67,74,93,-31,-42,116,-17,94,40,214,-155,-24,30,-69,-111,-39,-206,133
+X56692_at,173,65,276,77,112,88,115,41,78,70,113,22,115,57,57,250,162,124,135,73,-9,126,51,120,36,109,54,189,115,87,27,-80,171,9,106,86,48,176
+X56741_at,330,465,326,395,598,154,331,403,329,199,212,283,266,213,539,358,287,245,143,290,142,95,-47,535,247,73,231,133,139,183,272,120,267,201,119,260,469,463
+X56807_at,16,42,29,70,42,62,-10,49,42,74,21,61,8,107,37,-14,15,15,25,22,18,11,-34,93,-4,20,137,18,84,46,65,36,42,11,64,34,31,162
+X56932_at,21121,21146,23203,22197,22414,24183,25128,25438,21732,24313,23553,22286,21630,23816,19980,24890,20217,20748,23276,20209,25685,23348,24983,22077,23920,22776,24166,22175,23307,20269,21733,23393,20883,22384,21328,21079,22945,21719
+X56997_rna1_at,11777,13550,13412,13358,13239,12392,12064,10009,13536,15069,13017,8309,11219,14125,15412,14593,11756,10134,13204,14522,19796,11150,11543,12534,11804,14070,9597,13425,10885,13707,11062,12710,12508,10358,13941,13395,14365,12359
+X57025_at,89,-2,199,24,24,12,-73,97,43,22,14,-35,33,34,18,69,48,26,11,19,-26,134,22,53,-7,56,9,53,-2,-37,101,57,97,-21,-11,-1,59,81
+X57129_at,58,191,-22,-43,-8,24,-31,-5,-78,115,4,396,255,-140,-29,-84,-61,-57,-114,289,-32,31,-106,-4,432,182,-200,239,-149,-56,-29,80,18,181,1004,-60,115,-63
+X57206_at,292,-184,-38,-13,99,-231,-92,158,266,-109,-103,-199,193,730,-32,747,1605,21,146,728,-44,-28,-22,413,-304,266,-250,-22,103,-147,-91,-67,-175,-105,102,-158,-2,16
+X57303_at,244,265,288,307,96,158,174,196,303,184,204,234,200,278,155,184,438,92,108,191,82,173,150,150,183,152,323,291,189,224,288,298,322,109,242,179,360,456
+X57346_at,1873,2057,2551,2231,3229,3010,1918,1728,4119,1113,1170,965,1328,2634,3714,1393,1925,615,583,2361,1858,812,1635,2699,1346,1278,680,1167,875,2284,2051,1316,1121,1193,2039,1962,1999,1721
+X57398_at,565,1087,636,598,1596,545,704,1042,1528,375,1059,459,1036,846,1093,1026,1965,332,751,1986,951,512,461,1156,644,803,721,1467,673,1769,745,978,615,643,1647,949,990,839
+X57522_at,1342,718,53,613,376,417,446,284,441,71,314,441,609,743,2125,348,357,584,349,2096,612,502,-68,534,690,567,-297,186,591,428,398,201,89,215,344,315,312,357
+X57766_at,738,508,938,726,626,583,777,1157,931,664,447,441,250,520,567,555,1133,381,510,1252,543,530,545,713,569,451,1063,762,718,366,685,955,817,343,460,621,859,1129
+X57830_at,-119,-170,-279,-206,-158,-21,-193,-434,-271,-123,-113,-122,-122,-179,-140,-148,-297,-152,-134,-290,-96,-60,-208,-203,-257,-113,-103,-105,-113,-251,-216,-281,-224,-170,-288,-204,-217,-412
+X57959_at,8650,10783,6295,10787,12331,3840,6650,5965,9866,9366,9858,5458,9355,10192,9030,9581,13430,8811,9496,15292,8450,6927,5832,9179,8721,9548,6121,9692,7016,5652,7145,10781,9293,6898,9628,6689,6690,10885
+X58022_at,-75,-115,-214,-74,-135,-112,-176,-214,-110,-74,-154,-57,-120,-161,-220,-40,-234,-181,-40,-395,-42,-68,-106,-131,-158,-153,-247,-184,-88,-219,-97,-109,-128,-187,-132,-79,-56,-271
+X58079_at,-215,-76,-110,41,-29,-78,-104,-485,-221,-62,-159,2,176,-85,41,0,-90,-9,174,123,43,-30,-24,-284,105,27,18,-273,-233,-116,-52,99,-18,-11,150,-172,-215,-216
+X58234_at,-153,0,-29,-107,-6,-129,-94,-200,4,-55,-11,-56,-21,-40,-58,-44,-78,-46,-72,-100,-41,-19,-96,-7,-84,-97,-139,-52,-98,-49,-110,-54,-24,-127,-107,-87,-126,-129
+X58255_at,372,76,379,366,298,368,152,223,172,218,361,129,273,90,192,345,-105,216,328,393,162,376,227,395,389,343,-12,499,322,428,458,713,353,354,72,58,394,678
+X58288_at,-129,-97,-88,-44,-73,-74,-110,872,-138,-59,-97,-10,-92,-106,-67,-161,-184,-117,-75,867,-1,-44,34,-130,-116,-139,-137,-178,-146,-134,-105,-86,-140,-65,-55,-111,-92,-198
+X58377_at,6,91,47,95,143,72,23,1,47,65,92,81,55,95,28,97,125,26,127,86,38,83,119,118,82,55,104,-7,21,29,59,26,108,78,35,5,126,186
+X58521_at,865,726,1028,716,677,825,536,754,598,233,703,370,359,739,725,312,527,199,176,273,79,517,642,647,440,217,549,242,235,442,523,388,673,82,376,383,587,577
+X58529_at,5214,850,85,6750,4902,236,5998,5853,345,256,-40,1802,7400,1424,7938,12403,715,9196,2680,11267,3094,8127,106,8558,1986,14538,9134,554,228,239,540,235,3053,-9,293,514,9130,1252
+X58723_at,239,9,141,118,68,-14,84,25,85,22,80,56,61,55,78,34,72,21,79,50,41,68,66,90,58,65,120,43,38,2,75,86,59,18,96,27,79,133
+X58964_at,5,-492,-65,-682,-373,-336,-620,-1018,-260,-160,-530,-344,-367,-264,-150,-365,-622,-393,-413,-657,-364,-370,-254,-130,-252,-607,-718,-179,-302,-352,-1128,-633,-313,-500,-509,-439,-669,-670
+X58987_at,-50,3,-51,-41,-26,-21,15,-68,-59,1,-67,8,-41,-24,-54,23,-29,-45,-75,-20,44,37,-30,42,-46,27,-59,-15,-28,-69,-32,-51,4,-19,-40,-27,11,5
+X59065_at,85,53,145,-25,48,76,82,20,7,43,113,11,42,-18,11,59,137,47,14,118,26,22,-20,35,10,-4,344,10,-57,56,26,45,48,70,99,66,95,89
+X59131_at,-266,-116,-187,-328,-122,-256,-309,-431,-279,-62,-132,67,-109,-193,-37,-112,-255,-90,-28,-118,-42,-5,-85,-142,-16,-61,-305,-180,-144,-214,-143,-124,-63,17,-244,-277,-289,-340
+X59350_at,1608,-423,583,635,758,675,796,-1347,651,432,-4,386,1121,398,1105,1653,-1,973,1542,3311,884,414,290,671,538,989,790,204,-153,310,-916,-998,86,-436,-201,414,187,-1459
+X59372_at,-100,-140,-108,-198,-122,-172,-272,-223,-139,-130,-119,-102,-132,-171,-112,-173,-216,-60,-178,-110,-167,-122,-159,-190,-15,-75,-201,-240,-141,-64,-201,-126,-162,-122,-29,-104,-96,-181
+X59373_at,402,83,85,202,226,231,233,47,291,59,266,0,133,236,167,260,179,175,15,264,472,278,72,140,255,308,148,222,50,73,118,65,346,61,96,-60,382,437
+X59405_at,219,165,369,185,359,85,320,187,264,136,442,96,413,469,318,181,341,91,135,118,274,159,22,341,13,82,75,156,163,294,140,159,193,158,161,92,188,115
+X59417_at,3016,3424,7724,3821,5216,4194,5528,2073,7782,5204,6541,846,7743,1756,7288,6084,2455,1273,6482,7629,5746,699,2443,3840,3878,3262,1810,782,490,1648,528,99,1203,1561,1628,1784,1214,1583
+X59434_at,419,673,415,463,337,-167,349,578,594,309,322,310,264,455,436,523,459,399,274,588,372,234,368,718,419,285,672,647,461,355,723,584,647,331,411,741,625,971
+X59543_at,302,72,85,96,359,170,3,-97,451,211,378,27,463,485,576,34,250,214,202,322,404,-41,-3,252,156,162,240,-39,16,-29,96,67,150,114,86,-17,47,14
+X59618_at,16,-1,191,55,224,179,115,130,368,483,234,79,155,-14,270,-19,2,154,134,37,-57,19,87,133,0,-54,-45,-20,-2,-50,290,491,530,57,-6,99,6,215
+X59656_at,-494,-153,-623,-133,163,-240,-359,-1016,-279,-107,62,-117,-46,-82,103,-116,-712,21,-10,-22,-217,-180,-288,-128,-23,-162,-605,-410,-300,-167,-51,144,-152,-234,-185,-299,-339,-346
+X59710_at,73,126,50,49,84,48,31,-5,76,31,20,-11,83,57,81,34,87,24,-3,148,69,68,75,-8,-8,17,23,51,2,-25,39,20,15,14,43,26,22,9
+X59711_at,86,72,158,182,83,128,30,185,139,141,146,-7,180,127,103,161,379,57,93,220,49,120,119,153,77,12,132,17,31,-33,58,224,34,-5,2,5,117,120
+X59727_at,39,125,-28,134,130,106,-23,-272,49,117,178,-8,8,-130,113,-51,125,-55,125,179,234,-147,85,42,-95,-88,-131,376,40,45,-85,-266,-65,27,92,-113,-141,-328
+X59766_at,44,-285,161,86,-4,119,174,115,-130,-10,-44,74,-14,-21,0,-34,-101,84,7,-72,44,103,-47,34,3,-8,-17,117,240,-43,-372,-162,-136,-75,-138,60,-220,-12
+X59770_at,237,183,299,296,373,231,268,241,230,167,115,117,166,213,159,155,418,95,158,164,91,205,201,118,107,146,434,329,247,177,222,252,242,90,254,248,315,517
+X59798_at,-697,-617,-814,-552,-220,-489,-613,-973,-837,-345,-441,-331,-305,-514,-303,-481,-807,-395,-407,-533,-262,-317,-566,-369,-518,-369,-816,-595,-442,-530,-531,-679,-515,-314,-527,-486,-581,-734
+X59812_at,-150,-48,-281,-67,147,-85,-248,-454,-187,-250,58,163,-134,85,12,-2,-51,-169,-32,-406,148,52,-134,15,36,-38,-483,82,144,255,-106,110,-53,215,77,-81,-158,-134
+X59834_at,958,8952,3745,1245,1870,2196,1831,1092,1551,2582,4272,531,1140,2883,1402,973,10655,433,690,2348,849,733,968,2084,123,262,510,1522,1214,2044,2320,1471,2163,3008,1109,863,1458,2063
+X59841_at,315,215,464,830,463,286,448,265,378,179,213,84,383,381,852,209,552,231,386,667,144,187,193,1337,53,441,298,1350,343,848,183,256,198,635,485,249,158,294
+X59871_at,202,2182,4175,38,87,2224,15,106,7405,2309,2801,214,88,3883,153,924,95,509,425,151,153,133,2006,40,344,211,20,98,137,7,10,70,92,-2,32,31,175,88
+X59892_at,2071,2001,3442,1692,1875,1719,2007,2415,2473,1637,1662,1139,1409,1720,1745,1477,3108,2459,1758,2114,749,1595,1404,1454,1552,1606,2545,1966,1798,3683,5481,3227,2243,1345,3955,2417,2526,4896
+X60036_at,4615,4999,4417,4858,6391,2937,4130,3929,7575,3849,5076,2447,3099,4105,6915,5538,5876,3681,4512,10237,3722,4827,3693,5403,2318,3472,3357,4648,2883,4439,5113,5985,5206,4335,5157,4356,3971,4775
+X60188_at,1062,953,1478,844,909,745,966,838,1156,948,990,362,843,756,905,1079,1577,851,607,996,323,891,809,1066,930,723,915,1100,752,1092,901,1073,908,651,1110,986,1667,1417
+X60221_at,2126,2651,3332,2160,3061,1836,2286,1214,3700,1861,1955,1191,1819,2678,3211,2590,2049,1339,1500,4704,2903,949,1772,2424,1324,1478,808,1433,728,1759,1796,1734,2033,2039,2907,1893,1936,1880
+X60382_rna1_at,70,68,264,-5,111,-10,3,-86,1,31,25,137,-8,-23,27,11,127,-14,66,-8,-67,49,-15,27,119,24,90,-28,-2,0,45,26,149,22,-2,-28,34,157
+X60483_at,270,168,174,95,244,-16,393,38,33,13,63,73,2,-24,25,110,615,128,-4,261,-126,79,161,234,299,271,416,-60,-62,136,-10,263,-79,-74,241,39,221,438
+X60484_at,124,21,23,21,59,-90,70,-1,-203,123,18,-99,89,106,35,84,43,3,28,4,9,6,-24,119,73,64,-114,156,182,14,14,72,147,14,-135,56,81,214
+X60486_at,2216,1914,6183,4214,4862,2768,1295,956,6588,845,3163,638,1422,1922,9522,224,133,946,202,1040,2045,1229,4664,2144,664,943,228,1444,1964,2317,2376,1410,1099,4523,419,706,1621,1421
+X60489_at,7396,7655,7190,8151,10567,4735,6497,6306,12006,8112,13284,3664,7182,12445,11307,10061,13334,7170,8003,14726,19176,5470,5287,10353,7332,7677,7950,12396,9142,7054,8727,11183,13340,9958,10119,7148,8938,11377
+X60592_at,780,753,776,938,467,430,588,352,481,652,554,383,467,425,268,719,1269,697,405,854,309,320,547,-133,314,401,844,602,519,546,758,414,488,414,878,711,1052,1252
+X60655_at,285,38,217,39,343,1,280,74,502,230,391,77,131,237,128,154,197,191,-27,158,77,236,182,178,348,159,-64,332,199,288,234,309,304,-35,293,349,211,379
+X60673_rna1_at,146,130,293,99,28,124,196,250,217,107,148,-10,24,66,81,37,206,60,11,0,192,221,155,133,51,36,-17,186,214,586,117,105,212,154,705,219,92,845
+X60708_at,-113,1170,-109,-205,-50,-120,-90,-91,-177,25,-50,-91,-110,-77,-16,-117,-59,3,54,-83,-34,-65,-15,-170,-39,-107,-6,-75,100,-61,-48,-44,-99,-45,-20,85,-40,-69
+X60957_at,347,364,269,59,337,-28,-10,242,22,281,179,48,230,301,280,99,281,206,65,431,202,125,281,23,643,391,467,252,38,418,98,344,446,392,194,54,331,419
+X60992_at,128,292,739,-4,11,762,-21,-109,1179,545,1392,33,-15,327,-44,2,-258,-20,91,-16,168,14,509,57,105,70,-29,102,-86,40,150,188,273,-5,90,15,64,27
+X61070_at,-294,-304,-309,-256,-181,-97,-275,-424,-61,-138,-219,-204,-189,-175,-108,-159,-299,-86,-18,-74,-192,-52,-294,-269,-100,-181,-356,-335,-290,-412,-84,-64,-122,-10,-146,-214,-291,-464
+X61072_at,544,329,886,494,365,391,470,676,663,369,419,313,303,601,508,472,784,364,264,534,277,415,400,510,428,350,771,498,420,422,430,544,526,153,302,324,493,819
+X61079_at,-93,-35,77,83,-59,-78,-18,115,-64,25,28,80,-1,57,11,-36,64,-7,-13,-22,-33,41,74,-106,-49,-72,-23,37,-4,312,-56,-122,63,-19,-82,-47,72,3
+X61100_rna1_at,201,242,335,284,335,222,136,173,350,169,170,119,230,311,252,315,445,194,155,568,347,119,193,269,153,142,250,191,139,25,167,118,144,234,143,210,150,109
+X61118_rna1_at,570,416,65,1123,2652,741,1594,328,127,411,-5,380,825,135,1364,293,2628,80,368,924,520,309,108,2274,854,453,472,909,581,640,309,511,991,855,939,965,1375,811
+X61123_at,1091,2427,1164,774,1427,698,544,1475,1802,815,1016,901,1990,503,1819,2318,590,1615,932,4757,1925,2218,389,976,1407,2078,711,517,-2,1660,2079,1356,1571,301,1890,194,684,1813
+X61177_at,-84,64,25,-46,38,49,-38,-79,-82,-42,-12,-14,57,2,55,-75,-45,36,14,-11,-34,51,-28,-64,-36,-32,-106,-107,-96,-80,-33,112,1,-3,-11,0,12,-6
+X61373_at,154,329,57,115,143,341,267,383,198,289,53,119,89,298,175,357,26,121,353,246,-79,277,237,257,129,13,45,30,334,-49,165,85,1,7,443,-180,-1,168
+X61587_at,242,667,419,-100,918,321,-220,-215,691,320,140,879,200,946,408,-14,2127,463,-23,-57,-189,-103,-7,445,140,507,-621,1112,622,2801,812,756,531,2128,2240,1009,549,2189
+X61615_at,237,123,174,280,244,259,282,514,235,219,255,214,179,253,102,266,323,106,152,168,243,160,243,217,179,207,330,465,360,132,354,168,224,227,125,393,632,193
+X61970_at,1286,874,2112,1354,1566,1262,846,617,1399,816,637,452,903,1060,1865,1535,1764,1104,804,1924,293,306,799,1184,600,612,663,617,656,746,574,464,627,646,718,671,468,477
+X62025_rna1_at,1045,768,1015,1016,409,490,1045,1332,445,600,584,610,653,650,659,646,1572,188,643,813,352,750,710,598,769,364,963,849,591,437,1248,785,758,712,553,742,1496,1680
+X62048_at,96,60,286,85,422,12,58,86,131,277,76,28,240,73,373,90,362,157,50,-13,6,61,66,145,54,-31,189,25,-24,-13,-22,50,101,97,154,54,72,-50
+X62055_at,2414,2225,2095,3298,3785,1696,1683,1063,3716,1320,1242,738,1085,3893,2709,2324,1997,844,581,1735,223,431,980,3143,424,1413,791,3110,882,2256,1079,522,965,1752,2269,2872,2487,1250
+X62078_at,19,22,57,101,481,-21,-53,-38,313,9,40,-34,25,-19,64,88,-65,445,106,17,109,-88,-81,96,-36,157,-104,47,211,881,227,-65,186,259,717,221,60,-7
+X62320_at,524,1074,485,370,1242,736,811,371,1002,711,366,362,973,878,933,467,1647,1017,366,947,203,717,509,624,623,759,331,1561,894,14198,5692,770,1582,1582,11369,2094,2598,3807
+X62466_at,6144,2336,1933,840,891,1696,981,2431,3400,1154,1258,2339,1580,4850,1671,2447,1590,1219,3001,5668,627,1200,1236,386,1617,3005,1342,1440,759,1360,906,558,1737,456,733,3827,2612,1645
+X62535_at,509,2908,3979,618,670,3629,248,535,2554,847,723,275,1074,2296,1200,1774,1159,163,565,781,211,286,1335,833,926,821,20,559,214,111,-127,-91,201,189,67,201,369,-264
+X62573_at,605,610,873,543,545,595,840,1042,691,675,503,280,459,587,376,355,848,282,512,203,337,609,104,395,548,409,826,765,598,803,955,1178,718,579,900,788,698,1124
+X62654_rna1_at,631,739,106,352,2028,17,245,281,621,381,373,626,712,800,704,537,648,345,364,1029,748,549,85,773,245,814,384,1907,743,4797,3199,1015,1121,1755,7589,1888,1696,2519
+X62691_at,17558,18299,18932,18403,18893,14762,14692,15940,17723,20066,19659,13728,16268,18997,18585,19517,18731,19466,20021,15432,18597,17079,16143,19061,17686,15452,13249,19727,13008,16221,18534,21215,18558,22220,18526,16526,20593,19638
+X62744_at,4169,656,-39,1242,1368,46,1164,2181,-235,67,-97,869,4105,-1,3296,972,459,4164,4078,9238,178,3283,-170,1585,1282,2581,865,940,2366,1708,1392,127,2095,1224,2539,3025,2431,1977
+X62822_at,66,-185,-76,-2,187,-90,-312,-38,-58,-144,-247,17,-46,204,-2,-198,-225,28,5,-61,-104,109,-112,-55,-50,-128,-314,-138,-52,-147,-215,-51,-107,-23,-93,-189,-2,-172
+X63097_at,-60,39,-72,-49,-12,-16,115,61,14,35,-103,5,-43,43,-42,-1,-62,-21,48,85,-23,60,47,-44,103,-9,-1,9,57,111,48,108,55,203,36,-1,60,143
+X63187_at,-82,77,153,67,131,33,-28,19,93,65,-19,67,-17,159,24,68,315,36,59,123,206,44,41,299,119,60,75,131,144,220,79,121,47,65,143,-28,34,76
+X63337_at,268,193,281,241,115,160,294,449,282,246,291,40,158,219,129,120,335,149,39,232,149,194,167,213,258,182,259,373,230,249,259,298,288,146,190,228,277,305
+X63359_at,177,108,887,79,94,78,134,226,84,219,56,94,230,345,15,410,455,178,97,13,167,146,281,512,202,347,-26,692,324,111,125,189,433,394,265,389,231,214
+X63380_at,-687,-499,-651,-311,-220,-794,-260,-1039,-838,-258,-101,-301,-286,-693,-760,-459,-616,-285,-465,-348,-102,-188,-188,-156,-150,-149,-755,-26,-541,-551,-394,-523,-564,-46,-1131,-201,-169,-26
+X63417_at,65,371,-99,5,363,174,184,254,268,36,345,74,121,229,149,236,298,477,203,176,274,78,41,42,200,64,-28,252,103,615,1000,423,301,334,1025,137,216,380
+X63422_at,674,675,785,743,1025,778,732,572,1418,818,840,616,478,1040,1383,1034,1011,708,554,1555,143,307,640,795,825,1294,463,1016,593,961,903,930,805,779,1162,821,866,772
+X63454_at,86,-48,-25,53,186,-1,65,22,26,-19,117,73,136,-24,-48,190,389,90,115,-4,21,133,5,36,88,3,286,332,271,162,-41,-14,-55,6,-142,133,138,1
+X63469_at,460,151,230,314,632,181,213,227,362,47,225,43,495,442,522,467,485,472,156,629,256,104,172,494,162,348,217,181,74,202,4,-25,28,178,12,115,136,63
+X63527_at,19184,20867,20120,23086,22787,22405,23445,24582,21380,20655,22236,23020,20438,21834,21296,21239,21989,18872,20040,19559,20337,23481,24592,21318,23878,19037,22714,20513,22247,20121,21141,21716,19779,23195,20709,20909,20613,20541
+X63546_at,129,162,242,171,51,81,85,142,168,42,82,64,101,164,19,10,-31,150,86,-11,43,-17,148,68,89,22,151,144,40,53,50,14,55,54,171,69,108,134
+X63563_at,554,176,321,386,468,396,391,253,389,272,485,70,611,454,685,503,1029,358,364,872,361,138,-13,517,28,84,230,445,134,246,232,488,268,330,291,28,187,255
+X63578_rna1_at,84,219,336,-8,-149,257,255,347,317,14,180,48,-19,122,94,80,156,4,-60,-139,212,-73,163,165,27,11,-140,340,223,-32,270,-56,-201,93,107,100,48,87
+X63597_at,133,31,43,47,21,3,36,13,24,67,-20,-8,-7,14,40,-11,67,3,-32,34,16,-9,30,2,30,-16,48,98,57,44,50,64,42,7,48,53,39,24
+X63629_at,-71,35,-136,-515,149,-158,-77,-365,-200,22,73,-173,-40,404,126,-1,76,85,-56,-207,-118,14,-7,-156,29,-34,-6,208,2,154,-398,-57,106,27,-28,-78,299,131
+X63657_at,120,62,80,93,131,108,181,94,161,80,126,67,160,69,116,93,210,46,33,171,192,35,62,78,85,96,134,176,125,77,84,176,87,131,98,51,132,179
+X63679_at,862,899,1308,610,849,465,488,586,1361,710,1818,239,754,456,670,591,1869,338,399,825,128,630,406,750,421,451,391,621,331,1075,747,1092,605,558,1437,578,1181,1227
+X63692_at,703,487,969,342,830,768,483,407,1146,770,863,267,714,721,1320,514,1089,619,702,471,660,266,231,934,549,464,244,532,271,684,561,607,694,347,237,444,470,592
+X63753_at,546,311,1869,449,707,359,544,389,449,239,396,811,853,669,855,554,1088,377,400,1396,251,32,146,778,1805,268,305,241,139,243,213,139,160,146,383,60,319,287
+X63755_at,61,13,286,206,-357,78,149,-118,-7,250,46,-70,196,-42,-490,128,211,200,31,-238,-47,-56,37,-32,54,219,1020,-105,-69,-196,-244,-228,184,-263,-455,-367,63,84
+X63759_at,10,15,79,-66,-20,-97,-50,-68,33,35,-2,-41,6,-10,31,-9,-3,21,-59,-44,-117,9,9,17,2,-2,-12,-68,21,-9,24,34,-20,14,-51,-10,-16,5
+X64037_at,1122,823,1681,554,1024,686,626,1431,827,358,929,109,583,530,498,512,563,520,543,1203,159,939,522,1077,609,622,747,824,865,1468,640,1560,888,375,1071,487,645,1740
+X64044_at,185,254,420,361,342,332,248,211,209,188,87,68,224,63,417,126,319,17,126,457,-84,221,381,628,405,58,48,469,144,333,207,321,253,274,148,364,505,164
+X64229_at,341,336,412,346,416,266,228,175,297,338,298,51,907,295,502,354,890,254,259,349,117,180,239,426,224,72,120,406,156,470,542,219,525,407,331,238,417,521
+X64269_at,492,472,449,499,443,485,578,505,594,281,251,250,365,303,243,424,634,268,336,545,226,302,360,361,408,250,769,516,507,390,409,465,421,150,591,481,432,721
+X64330_at,1000,1212,1481,1213,1425,656,994,844,1531,810,796,235,1452,1014,1201,789,1252,685,719,2229,413,273,476,1083,535,813,629,778,461,857,718,551,657,230,512,843,919,740
+X64364_at,507,1600,720,755,1213,663,887,1211,1556,1539,713,155,1507,1029,1435,750,1619,770,2061,2513,73,28,412,1122,1164,923,179,1166,880,2825,6136,8034,1948,4372,3125,1360,1897,2776
+X64559_at,-260,-159,-305,-167,-290,-216,-152,-427,-145,-471,-382,-103,-231,-368,-158,-177,-255,-38,-328,-22,-292,-200,-115,-117,-295,-127,-704,-112,-105,-85,-129,-201,-414,-89,-227,-273,-316,-731
+X64594_at,-172,-175,-362,-209,-86,-199,-166,-280,-132,-183,-162,-51,-69,-167,-120,-135,-335,-62,187,239,-141,-218,-182,-35,287,-62,-286,-177,360,-103,1544,1288,68,1449,19,-302,-219,277
+X64643_at,91,60,-68,21,73,85,38,62,34,32,2,34,68,47,88,75,100,35,33,123,-36,-14,68,100,29,23,9,-65,19,19,27,54,-51,3,-7,1,44,25
+X64707_at,8408,7944,6325,7491,9729,6175,6501,8322,9403,10535,8492,11334,8225,9850,9132,10996,9004,8508,9413,15600,12191,4689,4364,9874,5546,11023,11237,9939,7384,7047,7365,8833,7963,7192,5321,6711,8180,8774
+X64728_at,310,0,261,150,186,183,297,553,266,105,150,126,255,276,17,251,111,147,189,-225,-67,272,167,-196,170,296,101,-6,214,285,150,72,269,-9,-306,128,61,176
+X64810_at,38,78,1,21,67,8,63,34,16,-10,34,-7,23,52,31,12,143,38,44,0,-14,14,-9,59,52,27,219,49,120,75,114,72,64,-3,54,-30,48,-13
+X64838_at,96,3,22,-52,187,-213,65,-61,8,-22,83,1,270,115,456,151,4,67,39,154,705,-36,56,135,15,143,-145,16,-12,-65,169,-50,-6,-50,77,-9,-77,-42
+X64878_at,143,70,-167,53,46,65,99,-5,131,37,74,57,104,125,144,148,242,104,97,-66,339,54,56,214,139,25,-56,110,-2,99,244,180,0,74,127,71,93,90
+X65233_at,65,-11,-13,13,16,-44,40,41,-3,7,23,10,-28,-14,51,-28,36,30,-40,28,57,-13,108,16,-20,24,71,22,4,-13,35,-16,-8,-1,-11,-3,47,10
+X65293_at,-286,-41,-264,-160,-45,-133,-13,-268,-294,-39,-98,-93,-139,-53,66,-4,84,-141,-127,61,-157,-162,-245,11,-180,-38,-172,1,-158,-88,-231,-98,-174,-102,-70,-77,-241,0
+X65550_at,-108,-155,4,219,88,-30,42,115,377,14,208,-114,586,106,554,6,172,229,219,48,-148,14,315,75,-44,7,70,-75,-2,62,-79,-5,-81,-30,-41,28,-112,-106
+X65614_at,365,248,366,363,236,158,421,466,365,294,248,507,214,196,213,269,483,247,145,193,49,68,246,288,172,104,478,210,226,875,379,225,304,177,267,330,379,794
+X65633_at,-63,84,136,-182,52,-83,-18,-80,-199,20,106,-31,-29,49,-29,114,-172,81,-24,-22,59,-88,-17,-57,76,76,-244,-183,-141,9,-146,-95,80,-143,-48,-69,-98,-89
+X65644_at,337,42,153,208,249,544,446,260,226,6,6,183,102,128,136,348,-2,-11,186,163,24,243,85,430,-8,265,352,-61,93,-97,-90,222,-30,-6,-87,142,-39,33
+X65663_at,-53,-48,-38,-11,10,-14,30,-43,-8,2,-9,17,-10,-8,-77,-76,-49,-15,-47,-84,-22,-54,-58,-33,6,-11,-25,-80,60,-122,-8,19,-23,-17,-21,32,-61,-51
+X65724_at,90,11,237,143,26,96,157,175,192,130,86,38,67,124,38,122,187,87,180,26,19,14,153,176,108,152,192,140,122,13,68,134,195,71,104,113,66,202
+X65867_at,582,347,784,545,699,453,599,518,683,376,351,196,260,893,282,446,747,342,404,1050,427,121,347,624,260,464,655,501,324,510,266,440,422,290,420,503,367,374
+X65873_at,437,502,431,544,296,149,352,422,612,448,539,90,808,481,497,677,550,628,252,826,231,266,302,404,165,540,336,293,84,370,280,404,368,123,325,222,423,576
+X65977_at,35,-13,-221,-254,-23,-103,-201,-89,50,-132,12,-50,-4,10,4,13,-150,41,-53,-154,-1,-43,-144,114,7,19,-231,-40,57,-21,-242,-32,-42,61,62,-78,-86,1058
+X66079_at,1631,790,1086,2366,1919,700,1554,2063,848,565,701,334,1766,665,1481,1194,1253,1162,439,4091,603,584,664,2175,415,535,1797,420,723,445,691,527,513,201,940,817,1269,865
+X66114_rna1_at,-537,-181,115,126,276,316,189,97,353,-3,-54,-41,333,92,286,-207,-639,-152,191,127,-42,34,-381,165,-107,-166,-513,-184,-98,-4,33,-320,-127,-22,-604,395,161,-237
+X66141_at,312,429,192,167,331,167,211,542,175,365,213,97,169,578,366,388,340,370,264,310,447,295,155,405,303,329,297,537,495,367,401,355,414,231,451,134,213,425
+X66171_at,-352,-1194,-1150,-652,-502,-521,-623,-905,-163,-461,-399,-119,-762,-721,-974,-642,-1346,-488,-268,-1312,-254,-432,47,-328,-373,-786,-2015,-158,-327,380,-379,-108,-348,-352,319,-154,-460,-152
+X66358_at,-295,-2,149,-245,65,-279,-252,-295,-344,-239,-140,-275,22,109,-317,-131,-290,-142,-155,56,-199,-183,-150,67,29,127,-284,-302,-40,-138,-299,-159,-143,-121,-91,-273,-277,-286
+X66360_at,-1,35,-2,-18,-12,10,-43,-44,-24,-33,-56,-31,-12,30,13,36,-90,-70,-24,18,-51,6,-3,-66,-33,-10,-61,-66,-45,-44,32,64,-9,-7,9,-43,-74,-4
+X66362_at,-319,145,-218,-226,165,-158,-164,-196,-98,-229,-156,-146,57,29,-53,-126,78,-128,-197,-118,-193,-227,-176,-100,-154,-158,-111,-277,-240,-112,-194,-212,-124,-11,560,-264,-198,-253
+X66363_at,580,257,832,432,632,572,504,946,324,305,499,117,545,415,361,383,293,129,144,-138,-121,451,459,424,520,186,145,420,543,666,197,1030,343,203,616,418,485,698
+X66364_at,934,672,1249,976,568,666,640,965,1054,651,693,234,264,740,649,479,300,445,248,521,337,483,851,875,511,180,352,858,848,781,395,373,657,237,615,838,459,635
+X66365_at,918,637,459,680,680,503,583,409,749,657,-73,224,252,670,793,-183,1549,374,303,368,127,283,455,719,-99,322,1053,802,557,452,150,-638,344,71,715,852,981,-167
+X66397_at,535,612,855,525,818,545,692,979,638,490,885,205,630,967,950,594,1672,536,393,1130,480,285,455,713,438,497,544,586,478,573,480,667,399,251,513,503,494,659
+X66401_cds1_at,1735,1097,1260,982,1097,1134,851,1160,663,916,130,725,2575,1776,3898,1441,1456,1605,2043,2674,482,294,359,1189,614,2147,608,358,379,705,308,198,596,370,558,570,720,451
+X66403_at,611,537,740,238,691,316,801,1082,568,642,423,129,425,215,156,483,911,409,301,828,-63,414,520,440,158,547,898,541,615,874,516,559,728,45,816,685,712,1017
+X66417_at,873,498,1086,913,472,633,998,1098,1061,635,607,231,364,436,392,710,986,435,334,283,228,708,554,581,692,408,751,767,949,892,679,815,847,226,595,856,806,1214
+X66436_at,430,247,434,-15,476,33,43,-133,284,423,218,63,519,198,390,566,-216,426,459,738,-21,173,150,-100,438,273,-363,528,286,699,323,-435,364,281,-26,-30,213,498
+X66503_at,262,126,218,228,442,78,164,226,221,-7,134,-10,250,272,210,80,896,95,15,330,-48,28,18,152,109,-132,86,153,-98,138,37,60,52,-7,49,74,150,106
+X66533_at,205,161,345,70,40,83,3,169,688,62,87,-33,121,150,26,155,876,20,-48,163,-18,-62,-7,132,30,58,118,-49,-64,21,-36,-64,-14,22,-26,-40,-58,-76
+X66534_at,263,218,491,743,550,168,277,383,162,130,161,104,167,198,468,269,1314,16,139,351,77,35,41,616,144,137,122,247,226,73,32,148,97,6,50,126,368,59
+X66610_at,2,20,-26,19,32,81,99,-5,30,91,-4,87,-5,34,75,64,7,-43,40,67,27,-31,81,53,85,-26,79,-70,-86,61,223,113,130,31,117,120,38,230
+X66839_at,180,95,240,203,86,602,278,70,198,123,86,458,69,397,223,156,-80,169,165,66,374,274,290,178,135,43,122,144,168,243,197,199,193,370,114,109,206,179
+X66867_cds1_at,611,122,571,556,674,336,494,479,239,166,306,365,425,450,677,336,763,339,266,950,166,94,256,455,347,495,366,-16,48,106,357,20,390,189,-60,308,387,243
+X66899_at,701,874,493,186,1116,1001,199,199,1601,917,1412,488,1225,1160,1885,887,1000,217,818,2082,2002,329,1134,1292,430,600,118,359,141,431,340,599,228,412,413,104,282,-204
+X66922_at,-8,1,-19,-12,103,12,45,-109,13,76,24,-54,35,5,95,11,112,-26,6,-26,-62,11,-89,123,-31,-58,-17,33,-62,40,-79,45,55,21,19,-52,15,-54
+X66945_at,440,-167,1508,-408,-108,1630,-576,-704,627,667,1641,-2,440,11,-29,792,-212,35,602,81,99,124,231,21,-37,-15,-234,-215,-437,-439,-360,-206,-31,241,-310,-279,-188,-121
+X67081_at,-17,42,-57,-47,32,-103,-31,-17,-39,8,-14,-61,-15,11,0,27,-5,-1,-34,-21,-12,-26,-62,58,5,4,20,-27,14,64,-18,-40,24,-22,73,-39,-19,38
+X67098_at,209,748,588,91,75,595,211,254,123,237,391,89,144,375,38,99,294,99,147,199,126,221,203,282,80,94,39,543,276,200,-18,124,447,73,276,170,412,223
+X67155_at,209,131,296,355,137,213,223,218,371,335,319,89,315,168,229,151,697,323,151,33,79,124,51,179,51,95,167,40,86,135,77,261,219,138,132,188,197,236
+X67247_rna1_at,22121,23042,23885,24116,24471,23810,23571,24964,22521,25118,24883,22803,22140,24793,23118,25433,23812,21445,24879,22448,29644,21564,24132,23256,22816,22484,25119,24887,23848,20419,23681,24456,22391,24868,24357,25812,24513,22830
+X67318_at,-129,-192,-239,-338,-165,-387,-307,-217,-362,-48,-121,-165,-139,-231,-85,-174,-343,-136,-93,-138,-77,-156,-148,-126,-224,-145,-436,-220,-88,-197,-237,-249,-233,-23,-187,-375,-401,-161
+X67325_at,-1148,-746,-1124,-969,-580,-846,-1611,-403,-996,-1064,-789,-541,-469,-617,-560,-997,-1568,-707,-473,5463,-508,-661,-1303,-963,1920,-682,-1129,-1151,-997,-810,-731,-796,-1070,-482,-642,-1245,-1841,-904
+X67337_at,55,78,85,50,112,71,67,37,57,39,34,-74,105,40,147,87,36,-1,46,242,108,-17,60,27,30,-25,65,-27,9,56,1,19,44,26,14,0,2,-26
+X67594_at,132,294,322,149,227,112,470,176,261,138,76,-110,185,244,-107,245,381,-26,246,312,146,61,89,284,172,208,270,66,221,243,110,777,-293,6,-108,406,106,431
+X67683_at,169,449,416,307,317,231,110,83,506,85,165,-15,171,516,407,348,-135,266,172,188,470,94,153,327,304,281,26,413,295,366,44,484,351,211,131,275,118,-15
+X67697_at,187,194,361,116,239,149,213,328,278,173,163,18,234,207,140,272,232,232,213,228,147,126,138,301,243,258,278,238,254,285,287,425,286,91,188,10,270,280
+X67698_at,992,1256,500,1100,1179,403,833,449,1257,833,494,363,1800,398,1646,799,1379,750,962,788,2047,914,163,1270,643,862,757,1210,709,3633,1450,708,1796,2005,4612,1256,3914,2856
+X67734_at,-945,-28,-2024,-1208,-93,-243,-366,-1211,-824,-3,-777,-559,-363,-396,-634,-384,-692,-203,-307,-519,-614,-619,-712,-593,-390,-448,-356,-512,-442,-142,450,-197,-859,-94,-982,-710,-492,-476
+X67951_at,4144,989,1480,5380,7330,1715,7605,4709,3657,1426,2736,1761,5863,1720,10739,5100,1127,3663,3711,7823,1006,430,778,12722,3469,5967,3866,1669,699,796,634,305,2440,685,2054,1317,7234,481
+X68149_at,29,-221,-221,-160,-62,-46,-18,-94,-39,-142,-124,22,-193,-194,-87,-138,-551,421,-184,-94,-141,13,-264,-108,-411,-112,-424,-182,-134,-129,-300,-204,-222,-130,-323,-145,-204,-245
+X68194_at,201,204,134,179,327,106,191,28,188,277,146,90,300,147,328,187,809,198,44,187,103,10,142,374,13,119,122,9,64,-17,83,198,239,422,100,109,273,164
+X68242_at,53,134,75,71,87,80,20,161,93,47,89,70,52,16,96,104,103,78,23,91,157,54,62,104,74,64,81,2,108,74,60,130,73,42,59,62,54,53
+X68264_rna1_at,221,47,33,176,155,424,391,32,143,-241,266,291,-101,73,48,-68,-150,17,107,102,77,74,-110,191,92,-86,-256,124,281,97,100,-35,159,1,22,100,-302,-291
+X68277_at,3987,6021,1855,2825,7373,1458,5649,7820,4563,4169,2545,2162,5028,2624,7081,4959,3238,859,5500,16085,10631,7517,1035,8351,17078,9976,4920,5056,639,7320,8205,3903,13159,1422,7226,1007,8210,8437
+X68314_at,-109,-181,-184,-740,85,-120,-285,-200,-141,1,64,-140,7,-45,-83,-39,-70,-23,19,48,-286,-162,-558,-259,-51,15,-147,-129,-257,69,-11,50,-98,-19,49,-512,-183,-188
+X68486_at,640,955,935,1036,742,553,909,1349,917,632,704,329,541,831,650,652,1021,856,623,382,633,959,505,636,797,732,521,847,418,1572,805,1036,701,440,952,731,634,1437
+X68487_at,262,41,115,255,190,26,312,368,358,293,194,37,161,0,46,398,71,156,207,32,74,249,39,109,63,239,603,59,158,291,128,36,122,94,271,166,309,438
+X68560_at,585,324,425,618,500,174,598,262,617,333,333,103,685,689,822,825,1709,244,494,1536,477,402,210,547,174,188,286,129,36,123,185,174,221,294,102,180,219,334
+X68561_at,194,210,271,143,101,176,188,538,288,182,158,116,185,182,217,255,577,102,194,159,221,143,321,91,87,142,292,207,288,107,314,145,195,61,299,2,307,153
+X68733_rna1_at,550,425,579,763,305,617,707,1100,885,455,358,388,329,429,218,686,1371,529,531,361,346,358,655,477,341,350,965,386,519,808,717,460,484,229,356,782,1105,1038
+X68742_at,30,18,402,6,14,179,45,103,506,147,429,7,42,66,-1,1,35,-4,49,-5,-36,19,5,6,9,26,98,-16,9,76,-31,-1,27,39,77,69,-16,26
+X68836_at,199,94,139,368,631,215,425,176,125,-19,44,-7,187,386,443,184,843,-61,116,363,-68,5,-112,448,80,-211,37,168,238,147,59,170,84,2,141,82,90,495
+X68994_at,220,209,342,478,180,176,504,461,243,178,145,132,187,183,246,192,421,99,219,279,132,179,134,240,175,117,447,200,233,301,220,149,254,115,168,249,292,281
+X69089_at,-60,-125,-86,-100,1,151,-55,-221,19,-134,-53,-102,-82,8,6,-12,-157,-24,-121,-26,174,-209,-87,-104,-101,-15,17,-92,-33,-159,-342,-222,-155,-53,10,-99,-164,-293
+X69090_at,-438,-434,-585,-279,-404,-487,-594,-760,-630,-485,-309,-353,-303,-446,-335,-389,-771,-292,-293,-362,-146,-328,-512,-483,-298,-287,-496,-548,-437,-552,-638,-348,-284,-306,-681,-405,-598,-407
+X69111_at,1778,350,644,555,497,563,448,1356,757,2857,396,1325,1345,875,714,1144,133,1339,1503,669,885,2667,381,306,2813,953,768,297,319,525,565,538,536,243,440,438,668,724
+X69141_at,422,362,615,265,525,120,250,370,1285,469,597,104,365,479,696,644,723,456,276,1141,464,91,218,636,240,480,242,148,31,270,124,371,238,207,311,185,291,281
+X69150_at,20344,21055,21501,21956,23571,20086,25619,22249,20958,22876,23976,22319,21599,22066,21069,23512,22477,24081,24151,17815,27652,21504,20264,24400,23937,21164,24112,23345,22853,20874,21499,24858,21849,26068,20858,24395,23703,23749
+X69391_at,12458,12421,12940,12727,14929,9771,11891,10824,12340,9504,14688,7974,10950,12895,11904,11959,11181,11477,12958,16574,12083,9600,10933,13622,6789,10419,13905,12407,10070,11287,11975,13053,11830,10630,11470,12586,12990,9674
+X69398_at,292,1273,1392,237,151,805,156,301,1089,601,886,182,57,931,268,214,365,128,445,365,828,330,955,114,350,305,353,587,286,70,212,438,246,378,279,316,369,77
+X69433_at,1860,2196,5944,1389,1330,2962,1132,1427,3288,4786,3463,891,1493,1618,2449,1254,1250,1224,1242,2262,859,1213,2336,1617,1012,1321,738,917,1760,1466,2374,1778,2193,2568,1156,1823,1459,1080
+X69550_at,2804,4081,3691,3012,2529,3287,3167,3721,4861,4326,3998,1587,4811,2759,2305,3010,4208,1756,3050,4498,783,2805,2141,2939,1242,4003,3054,3756,2503,7084,3717,3808,4187,2165,5910,4529,4593,5965
+X69636_at,463,246,598,508,291,346,497,463,441,335,267,56,243,349,303,315,482,235,132,279,198,243,284,379,274,303,527,419,425,298,217,494,337,149,303,418,538,580
+X69699_at,1196,1005,1214,1255,658,860,1221,1320,1420,1136,997,311,774,859,767,943,1235,698,511,729,745,574,630,845,949,771,1367,920,1094,1247,807,1130,1028,599,1427,1132,1544,1872
+X69819_at,407,2268,469,45,159,906,-127,-104,2632,840,1791,465,129,1348,346,378,1051,1457,533,339,-23,-19,254,-113,689,1171,610,1177,1341,2299,681,345,1366,1546,1029,895,3673,291
+X69838_at,369,511,101,325,540,268,625,97,746,429,615,71,856,524,1025,598,923,129,243,1728,141,300,197,735,708,767,887,387,577,149,-192,49,108,-135,721,315,97,-73
+X69878_at,375,555,414,498,244,336,418,353,193,456,192,388,419,472,234,463,786,388,267,785,149,253,89,445,187,397,690,519,372,564,510,559,502,127,1061,247,738,1087
+X69908_rna1_at,2899,2745,2138,2624,4815,2171,2296,1314,3641,2355,2294,1771,3294,2453,6338,4488,4005,2959,2617,7565,1178,1889,1922,3868,2998,4179,1933,2706,1964,1969,2196,2933,3081,4095,2965,2553,1721,2968
+X69910_at,456,585,190,347,340,288,273,577,628,134,296,390,495,423,181,250,170,237,491,863,304,563,199,276,320,289,118,104,310,1023,117,76,402,142,762,168,258,1079
+X69978_at,232,356,197,358,237,202,275,248,318,152,176,106,136,275,197,291,394,89,88,378,392,138,231,270,155,184,289,191,134,857,119,259,62,122,159,99,153,164
+X70040_at,1010,801,939,998,351,298,1248,1057,905,733,569,576,610,570,605,1033,1180,587,408,875,261,921,663,538,411,400,869,778,925,1031,1277,1162,945,606,874,686,1375,1832
+X70070_at,193,201,351,379,-1444,-1319,-1246,202,354,-399,-838,-879,-1049,8,-41,36,758,-453,-203,155,-188,-341,-1590,467,89,-894,-1736,293,-372,367,443,402,340,-923,286,231,374,793
+X70083_at,-340,-90,-437,-272,-306,-366,-505,-163,-440,-117,-192,-71,-259,-186,-454,-355,-603,-193,9,116,-96,-105,-362,-133,-237,-314,-353,-201,4,-238,-225,93,-451,-35,-162,-130,-288,-139
+X70218_at,1939,1829,2260,1031,1665,926,1283,1292,2502,513,1124,751,883,857,2004,1617,1962,1482,550,1945,101,1150,889,1310,862,1456,1042,1329,1077,1868,1226,2059,548,1052,1678,1339,1735,1184
+X70297_at,307,186,282,467,146,26,275,535,269,223,203,142,114,196,110,336,199,180,219,158,204,243,260,179,202,231,35,677,670,517,342,475,346,2328,749,702,522,607
+X70340_at,22,24,78,79,11,-113,1,155,30,-39,-2,0,32,80,-26,-9,-10,-21,-39,9,76,34,72,144,-4,71,40,-213,4,-49,44,85,20,-70,-56,-47,33,72
+X70394_at,607,380,509,406,675,231,472,524,290,224,279,183,668,796,754,563,2522,517,320,920,446,158,321,858,306,295,439,121,180,165,118,417,288,98,90,87,287,420
+X70476_at,432,79,283,487,559,264,289,133,401,121,-3,103,321,371,673,589,565,323,366,1178,918,168,237,348,112,98,-70,212,93,165,187,152,155,286,227,86,-4,52
+X70649_at,95,116,108,238,382,58,124,-16,302,47,163,-25,304,284,432,271,219,86,107,832,388,60,284,321,88,-25,-93,168,7,136,102,32,112,145,11,82,32,-237
+X70683_at,1062,5229,3991,2035,2613,3241,982,3911,3421,6868,4234,1863,4569,1356,3463,2549,1826,1904,1692,9711,568,3640,3682,2844,2793,3442,2555,1838,812,196,186,2786,2318,643,286,1236,5703,1645
+X70991_at,34,186,-116,434,64,588,151,5,65,434,439,264,40,252,49,34,-131,100,38,-3,-183,122,416,-59,225,-213,489,14,55,283,781,337,67,250,664,115,65,89
+X71125_at,55,45,27,3,55,-40,-20,23,42,28,-14,12,10,64,-10,16,47,70,12,53,17,40,66,-18,25,62,7,26,96,81,32,57,65,-7,17,5,66,18
+X71129_at,514,605,773,245,954,490,290,79,1316,882,812,290,388,922,562,629,800,454,360,594,236,230,507,604,344,658,98,397,238,535,622,366,587,340,836,555,707,437
+X71135_at,132,-7,-171,352,178,10,42,-275,-33,6,66,-300,-12,11,81,175,265,106,181,-268,147,261,125,-26,134,224,-112,1,163,-218,-589,172,37,-262,-255,-32,83,86
+X71348_at,-154,-179,-266,-294,-84,-277,-258,-403,-284,-188,-190,-122,-165,-151,-142,-186,-265,-121,-155,-194,-17,-78,-254,-170,-196,-101,-159,-287,-242,-149,-215,-268,-187,-226,-227,-160,-287,-315
+X71428_at,4631,4481,5366,3243,3397,4966,4424,4850,6076,5158,4461,1468,3098,4624,3478,3906,6434,1536,3023,8310,2429,3031,4770,4179,2749,2950,2808,3720,3246,5057,3825,3333,5848,1549,4636,4521,4716,5302
+X71490_at,346,625,735,402,792,311,-3,-598,375,445,547,119,814,222,1053,748,952,440,101,1027,-316,56,18,704,69,898,531,8,55,855,-466,-498,-172,53,261,156,374,-428
+X71874_cds1_at,1820,1085,3048,1295,2188,2459,1922,397,837,2225,-1,855,1870,1772,4579,2469,946,1069,2703,3273,441,-39,824,2076,1043,3538,968,486,920,2449,-359,195,1301,933,1380,1999,1439,109
+X71877_at,194,162,353,111,153,129,142,1,146,206,180,87,71,170,173,199,179,133,120,190,187,243,208,180,158,221,223,148,-163,106,171,253,236,-66,319,168,219,281
+X71973_at,1975,3294,3022,2574,2092,1966,2036,2157,4058,2235,3053,1373,2136,1651,2953,2404,2418,3491,2037,2524,139,941,636,2886,1726,2870,2390,1861,1829,3464,3493,2940,2618,2229,4071,3651,3881,2920
+X72012_at,132,-203,-480,-126,245,-145,11,-424,-602,-469,-440,-25,540,-607,173,954,134,-160,1351,173,-24,-71,-587,168,31,632,-170,-274,-98,309,-596,-458,955,9,-11,-419,244,60
+X72177_rna1_at,336,343,596,287,207,309,366,427,284,136,324,159,180,324,218,152,584,256,234,167,73,330,359,323,201,145,571,443,259,461,216,140,443,146,415,477,517,576
+X72308_at,455,133,595,228,83,398,357,349,352,-25,141,140,216,132,100,193,520,245,-40,89,-116,82,-41,114,333,127,422,429,278,341,709,5,418,83,86,325,-34,536
+X72755_at,232,380,481,185,159,250,359,442,465,103,205,110,191,189,314,259,647,224,255,365,192,256,134,133,132,284,464,220,153,189,358,409,367,269,394,159,244,352
+X72790_at,45,184,58,249,174,245,43,173,-54,186,17,66,96,326,233,176,347,67,282,614,61,136,-60,241,103,205,214,108,194,-159,-24,125,-23,33,157,71,39,60
+X72841_at,612,713,648,641,954,554,258,260,1486,626,882,537,1917,1074,1208,820,1789,687,304,1586,700,273,501,925,686,548,287,537,384,398,673,828,1028,752,406,507,568,368
+X72879_at,213,211,360,258,147,273,253,314,235,79,115,205,44,173,146,42,300,116,182,92,106,162,49,100,147,55,123,103,259,140,227,275,274,-11,90,200,249,416
+X72882_at,-425,-500,-485,-625,-284,-521,-710,-905,-458,-343,-323,-428,-283,-452,-257,-342,-943,-383,-314,-519,-367,-349,-417,-380,-476,-333,-1051,-443,-591,-482,-639,-696,-471,-278,-483,-616,-559,-831
+X72925_at,-209,-202,-567,-282,-145,-103,-174,-317,-222,-167,-305,-96,-175,-171,-111,-222,-417,-243,-129,-215,-138,-205,-125,-373,-186,-298,-325,-306,-168,-267,-218,-203,-245,-194,-203,-163,-431,-245
+X72964_at,1283,569,1021,662,734,401,499,917,1247,711,555,1096,1067,680,704,737,1018,439,307,992,627,381,883,871,557,562,655,622,476,451,561,498,642,382,654,723,741,638
+X73079_at,83,56,68,72,87,55,-33,-187,-29,-90,14,50,-10,44,145,-63,114,-26,-27,-165,171,22,15,196,26,75,-23,60,79,28,-129,-4,35,-9,-112,11,17,266
+X73113_at,1093,675,964,978,564,602,653,1001,470,471,444,712,509,369,531,737,794,450,526,886,237,765,708,493,646,374,1146,700,829,832,923,558,647,348,508,776,1125,881
+X73460_at,16446,16711,15989,17335,20994,16798,19862,15408,19629,21450,18922,17680,16966,18184,19412,21088,19105,21570,19680,18075,13573,17342,20450,18841,18958,18364,16958,19288,16062,17964,18259,20486,19478,18628,17824,18678,19534,17986
+X73501_at,-195,-160,-263,-132,-151,-129,-152,-323,-187,-164,-141,-64,-131,-151,-72,-199,-316,-165,-194,-229,-86,-104,-205,-214,-165,-223,-201,-153,-170,-229,-201,-256,-203,-122,-121,-197,-250,-310
+X73608_at,145,-2,79,237,78,206,53,-250,-2,78,-79,58,77,49,112,-72,-169,3,-137,157,99,34,113,9,143,24,162,45,108,-53,6,-232,121,82,-111,74,130,302
+X73874_at,-24,0,-11,-94,-13,23,-112,-7,-37,12,5,109,-57,-62,21,-49,85,55,-20,-96,56,-22,26,29,-58,-23,-147,25,19,-147,-88,20,44,-55,-61,-65,-1,-17
+X73882_at,-73,79,9,56,-37,-37,262,-38,-36,-30,20,66,-105,4,25,74,120,-33,38,-150,17,7,94,135,33,-46,84,53,36,-82,21,45,-7,-10,47,-37,274,-157
+X74008_at,1317,869,1531,1016,1927,1162,651,796,2208,1392,1413,547,1469,1586,1908,1576,1910,1360,1190,2907,3824,1105,1400,1146,569,776,691,610,533,1171,929,856,902,731,1452,882,906,440
+X74039_at,106,-8,181,104,28,152,114,59,19,107,32,136,158,68,125,28,131,125,-33,82,73,39,79,98,59,210,154,191,156,83,131,-49,85,6,280,128,173,85
+X74104_at,1359,1694,1848,1287,2055,1043,1199,1469,3919,1634,3038,635,1525,1794,1805,1803,2632,1598,1346,3533,605,1018,1195,1962,1017,1288,859,1611,1247,1986,1341,1433,1478,1477,2668,1640,1561,1457
+X74262_at,1372,1184,2221,1051,1370,1306,1339,655,3593,1058,953,209,1624,2050,1995,1625,3139,882,1459,4253,768,176,862,1409,489,716,500,279,336,194,130,51,596,309,313,275,311,19
+X74295_at,310,-86,313,219,237,490,110,1042,281,532,480,232,212,202,338,199,537,54,-42,242,288,309,324,532,90,260,104,368,658,271,277,79,325,258,751,145,438,78
+X74328_rna1_at,810,290,408,114,75,-26,137,443,278,367,459,27,119,463,11,257,546,133,82,598,-91,164,85,93,199,53,522,164,76,125,516,267,95,267,328,119,104,344
+X74330_at,232,229,431,306,171,263,161,1,483,398,284,114,309,282,252,51,480,143,193,251,74,37,376,387,185,32,-62,-12,146,62,310,299,322,383,-34,153,17,40
+X74331_at,132,98,217,100,120,72,149,79,270,86,124,17,283,217,146,85,213,156,132,259,119,68,7,157,38,98,200,78,122,93,11,110,75,73,18,53,20,119
+X74496_at,347,268,573,149,462,195,226,263,452,157,339,44,393,388,325,231,379,200,213,434,303,219,233,411,147,256,109,248,302,370,367,435,272,157,364,85,291,122
+X74570_at,150,349,220,453,189,177,591,47,207,376,221,48,85,204,519,220,482,333,123,156,-153,170,-720,-52,339,236,206,766,403,589,410,372,593,247,126,685,428,1009
+X74614_at,1144,1058,1579,1643,679,1573,1589,1416,1783,1080,1120,811,772,945,1052,1026,1402,856,783,903,645,979,1356,1371,861,930,1854,1155,1019,1294,927,754,1293,1093,1408,2346,1980,1895
+X74764_at,593,483,1338,292,395,316,500,971,1033,911,749,68,792,483,636,704,1408,610,597,1324,308,357,117,572,474,1023,658,804,209,1148,432,1015,601,229,94,383,684,1332
+X74794_at,1073,387,953,251,850,1689,1023,862,1827,576,459,354,1221,29,1689,200,1077,466,352,71,94,52,571,304,491,633,738,-515,918,416,-51,1568,523,238,374,434,-513,455
+X74795_at,2792,2755,3185,1681,2557,4786,1681,1589,4263,3918,2464,1382,3242,2109,2868,2092,5971,1889,1528,2985,1068,1103,1924,2133,1378,2550,1411,1495,1575,2109,2975,2950,3525,2112,1916,1980,1341,2474
+X74801_at,575,600,867,928,2204,860,445,505,1825,722,1369,534,1039,1084,1703,1001,1804,440,766,3802,469,163,813,963,525,1031,641,373,226,321,390,304,463,344,505,443,521,253
+X74819_at,4,78,228,51,68,184,119,-7,157,120,131,80,87,38,50,170,71,111,91,60,13,215,150,170,101,197,25,101,341,168,51,191,116,6,13,79,80,280
+X74837_at,3,92,-103,30,-94,-65,-60,59,-109,-201,-110,-20,41,-14,74,5,2593,3,51,16,-74,-26,-26,-59,40,-46,-136,-16,-45,-258,-74,156,-39,7,-26,-28,432,-159
+X75042_at,415,521,190,207,239,204,134,169,293,117,460,339,157,263,328,159,246,257,184,174,119,245,161,105,482,180,190,402,264,818,881,514,760,183,1121,201,379,779
+X75208_at,501,395,667,606,557,448,823,697,504,420,521,270,603,405,887,778,797,483,449,1570,333,493,459,479,445,664,525,496,553,516,433,499,461,430,219,494,726,947
+X75252_at,1162,1710,610,1626,1250,417,1080,772,1401,699,1146,968,1045,985,1956,874,2913,524,1028,2392,1335,717,569,1333,1517,773,409,913,697,307,546,898,1124,997,779,1186,1678,736
+X75304_at,574,627,553,676,695,419,631,545,714,788,311,196,568,491,586,725,1816,480,521,941,282,367,233,767,409,498,616,619,387,313,333,906,512,428,1026,342,604,708
+X75308_at,37,89,-1,-8,24,51,115,-70,17,-4,22,0,37,34,2,22,204,59,-7,29,29,35,85,17,59,34,43,99,93,87,1,102,-8,-43,62,34,73,-27
+X75315_at,359,555,-161,-117,487,120,337,1809,-37,65,559,794,347,437,374,379,-619,-10,722,1436,93,3325,176,316,824,227,-142,-89,48,70,1277,1602,957,907,138,26,283,1356
+X75342_at,317,350,313,540,168,136,593,215,-35,-59,224,298,171,381,301,306,947,274,32,417,201,234,275,217,477,332,444,18,281,495,316,359,474,127,385,108,272,652
+X75535_at,-4,-26,-171,-114,44,-172,-147,-248,-63,-107,-80,7,38,-32,-58,-105,-76,-91,-37,250,69,-147,-125,-13,-49,-44,78,-57,12,-106,-94,-106,-148,-34,-114,-129,-147,-258
+X75546_at,11,146,216,118,4,225,193,170,-41,239,212,57,92,142,-14,270,248,180,153,254,9,187,269,2,149,177,192,215,177,446,188,168,218,98,262,392,270,538
+X75593_at,782,337,902,678,1168,522,1265,1088,895,607,496,686,1053,472,1050,870,1299,1257,1407,1308,1141,221,340,1011,918,879,726,1023,651,1058,1653,1422,1724,808,1116,1066,840,2450
+X75756_at,-43,-19,241,-197,94,-97,36,73,49,16,-82,-38,5,-3,-69,-88,-14,154,-49,107,-7,-121,-13,-31,4,183,4,84,-4,29,-175,-151,-124,-54,30,6,60,-198
+X75861_at,1820,2189,2233,1322,1614,949,878,1181,2724,1498,2110,916,1686,1538,2108,1289,4369,947,1192,2635,317,928,1257,1969,1030,855,438,1214,791,3085,2487,1982,2067,1748,3260,1950,3027,2043
+X75917_at,-244,-232,-384,-256,-177,-320,-314,-373,-290,-178,-242,-133,-116,-222,-157,-182,-234,-207,-121,-145,-139,-138,-191,-162,-219,-211,-292,-209,-175,-258,-317,-199,-231,-113,-180,-201,-237,-239
+X75958_at,-66,48,6,-24,-16,5,36,-106,20,-8,-9,-1,-10,36,-31,-18,22,0,-12,-20,-72,-1,3,-22,5,11,-35,-46,-93,-9,-21,34,16,-1,29,-22,-10,-60
+X75962_at,531,370,385,234,335,257,359,350,298,299,436,179,506,388,554,427,788,368,509,1015,371,409,277,541,288,685,420,404,201,339,343,472,387,380,233,256,453,275
+X76013_at,2124,1825,1354,2182,2861,1346,1823,1938,714,1623,2369,918,1664,2569,3025,2416,2409,1749,2044,5711,979,1297,1609,3009,1296,1945,1699,2281,1738,1841,2175,2461,2039,1847,1994,1594,2255,1285
+X76029_at,93,91,138,121,91,161,126,161,180,142,142,93,76,112,84,92,175,102,130,156,2,52,127,107,120,-14,150,134,173,155,180,120,172,74,155,130,125,104
+X76040_at,190,292,262,82,174,350,157,200,730,670,542,76,245,142,309,174,205,95,101,384,83,194,37,180,162,59,100,151,84,206,224,125,128,259,200,173,195,298
+X76057_at,74,146,155,-61,327,158,18,-136,550,152,-3,-14,227,575,234,43,462,187,173,360,269,-128,108,344,144,188,-123,-24,204,222,-10,33,266,61,82,218,254,-134
+X76059_at,-34,40,7,460,14,389,122,-61,-54,74,-6,-10,-42,-39,-26,88,98,90,53,100,337,-171,96,-141,260,74,755,-56,-81,56,336,78,-23,-18,481,-28,110,155
+X76061_at,210,216,250,139,270,67,193,167,152,-20,71,38,418,449,335,253,413,121,211,166,266,-1,-37,364,35,97,92,34,40,58,14,-41,75,11,29,-32,165,-15
+X76092_at,-50,-16,-59,-90,-79,-99,-107,-170,-102,-84,-119,7,-2,-119,-18,-59,-89,-16,-67,-74,-119,-64,-49,-105,-72,-110,-170,-59,-110,-89,-120,-98,-78,-18,-88,-90,-76,-99
+X76104_at,453,345,638,310,326,531,415,877,605,448,351,283,446,600,398,544,1593,394,204,957,132,245,341,512,512,362,652,723,363,557,346,455,647,217,388,472,854,365
+X76105_at,-278,-103,-631,52,423,-263,346,-370,-98,-28,-59,-224,88,27,484,10,-107,4,396,652,94,-176,-208,79,-76,65,-729,-254,-182,4,90,-275,-305,183,754,-109,99,-444
+X76132_at,509,190,334,251,274,531,233,437,211,131,389,181,283,469,144,351,219,318,103,179,329,457,469,439,394,322,139,429,476,148,353,290,234,29,150,187,203,252
+X76180_at,-105,-61,-172,-25,-73,279,141,38,-56,39,-184,22,-5,112,50,-109,-238,-79,-64,235,-323,-90,87,-128,-64,92,-23,-18,185,342,12,-109,36,107,-115,-85,-22,43
+X76228_at,742,843,647,806,1263,542,888,889,780,576,692,383,776,722,1328,706,1531,654,353,1524,382,589,490,897,628,512,405,600,401,749,590,793,751,679,734,499,567,745
+X76302_at,1401,427,605,642,648,611,606,536,1032,399,473,133,331,511,635,462,1038,444,322,1000,1575,266,387,839,394,510,309,377,319,350,764,674,536,370,330,404,621,426
+X76342_at,10,34,-21,-6,-12,-23,-72,56,-3,16,-23,-28,7,5,20,22,6,27,0,3,-12,-88,51,27,-13,2,45,-22,-28,34,-10,11,29,-2,-4,2,38,-58
+X76383_at,-1,-80,49,-6,-40,-42,-16,1,55,-12,-66,-44,13,15,29,36,-5,13,-75,-22,12,-47,-17,15,-18,0,-89,0,-26,-73,34,63,34,-46,-30,28,-35,-13
+X76498_at,-187,-112,-226,-199,-71,-170,-178,-251,-158,-93,-136,-152,-70,0,-2,-198,-177,-38,-120,-180,-1,-34,-85,20,-117,-33,-173,-99,-74,69,-136,-47,-185,11,-21,64,-193,-127
+X76534_at,-27,-10,145,-55,7,69,-40,-68,-58,19,-7,38,22,-39,42,-5,-13,3,4,29,31,-14,81,-17,10,-4,17,30,26,16,56,49,33,26,116,-17,83,-48
+X76538_at,562,639,538,769,834,659,912,706,598,431,333,331,501,570,793,545,1345,439,414,1180,294,275,379,843,466,456,449,504,586,603,330,236,385,235,464,852,550,380
+X76648_at,1361,237,1240,992,1233,401,821,1012,929,330,512,90,827,679,1426,1578,660,541,1225,3081,1620,532,303,1463,416,1134,477,110,209,358,254,550,214,514,147,159,165,307
+X76717_at,1878,1652,1572,2161,1307,978,875,1622,1233,2688,1292,1302,1659,1459,1210,1597,2569,1404,4313,2757,759,6341,1421,834,1500,1633,1146,1745,1733,2207,742,2239,1810,1463,2143,1926,1522,2486
+X76732_at,139,1610,1575,383,485,846,344,172,1475,1309,1256,273,297,369,784,424,3361,106,212,1052,2642,30,1067,584,266,234,301,1004,548,752,357,303,396,904,923,697,947,516
+X76770_at,1553,839,1409,1417,706,976,1297,1563,1006,829,527,620,773,989,711,640,1522,441,790,1092,347,609,805,921,603,778,1153,1058,1002,748,718,820,1062,371,822,1263,1187,1574
+X77094_at,1370,1188,49,864,891,60,831,692,114,49,91,893,517,68,1419,517,1347,249,208,3177,533,1107,3,919,841,922,505,788,666,987,198,128,183,286,691,824,735,168
+X77166_at,18,21,23,-29,148,51,60,40,46,-21,70,-7,56,76,72,32,-75,43,28,-151,-56,-28,56,-3,67,-95,95,52,-2,-16,-639,5,5,11,7,83,-29,79
+X77197_at,72,77,117,142,192,67,57,115,53,37,89,47,78,42,116,114,19,67,62,44,302,5,60,79,89,73,142,25,100,74,67,78,63,90,50,105,68,84
+X77307_at,214,89,44,54,26,110,26,-31,2,148,108,41,130,213,130,233,120,91,184,88,-43,39,100,63,166,101,215,83,14,-3,77,47,19,66,43,-18,35,-20
+X77366_at,-53,-101,175,-127,366,37,6,-167,221,-121,39,-17,207,55,158,150,76,136,53,265,286,31,-20,356,-40,319,-129,-47,0,-109,-293,-47,-127,81,-146,-156,-182,-265
+X77383_at,-317,-140,-203,-47,-102,-62,-109,-274,-20,-177,-96,10,-73,-114,1,-131,-213,-165,-133,-85,-67,-133,-47,-14,-139,-165,-139,-249,-127,-105,-145,-170,-112,-74,-143,-56,-141,-292
+X77533_at,-161,-197,-31,-346,-205,161,-463,100,-215,-73,-68,-185,-173,-119,-16,-259,-511,-200,-208,-195,-39,-261,-144,-172,-200,-166,-322,-333,-312,-364,-362,-320,-278,-89,-394,-446,-450,-454
+X77548_at,493,407,814,409,706,442,300,731,1485,471,601,212,767,761,583,466,3342,81,782,2362,557,192,241,417,358,291,123,356,521,981,858,1177,431,1240,1076,612,535,1030
+X77584_at,1180,2216,3247,1335,2196,2021,1110,835,5312,3922,4614,1465,1810,2889,1678,1661,3862,1856,1461,1087,3640,455,2631,1431,1775,951,979,2619,1695,1697,2054,1428,2378,2374,3782,2761,3367,3437
+X77737_at,158,-66,98,219,93,-87,371,1418,-153,42,79,119,191,226,56,-12,68,90,4530,1956,113,431,55,-32,2314,319,-258,55,1916,191,10263,10149,1127,5180,1122,-194,551,3976
+X77744_at,5,66,47,26,59,-78,35,5,52,14,50,-90,114,59,124,12,36,39,-4,30,-33,-47,9,54,-28,27,-28,-17,-31,17,-44,-64,-1,31,-76,-48,26,-15
+X77748_at,19,1,10,-26,19,1,189,106,47,10,6,1,-89,45,0,-26,-24,-19,-13,-39,-44,40,60,11,-44,-14,28,54,9,64,66,33,59,11,-224,64,37,42
+X77794_at,775,338,297,398,1033,94,278,289,1043,687,1482,342,929,686,1590,1021,1738,1155,924,2017,4416,351,189,711,532,564,442,477,430,196,486,762,885,987,491,561,583,207
+X77909_at,82,-403,-5,-159,307,-151,62,680,491,73,204,-80,146,36,-65,127,718,201,194,374,-93,-10,-110,122,424,373,98,-88,293,15,342,509,420,258,363,-20,51,605
+X78031_at,594,321,424,458,574,327,500,500,447,369,199,507,2615,404,687,522,1316,262,346,446,76,124,533,319,952,1053,524,475,206,425,309,1538,415,317,415,372,588,458
+X78121_at,12,-157,-197,-154,18,-71,-70,-230,-111,-121,-91,-77,-91,-86,-101,-87,-102,-57,-145,-83,-96,-143,-140,-107,-101,-112,-201,-163,-84,-69,-142,-158,-151,-54,-179,-75,-208,-201
+X78136_at,7558,7993,7274,8575,8059,7201,6864,6361,12228,9454,8724,4697,6708,5443,10561,6011,12432,7281,7879,13304,1945,7593,6360,9366,7250,5035,4404,7940,4159,9319,10467,14025,9274,6923,11875,6925,8324,9091
+X78342_at,-212,-58,-127,-100,110,-122,-119,-125,7,7,-125,-30,-41,-35,17,-46,4,-129,-75,75,54,-99,-123,-9,-55,48,-219,64,-57,-184,-259,-110,-167,-49,-117,-198,-101,-337
+X78520_at,-108,-87,-112,-71,61,-65,-78,-244,-53,37,38,-51,48,-20,74,12,168,-114,-3,131,-127,-167,-110,-46,-62,-28,-122,-168,-264,-106,-60,-133,-95,27,-65,-168,-54,-184
+X78549_at,567,657,593,-173,395,-35,119,614,-202,-103,466,287,75,-261,-73,-58,1151,580,136,294,181,-103,-279,452,395,164,291,190,209,637,-109,573,650,106,737,145,264,1181
+X78565_at,-55,-104,-67,-131,-13,-85,-16,34,71,-3,-10,-2,-23,-65,-69,5,-36,93,-215,-224,94,-126,-62,-4,-62,5,21,-67,-36,47,-160,-148,56,-59,-48,56,0,-61
+X78578_at,7,-43,17,-37,-26,-40,-25,44,-30,-39,-26,-41,-73,-21,-5,-21,-17,22,-28,-21,18,-44,-5,-36,2,-15,114,-90,-14,-58,-1,-17,3,-18,-15,-6,-55,-37
+X78627_at,645,471,575,285,784,168,240,452,596,281,338,178,560,355,588,482,1342,241,311,1508,301,193,429,486,191,287,311,301,331,178,206,299,308,249,168,292,371,231
+X78669_at,427,306,242,262,366,81,179,295,320,186,351,123,218,217,315,239,403,105,312,344,522,79,134,430,231,208,148,115,153,89,143,163,187,134,73,51,281,119
+X78678_at,-313,-241,-498,-516,-221,-424,-500,-421,-185,-282,-190,-285,-201,-160,-298,-252,-701,-162,-248,-326,-78,-360,-509,-328,-255,-182,-195,-378,-298,-220,-90,-303,-364,-285,-424,-406,-534,-394
+X78687_at,37,103,74,158,121,80,349,97,395,281,276,61,147,23,53,46,92,244,-125,63,137,-19,-94,110,122,52,65,72,-28,271,176,-20,126,89,322,91,455,335
+X78706_at,-282,215,-466,-1044,235,53,-720,-986,78,-41,242,-633,176,-418,20,-32,-328,374,169,34,-49,-74,-258,315,-291,131,-999,-291,-322,855,-1180,-66,-403,165,1423,-7,-553,-711
+X78710_at,-59,6,-55,21,-72,37,-97,-44,-67,20,80,45,17,-44,-13,12,-130,-148,-19,118,-84,-20,-70,-156,29,-93,-208,-123,-4,418,24,243,-18,45,50,-62,-73,261
+X78817_at,3870,3847,3220,2460,2458,2199,3851,2105,2224,2013,1379,967,2696,2658,2364,1754,5143,681,1836,2757,544,1122,2213,2444,1572,2619,2223,2827,2991,2565,2157,1959,2715,1206,3021,2461,2590,2040
+X78924_at,581,176,344,254,267,243,277,361,487,237,297,-12,341,398,446,261,861,282,361,444,6,367,201,147,188,42,503,338,343,341,397,530,437,170,82,111,603,648
+X78925_at,379,211,46,212,236,-62,460,127,-42,196,156,140,284,308,374,284,616,375,235,332,94,142,74,317,127,28,145,177,28,1135,1049,298,452,259,808,345,794,665
+X78926_at,110,24,58,119,88,120,89,179,51,59,72,10,50,75,50,66,80,55,20,90,124,73,56,128,74,-13,134,50,31,94,-3,113,54,46,68,32,172,76
+X78933_at,179,43,83,10,22,26,85,79,25,44,69,7,92,111,82,34,78,49,14,147,88,74,121,102,4,71,42,31,26,65,35,48,37,31,79,-13,6,50
+X78992_at,5017,10824,2130,2922,3260,5844,5687,5431,3371,1295,4220,6011,6509,3705,7187,1452,6932,-168,3233,3940,22,10068,834,6492,6994,6425,384,3772,2974,9361,3839,10662,14971,3936,3894,5969,15125,2570
+X79066_at,699,285,-400,766,-202,497,564,440,-313,421,-36,133,500,-172,-11,308,-421,307,-171,216,378,600,241,-447,185,-225,320,-477,-940,793,636,-19,763,301,427,525,859,589
+X79067_at,924,133,-285,1105,620,-35,830,145,304,1501,841,617,867,684,634,272,153,313,535,673,597,604,-165,600,356,-11,1383,-314,-129,298,-140,-128,1296,29,-148,-342,817,1091
+X79201_at,181,319,36,72,210,-42,-43,8,334,25,114,-1,386,232,203,157,158,61,67,28,-14,44,-20,227,1,-15,-4,22,-7,189,31,36,43,-14,127,-5,-17,26
+X79204_at,83,47,118,18,63,39,-30,25,52,84,36,15,55,47,62,141,-45,91,67,-21,243,53,-45,92,73,77,40,14,137,74,-6,9,0,58,10,1,73,90
+X79234_at,12625,11891,10234,9942,16848,9564,9997,10577,15442,15491,15716,12032,14192,14333,16602,16255,15734,15090,13222,16302,20182,12316,7711,14486,16804,15652,13004,15888,10298,13545,15968,17961,15524,18642,15626,10826,13953,15340
+X79353_at,1591,680,466,406,801,508,542,997,541,432,523,205,1567,203,780,651,1060,337,430,2232,167,521,220,678,-168,1329,259,301,125,1080,602,379,463,250,781,164,416,543
+X79439_at,1608,519,1781,786,1430,1015,808,1835,384,503,767,152,1260,488,205,1649,2529,883,412,1931,1026,782,1316,636,1508,1372,2505,504,545,1511,400,2418,1758,351,1419,821,1082,3072
+X79440_at,-72,-141,-180,-9,214,-32,285,-1,-165,82,9,61,91,-194,198,-11,17,-162,50,313,182,96,-151,432,26,6,32,-81,-346,-182,-17,236,-57,-51,-124,-261,133,-198
+X79483_at,-116,-302,-141,-204,167,-119,104,-698,-91,-230,31,-204,-279,-378,-319,-115,-1027,23,138,328,-232,-160,-294,-83,139,-192,-719,-9,-28,77,-162,2,-214,119,-110,-122,99,62
+X79510_at,-74,-187,-101,-94,-39,-154,18,-125,116,35,-35,-48,-29,-170,-88,-60,-237,-24,-34,-15,33,-120,-159,-67,-77,-38,-132,28,-103,31,-139,-120,-94,43,-247,-133,-31,-131
+X79536_at,1060,2537,1580,998,1377,871,1434,1134,2246,2108,3386,547,1536,1794,1078,2127,5219,621,1870,6740,2922,1163,1554,1728,1753,1775,486,1959,2269,1487,808,2178,1658,1379,1744,1086,1136,1010
+X79568_at,-155,-179,-341,-248,-148,-231,-206,-296,-296,-129,-194,-176,-236,-89,-158,-156,-369,-358,127,-261,-108,-295,-435,-94,-46,-249,-305,-165,-242,-277,-127,-324,-103,-45,-121,-133,-209,-283
+X79780_at,43,594,314,-82,49,-64,297,-55,343,201,132,-132,40,138,112,106,729,147,24,143,-67,109,-56,-11,-25,-22,367,-31,-108,47,448,130,276,175,451,308,496,375
+X79781_at,401,681,345,720,251,336,325,406,351,147,421,353,274,496,323,376,471,228,396,598,223,317,623,551,603,295,505,421,57,426,441,621,433,303,606,304,351,342
+X79865_at,426,145,725,520,1033,608,312,637,741,640,430,317,768,440,629,602,739,268,811,872,-122,5,577,1036,310,551,4,602,687,306,194,468,555,205,593,278,145,147
+X79882_at,259,-91,-328,-70,493,-81,247,-349,-254,-132,-214,-241,96,-249,250,475,-254,229,265,134,28,-214,-281,43,-252,760,-575,-14,-238,2274,148,-173,-121,122,623,464,101,23
+X79888_at,155,30,224,155,105,0,154,244,152,30,81,-10,98,70,107,154,126,112,141,266,269,60,89,108,104,118,39,127,88,50,79,147,76,37,17,91,72,161
+X79981_at,526,339,599,560,253,380,485,808,496,305,340,218,218,347,212,439,790,326,282,297,132,317,410,394,263,334,664,450,548,439,418,482,474,183,517,359,536,681
+X79984_at,136,100,264,209,74,179,25,146,85,95,126,70,-5,143,66,135,97,146,120,73,-47,61,134,19,81,62,173,32,122,129,110,109,84,35,50,47,244,112
+X80026_at,384,76,456,401,-11,220,473,577,489,246,242,234,28,213,79,69,470,239,206,82,163,171,362,286,61,123,502,183,377,312,270,467,399,198,498,446,388,618
+X80062_at,134,92,132,-12,20,5,20,14,-39,-18,-84,-31,-48,34,-6,-22,305,74,-20,193,-3,-15,94,-94,41,160,173,-66,161,15,-21,337,-16,243,-26,48,-60,119
+X80198_at,249,193,193,349,427,503,463,211,417,140,282,103,470,226,414,287,222,-142,112,624,133,121,501,417,-40,470,-226,490,283,437,69,-88,330,407,118,498,633,-163
+X80199_at,1757,1607,2188,1721,1685,1424,1851,2338,2259,1450,1775,609,2306,2021,1612,1457,3060,1161,1268,3391,2136,1272,1719,2121,1102,1455,1577,1333,1399,1869,1343,3037,1747,1038,1378,1387,1836,1628
+X80200_at,1721,2254,3072,1753,1934,1399,1762,2526,2965,1829,5348,1281,1154,1428,1260,1376,1599,1468,1040,2937,659,3848,1510,1681,1757,1048,1667,1728,1308,1752,1128,2542,2757,1090,1540,1754,2492,2072
+X80230_at,659,498,554,902,880,312,873,818,312,586,605,212,1855,563,1396,1696,704,235,1564,2472,261,617,322,1052,622,1266,755,491,264,468,319,270,393,273,639,351,789,367
+X80343_at,-1152,-198,-1271,-904,-72,-115,-1408,-754,-1243,-555,-9,-87,-277,-512,-655,1,-187,-245,-424,-557,-484,-597,-1006,-1021,-1030,-181,-629,-328,-781,-482,-488,-301,-10,-547,-612,-32,-155,-778
+X80497_at,339,241,452,383,461,330,384,467,502,212,255,277,502,441,352,190,415,83,378,486,344,272,463,290,381,131,168,713,413,527,542,594,274,227,610,327,352,355
+X80507_at,143,219,196,70,153,220,84,265,185,173,130,61,26,97,60,160,138,122,21,16,97,117,172,31,62,66,142,141,91,152,119,170,124,42,61,31,330,155
+X80590_at,328,340,443,221,287,279,151,505,291,207,279,156,164,272,98,183,341,130,212,-50,137,477,250,576,391,174,477,295,367,214,286,427,332,122,502,39,469,509
+X80692_at,426,1028,362,153,564,200,252,445,880,853,1136,344,922,391,695,833,1508,293,463,989,1549,359,735,478,222,350,596,590,91,1031,998,527,872,544,1459,542,786,436
+X80695_at,464,1064,615,475,1393,656,697,548,694,326,772,438,706,847,1151,429,919,914,605,1326,1457,581,435,775,651,369,89,1279,367,1134,679,708,659,925,1520,759,805,718
+X80754_at,1236,1131,1612,1325,1088,1287,1450,1851,1272,1073,1247,873,954,1248,1117,1245,1708,889,941,1475,652,1146,824,1047,1348,1192,1320,1353,1284,1534,1190,1498,1350,624,1299,1068,1323,2021
+X80822_at,14002,14512,15724,14490,16640,23235,22243,17199,13825,18867,16328,21200,17001,13925,13074,16360,12973,16559,17228,11291,9673,18215,20490,15518,16702,15794,20633,15078,21889,17048,15104,16909,14568,20051,12637,18742,15076,14946
+X80907_at,823,779,1146,759,760,752,868,1133,731,653,607,617,601,576,652,746,1149,537,581,714,183,601,571,627,725,743,945,1037,365,1248,1175,1338,1441,559,958,1054,1170,1353
+X80909_at,8097,8988,6635,10165,10857,5848,7282,5258,11559,7473,9581,5791,5327,8921,11078,9890,14736,5892,8540,14814,19055,6531,6136,10136,8514,7887,4960,10027,7069,6029,8510,9354,9170,9132,8165,6451,8294,7004
+X80910_at,465,746,453,319,488,151,384,526,740,419,818,287,366,559,659,591,1163,146,450,1013,639,533,246,724,373,315,86,377,221,397,443,512,1098,399,640,219,383,911
+X80915_rna1_at,635,360,688,453,490,316,519,814,580,333,293,310,441,366,423,520,605,446,263,577,151,358,397,421,434,385,663,453,473,597,650,545,521,199,687,378,484,698
+X80923_at,463,216,398,347,165,273,359,607,374,260,233,171,229,301,160,275,632,294,304,171,203,251,408,358,276,284,474,356,307,270,397,394,351,105,314,357,318,452
+X81003_at,595,416,484,590,668,248,452,653,637,332,162,102,807,661,597,498,1439,273,468,1315,106,85,330,842,438,358,467,258,449,602,442,315,639,223,668,292,459,452
+X81198_at,670,542,647,755,872,348,418,736,968,285,617,165,789,624,963,699,1167,502,410,1366,492,313,465,924,442,487,610,301,382,462,532,449,493,395,537,270,293,914
+X81333_at,139,97,119,100,70,33,126,221,191,50,31,41,51,91,79,55,253,102,103,114,13,91,127,106,84,112,150,76,108,153,183,128,132,115,66,103,103,215
+X81372_at,254,191,240,156,173,39,5,5,116,129,72,146,183,284,-22,204,-4,141,74,220,191,204,305,151,86,232,48,226,-7,39,-24,172,-32,58,122,34,65,-86
+X81420_at,-589,-1190,-938,-744,-580,-906,-1102,-1095,-1225,-707,-672,-524,-487,-1181,-665,-349,-1946,-243,-408,-911,-212,-112,-374,-566,-774,-368,-910,-462,-310,-445,-1233,-54,-693,10,-475,-274,-1067,-1200
+X81438_at,-579,-87,-639,-180,-248,-311,-337,-781,-516,-237,-232,-47,-315,-215,-150,-90,-484,-327,-149,-153,-256,-158,-309,-429,-207,-229,-21,-382,-774,-289,-283,-303,-236,-222,-259,-574,-383,-685
+X81479_at,-104,0,-27,-127,1,-67,-164,-353,-56,-123,-35,-90,-93,-42,-69,3,38,-49,-153,-86,36,7,-167,-110,-51,-81,-184,-49,-141,-119,101,32,389,158,-7,-26,388,-39
+X81636_at,23,67,-9,-27,56,12,-40,-52,61,-8,62,-77,3,43,-22,6,48,-13,-34,131,-3,116,-9,128,-2,0,-79,162,-43,63,-91,-94,29,3,139,-5,51,29
+X81788_at,27,137,102,158,227,49,77,-40,262,128,-2,-7,128,224,231,135,136,34,85,384,371,124,49,176,65,16,-3,23,26,57,13,-20,-17,138,162,66,-4,-7
+X81817_at,3483,2569,2072,1779,2111,1386,1574,1397,3646,1566,2016,2348,3558,1944,1897,1653,5223,627,1791,3244,228,821,997,2206,1732,3500,1239,2564,1774,2508,2259,1848,1686,1474,2741,2745,3216,1757
+X81882_at,23,70,67,55,49,218,146,77,111,12,33,4,75,43,48,117,245,-3,11,106,22,32,-13,94,-20,37,147,54,165,-53,-42,104,10,207,300,188,67,50
+X81889_at,196,67,109,112,108,26,236,238,172,99,146,33,67,159,61,63,365,127,98,132,79,90,41,189,52,85,103,111,88,141,135,112,186,59,96,82,92,127
+X81892_at,145,113,152,115,108,103,169,71,59,141,47,34,41,102,18,118,123,96,16,71,103,105,100,67,85,133,287,102,153,83,133,94,46,39,86,31,192,132
+X81895_at,51,-9,31,77,-11,-53,5,83,-43,18,53,-14,38,14,-30,-24,76,-2,9,56,98,-23,5,3,-2,31,104,35,64,-52,38,72,-8,2,20,26,8,14
+X82018_at,-21,-19,-42,-19,8,5,-23,-22,12,6,22,-21,-35,4,-28,-31,21,-9,-13,-8,-52,-47,-56,68,-18,13,26,-69,-74,-23,-10,-14,8,-25,14,-31,-31,27
+X82068_at,-35,-3,-225,-79,-25,-12,-33,-8,-101,-142,-35,-57,-32,-11,-25,-76,-84,-26,-40,-25,-57,0,11,46,-30,-88,-118,-74,-45,-119,-10,-88,-211,-98,-72,41,-51,-83
+X82103_at,690,523,651,541,582,458,404,551,647,363,766,202,718,687,781,703,752,428,477,444,557,341,248,686,252,201,345,466,425,494,487,677,507,275,557,197,449,864
+X82125_at,4,-21,-38,-36,63,55,-120,86,9,94,-46,38,71,11,16,138,45,71,29,82,9,18,-49,-6,47,22,50,-96,-26,61,-86,12,88,7,-42,-48,49,78
+X82153_at,91,79,-25,25,40,37,28,83,141,66,59,18,44,-10,4,63,134,57,16,97,37,44,53,76,28,40,57,137,-4,14,37,36,85,23,72,-6,67,-14
+X82200_at,2385,993,873,1106,1585,585,944,1004,595,526,386,231,2343,1016,3674,2092,5295,222,1146,4601,2060,674,294,2513,960,757,677,441,959,788,1696,567,493,251,440,490,719,2079
+X82207_at,276,386,215,127,397,421,354,482,778,251,381,317,466,461,595,277,665,294,266,382,-9,145,129,452,235,91,114,359,238,303,595,472,941,360,689,159,440,607
+X82224_at,-97,-167,184,276,49,106,-174,-512,-234,-35,-50,93,-83,-64,52,72,-399,-92,21,79,74,-238,250,89,-51,55,-397,-141,7,-142,39,-301,24,-45,-106,-9,-7,-409
+X82240_rna1_at,14511,-16,-206,5207,5994,-220,-104,9682,-118,-93,-182,278,6654,-40,14812,811,-159,3119,3342,17185,1060,3283,-151,3497,2410,10585,7593,-274,-288,-7,-104,-182,-15,23,-104,-190,-180,-111
+X82324_at,24,-60,208,-56,25,106,-43,-107,0,-6,-32,-5,44,-85,49,25,-133,80,12,91,51,64,66,107,47,108,-122,75,38,158,-44,-14,11,-23,1,-40,-10,38
+X82434_at,1935,1451,996,1715,1323,1024,825,1124,1474,1555,932,1754,1671,1285,1036,1274,1491,406,1387,1572,449,1311,1233,1001,1513,968,1192,1161,454,1483,2312,2505,2276,1014,2583,1470,1790,2112
+X82456_at,3500,2698,2683,1616,2603,1474,1448,1547,4027,1704,2600,694,3586,4138,2458,4277,9747,2904,2080,5054,2494,1205,891,1898,663,3537,1178,1658,1050,2599,2051,2330,1712,2001,2735,2357,2546,1007
+X82494_at,-118,-129,359,-158,-60,-69,-216,-142,800,-65,-81,-224,-58,722,-119,-116,-433,-260,-325,-308,-236,-3,-165,-143,-169,-152,-337,-137,-201,-289,-361,-194,-230,-255,-441,-158,-230,-145
+X82539_at,-124,18,-66,8,-91,-165,-126,77,6,-41,56,-73,30,-44,-66,-47,99,-19,-32,-32,-127,-104,-1,-67,-1,-63,-46,-10,-105,-82,-71,-74,-14,-34,49,51,-26,18
+X82554_rna1_at,155,113,215,230,285,202,248,206,295,176,66,41,178,160,183,248,702,97,80,409,103,125,182,233,70,49,230,108,120,21,142,79,98,23,230,168,225,195
+X82629_at,-30,-13,-88,18,-11,-26,36,-122,-39,-18,-12,-28,-58,-18,-34,-62,7,-21,-6,-7,7,-60,-60,-3,0,-8,-15,-80,-100,-55,19,-73,16,6,-67,-35,-52,-27
+X82634_at,438,125,361,309,201,364,225,365,376,83,80,168,87,221,117,222,261,181,112,131,141,98,106,363,156,296,406,316,156,109,234,396,260,87,330,283,169,242
+X82676_at,-32,-43,21,34,9,-37,42,-281,-96,-102,-69,-60,-53,-141,-116,-96,-59,-47,-100,-35,-89,-129,-254,-70,-14,-39,51,-192,-88,-138,-74,-108,8,-66,-52,-62,-96,-35
+X82693_at,353,-77,181,288,-114,256,539,320,501,239,221,293,102,224,-6,-97,217,42,142,57,112,304,545,102,104,-34,159,211,69,388,316,405,204,162,-79,302,379,463
+X82877_at,304,127,420,362,214,215,376,265,366,208,225,86,148,264,198,177,364,146,95,262,203,309,370,259,407,182,427,245,72,356,313,321,287,137,346,132,339,444
+X82895_at,1415,1068,1617,1144,777,1008,1473,1716,1619,863,875,879,644,845,500,798,1661,644,681,982,502,902,1187,944,1016,856,1248,1271,1110,1402,1084,1394,1293,331,843,1203,1225,1895
+X83107_at,34,-52,-41,11,-57,-90,-33,-14,-61,-2,-38,1,-55,-63,-19,-68,-21,-108,-27,-32,-128,-61,-36,-87,1,10,9,-65,-72,-57,-28,-52,-5,-25,-10,27,-40,31
+X83127_at,289,286,144,132,78,-110,77,-82,160,99,80,-166,192,48,-81,77,1222,29,-3,334,168,137,-94,304,-4,387,500,494,-57,70,-213,136,154,-73,305,133,310,381
+X83218_at,1433,1536,2049,1603,2255,1388,984,766,3060,1367,2049,3263,1437,1798,2190,1543,1466,1010,1056,3561,3696,881,1377,2233,3065,1454,727,1183,1009,1526,1367,1245,1393,1582,1823,1543,1284,897
+X83368_at,281,253,248,271,229,193,265,205,215,142,141,99,242,250,389,236,302,112,165,344,158,249,148,207,212,211,273,182,189,170,197,167,150,106,180,215,325,382
+X83378_at,48,400,234,228,248,199,327,379,356,358,399,-50,242,238,283,274,445,274,145,590,387,316,22,530,255,277,269,439,281,367,455,526,516,251,436,473,553,527
+X83412_at,-214,-205,-321,-224,-180,-19,-312,-395,-271,-182,-221,148,-189,-12,-201,-207,-68,-150,-72,-114,58,-129,-275,-204,-212,-99,-59,-39,-19,-462,-226,-280,-258,-159,-343,-202,-249,-318
+X83425_at,662,495,839,433,326,673,441,853,602,379,505,273,425,592,449,614,604,357,292,521,473,567,664,499,451,466,711,566,670,685,476,683,640,305,522,800,519,702
+X83441_at,202,108,7,90,112,48,42,898,71,136,91,24,56,89,276,162,122,53,305,1000,126,27,98,182,58,33,50,44,64,14,-44,-4,29,29,67,31,139,39
+X83543_at,-2,60,86,-49,101,-69,137,191,189,16,74,-80,147,159,78,-30,-85,125,90,30,-7,120,9,166,55,120,-82,196,156,118,51,184,74,11,-40,45,201,162
+X83572_at,51,102,-123,88,137,14,287,-91,-103,37,-76,10,42,10,168,-46,-68,26,-138,29,-38,61,102,-29,108,-119,25,113,-33,38,-35,-86,100,-91,-42,226,249,-12
+X83573_at,370,167,-60,274,259,10,295,-32,441,330,411,347,100,288,79,158,462,325,107,103,86,95,273,180,361,165,264,436,233,-3,453,380,615,127,605,536,577,298
+X83618_at,-422,66,-328,-231,-149,-330,-423,-457,-425,-163,-39,-227,-175,-300,-196,-168,-319,-104,-274,-366,-191,-168,-294,-406,-271,-244,-500,-338,-290,-303,-599,-513,-80,-27,-167,-257,-327,-516
+X83703_at,-182,-80,-152,-84,-64,-49,-156,-44,-203,-37,-112,-73,-69,-62,-27,-108,-122,-55,-49,-96,-3,-91,-123,-97,-113,-126,-179,-178,-149,-101,-108,-62,-113,-58,-76,-134,-13,-165
+X83928_at,465,410,457,319,518,261,374,755,465,135,429,198,349,286,504,263,729,171,212,573,23,358,273,431,215,261,344,403,221,333,369,641,277,154,415,205,355,356
+X83973_at,640,578,691,628,462,526,515,598,506,431,631,316,361,532,671,612,773,356,339,572,174,728,459,639,404,326,571,390,315,517,573,614,514,267,266,596,417,836
+X84002_at,170,59,258,231,258,184,151,115,262,111,3,34,160,200,331,75,428,123,117,368,29,13,136,115,96,116,6,48,81,220,55,158,95,143,279,112,55,85
+X84003_at,32,-15,-2,35,7,3,-25,49,31,9,-3,53,22,53,29,-18,60,-3,-11,51,0,-26,-17,-28,-19,-3,35,-10,-7,-32,-6,1,55,-3,11,0,32,8
+X84194_at,185,43,209,289,326,128,146,242,208,175,110,110,301,216,246,173,415,112,133,330,179,48,176,267,217,148,172,112,187,65,126,96,117,42,111,62,153,31
+X84195_at,87,47,94,39,53,44,-1,100,92,48,-6,37,33,63,39,55,48,20,47,100,28,37,20,72,6,41,35,86,9,62,11,87,55,33,44,36,84,41
+X84373_at,575,27,221,898,717,90,739,1658,159,115,280,18,1687,-25,3572,1412,853,98,2866,3339,14,375,104,355,55,808,-39,13,16,246,235,141,271,177,191,74,1368,207
+X84707_rna1_at,-648,-517,-239,-411,-266,-88,-638,-871,-465,-367,-250,-94,-342,-437,-268,-448,-811,-393,-363,-486,-157,-468,-492,-313,-488,-373,-832,-483,-327,-452,-522,-491,-443,-223,-559,-449,-560,-814
+X84709_at,-131,-42,-3,0,343,-149,-87,-158,55,-12,130,-99,132,260,368,-64,662,66,-16,220,14,6,-70,168,-140,112,-134,-132,-64,15,-270,-271,-183,103,50,-275,-234,-136
+X84740_at,314,186,363,307,279,200,282,250,215,201,210,275,269,312,292,283,487,156,76,275,166,251,265,488,180,180,363,176,177,200,218,247,211,183,227,153,250,241
+X84746_at,-172,-42,-210,-99,-63,30,-142,-241,-220,-42,-5,-204,-109,-75,-187,-88,-94,-98,-115,57,243,-71,-66,-245,-64,-26,-125,-143,-76,-257,-100,-272,-121,-3,-95,-115,-215,-197
+X84908_at,212,72,152,55,300,112,84,43,70,28,43,14,116,151,116,157,336,41,32,322,142,48,91,212,67,227,75,93,100,74,17,36,11,14,52,26,109,9
+X85106_at,-133,-85,-195,330,28,37,33,610,-312,-187,-65,244,-176,-42,-224,-187,78,-199,-291,-453,93,223,-123,-195,-107,-124,314,208,459,-576,-173,318,-50,-283,7,171,-396,-333
+X85133_at,-5,44,-58,10,5,183,-99,38,6,-9,21,22,-70,180,121,-181,-194,-7,-10,-16,37,0,-96,130,2,-35,-148,89,81,110,156,87,-21,58,317,26,29,108
+X85134_rna1_at,204,77,111,102,142,-8,26,100,108,44,123,8,127,140,119,107,299,81,49,233,47,119,123,215,54,110,28,117,14,-4,-1,83,84,39,36,23,67,47
+X85178_at,-383,-345,-586,-496,-119,-389,-502,-697,-437,-233,-287,-250,-209,-359,-258,-257,-547,-237,-162,-321,-94,-328,-444,-376,-258,-169,-597,-225,-478,-456,-550,-442,-386,-102,-477,-568,-362,-633
+X85237_at,-94,397,59,-95,186,-92,-45,58,90,182,408,10,220,176,288,29,414,13,139,367,16,36,127,261,110,38,-164,117,-33,319,157,489,435,378,340,17,294,309
+X85372_at,333,1183,2184,857,1785,1228,430,394,2284,1608,1683,436,864,1216,1797,1125,1102,775,773,2407,1645,447,1126,1215,694,794,478,421,298,760,658,479,719,861,854,612,488,711
+X85373_at,373,618,1109,674,1195,586,431,439,1116,565,1112,135,626,985,1458,496,856,518,557,1542,1605,300,499,1069,226,233,170,180,165,370,585,372,426,891,424,329,376,346
+X85545_at,418,153,289,150,399,64,159,526,155,-9,48,285,381,403,547,172,265,73,16,206,29,324,26,255,127,14,100,247,134,166,13,134,150,14,143,19,79,479
+X85740_at,30,39,-327,-148,-347,76,58,-47,-388,-198,-109,206,-202,-236,-137,-360,-208,-114,-223,-215,-82,-74,-102,-444,8,-166,-46,-246,-76,-589,-42,-342,-203,-110,-5,-11,-391,-389
+X85750_at,95,490,260,-31,26,55,-36,-206,169,196,140,1,284,3,142,-49,39,229,37,211,412,37,-62,91,-63,-71,-35,-128,-165,40,45,74,7,59,129,-30,-30,-127
+X85753_at,41,-115,-180,-105,57,-56,-147,-139,-83,-36,39,-113,-8,93,-2,-53,-41,19,-86,-52,1,-9,83,-61,-81,-84,-70,-94,-206,-26,-116,-126,-99,-46,-239,-142,-24,-93
+X85785_rna1_at,564,533,899,618,433,649,588,617,508,659,675,375,341,524,547,472,806,426,599,384,199,625,530,551,668,436,868,737,1007,640,886,998,610,487,452,650,934,944
+X85786_at,829,434,710,515,631,485,614,985,636,375,477,232,484,355,784,637,1028,422,354,751,228,491,298,762,474,481,641,539,644,517,447,518,748,203,691,550,407,833
+X86012_at,530,586,615,514,556,620,331,464,577,311,504,337,554,501,422,696,514,343,387,857,357,517,406,244,423,165,464,347,379,406,428,510,530,398,371,308,369,652
+X86018_at,478,124,476,434,705,183,341,13,749,136,96,122,448,449,807,425,882,452,180,1009,-27,136,72,668,172,248,281,252,170,303,287,333,484,334,-82,303,450,554
+X86019_at,81,121,189,71,39,-7,109,181,-42,99,87,17,22,125,125,128,165,-27,88,143,32,153,-108,45,75,11,46,27,4,-19,13,139,103,-14,45,15,41,140
+X86098_at,130,65,150,166,101,49,162,11,93,-8,24,-27,200,99,111,47,208,-27,71,152,-11,54,9,121,-43,33,50,1,144,-3,10,2,-16,1,26,53,139,24
+X86163_at,-119,-62,-222,-149,-92,-154,-210,-104,-123,-121,-116,5,-127,-140,-83,-92,-307,-116,-114,-118,-186,-94,-197,-120,-129,-197,-234,-112,-214,-225,-57,-166,-24,-74,-127,-132,-135,-175
+X86400_at,-46,-45,-74,-127,-37,-33,-109,-28,-60,-15,-19,-30,-5,7,-1,-105,-67,-24,-92,-37,-44,-86,17,-46,-24,-40,-104,-126,-33,-168,-7,-32,5,-47,-46,-68,-36,-76
+X86564_at,-17,-16,-61,-5,-24,-64,-73,-23,-3,-25,-47,-34,-26,-27,0,-78,-44,-49,-33,-9,-11,-62,-30,11,-14,-67,-59,34,-84,-86,-27,29,-21,-15,-31,6,-24,-43
+X86570_at,952,350,785,739,373,492,495,596,642,644,387,290,309,331,443,751,787,368,409,837,154,564,366,430,413,426,995,926,620,684,447,525,741,29,620,572,746,1407
+X86681_at,1055,674,1065,921,742,785,766,968,1362,657,615,518,523,621,604,735,2009,606,524,1129,318,340,968,1130,606,768,999,865,764,921,569,1260,802,340,654,826,934,1463
+X86691_at,261,1124,79,841,1437,524,1707,-134,1556,416,218,290,998,1067,1959,1297,1682,252,865,3942,677,634,414,2103,156,1102,208,533,96,-864,-78,255,-13,371,658,162,323,-442
+X86693_at,79,38,57,58,24,71,-3,58,7,24,50,11,-2,3,6,46,-48,64,-88,-27,103,-35,17,40,19,46,97,25,103,15,-24,-28,-27,-3,86,75,139,89
+X86779_at,1195,1164,908,1242,877,894,1527,562,1303,795,630,270,1220,398,924,1037,1999,857,513,1604,753,290,987,1293,660,1172,1254,1156,562,1220,766,864,861,566,1009,1085,1003,568
+X86809_at,380,642,-171,728,166,647,120,82,657,241,38,837,646,393,521,393,-430,255,585,289,700,-105,824,43,-12,-131,492,91,-69,954,692,-90,264,102,1220,175,775,-153
+X86816_at,-199,-140,-234,-245,-40,-177,-149,-148,-132,-154,-83,-11,-69,-114,-7,-63,-282,-51,-151,-54,-92,-60,-121,-116,-43,-19,-275,-201,-151,-125,-119,-199,-178,-65,-71,-147,-170,-179
+X87159_at,-324,-112,-371,-225,-317,-248,-364,-145,-346,-256,-137,-268,-78,-140,-210,-272,-433,15,-243,-211,41,-239,-208,-261,-463,-68,-394,-352,-7,-389,-279,-248,-364,-53,12,-88,-456,-452
+X87160_at,-7,93,155,215,-64,-206,218,-100,86,-38,255,-53,10,-39,2,-65,272,-73,37,119,54,181,165,93,100,106,206,140,28,8,-117,409,182,-97,296,28,267,20
+X87176_at,195,42,223,71,327,136,-15,50,247,90,88,87,204,212,225,200,289,92,158,259,371,82,121,236,78,105,106,244,163,170,101,93,99,133,76,236,83,42
+X87212_at,-196,169,34,3,490,-224,-134,-428,445,-1,-32,-152,-192,498,361,256,136,-168,-228,-188,38,-146,-208,184,-235,-297,48,313,168,269,-1,-171,-76,396,1008,746,-140,-38
+X87237_at,144,292,237,281,352,284,487,253,271,150,8,-11,311,529,231,249,963,288,278,565,41,-14,226,476,270,325,48,413,642,97,223,303,169,-43,606,383,123,8
+X87241_at,97,38,646,29,71,401,-16,173,963,492,1391,-5,31,65,5,102,-65,24,15,83,216,156,416,28,-9,17,316,76,45,-38,65,25,62,22,-97,32,66,5
+X87342_at,-295,-120,-457,-732,-79,-707,-762,-527,-231,-619,-322,-534,-373,17,-170,-479,-441,-186,-338,-541,-467,-453,-758,-522,-72,-367,-578,-606,-555,-311,-772,-126,-197,-234,-348,-776,-734,-368
+X87613_at,51,34,78,180,156,-24,104,67,45,12,16,-25,150,133,158,154,9,16,136,236,96,2,98,107,89,5,-21,-65,-45,-50,11,153,-52,103,-50,-53,-109,-30
+X87767_at,31,-23,54,215,122,90,228,125,12,21,-54,212,7,115,108,18,-27,32,0,0,22,-9,136,67,98,84,106,-98,91,4,160,99,16,1,-7,27,-56,173
+X87838_at,1724,1499,1216,1481,1270,572,1572,1260,1409,823,1794,379,1988,1326,1720,2085,2113,1373,2061,1489,2067,1450,929,1308,691,781,1899,1181,916,2232,2940,1949,2571,599,3796,1615,2022,3450
+X87843_at,-275,44,-311,-299,-125,-170,-278,-404,-115,-161,-201,-239,-278,-110,-121,-69,-324,-142,-172,0,61,-217,-110,-339,-134,-259,-183,-221,-317,-422,-309,-355,-181,65,-266,-325,-536,-544
+X87852_at,-276,-400,-469,-677,-138,-510,-436,-875,-503,-365,-258,-494,-182,-334,-139,-254,-718,-290,12,-596,-252,-338,-387,-76,-386,-332,-830,-425,-666,-504,-662,-548,-515,-467,-467,-565,-541,-554
+X87870_at,-188,-203,-190,-197,-107,-186,-268,-244,-98,-113,-143,-67,-119,-83,-125,-248,-278,24,-115,-116,86,-189,-85,-159,-199,47,-225,-196,-185,-241,-142,-202,-167,-50,-172,-158,-152,-222
+X87904_at,-4,271,-164,56,148,117,488,710,61,286,-85,254,203,344,321,174,228,195,142,510,103,540,286,181,-35,226,178,228,-257,104,-152,-70,-1,177,248,344,439,-158
+X89059_at,306,336,358,107,141,186,314,368,347,136,89,132,159,267,157,291,453,175,100,282,167,65,197,112,200,81,455,369,351,321,416,432,297,155,373,163,205,373
+X89066_at,8,17,-106,-30,21,-71,-28,-67,-162,36,38,12,-34,-11,43,9,-38,134,-39,-8,-16,-73,26,-67,-62,-46,-48,87,-79,-75,6,-1,38,-3,-1,26,9,55
+X89067_at,-34,-94,-98,-165,-37,-32,85,-4,-43,-4,-2,-58,-47,-63,19,-26,-100,4,-69,-2,0,-79,-62,-84,-42,-12,-53,80,-67,-41,-82,-17,38,-15,17,-49,-2,-49
+X89211_at,357,263,364,199,178,250,211,346,284,239,247,150,158,154,256,296,437,353,209,419,116,147,233,195,209,282,350,334,223,244,232,209,215,165,190,159,345,326
+X89267_at,3344,3220,3562,2534,2589,2128,3389,3337,3441,2663,3090,1717,2035,3124,2034,2983,903,3258,2366,2878,1163,3557,2642,2423,3643,3551,4908,4312,3291,4060,2517,3850,3634,2263,3006,3058,3618,3093
+X89398_cds2_at,368,195,469,144,299,296,146,115,708,176,168,127,521,425,372,171,1028,237,248,591,136,36,216,532,224,339,178,239,223,140,75,85,328,118,118,196,103,169
+X89416_at,-488,-629,-1053,-706,-66,-56,-312,-385,-81,-416,-330,-189,-595,171,-146,178,-1257,-294,-108,-761,-108,-575,-1010,190,-675,-838,-1539,157,0,-388,-545,-523,-612,-206,-872,-372,-630,-1245
+X89426_at,23,-1,29,-51,36,5,60,20,13,-15,1,-2,-4,0,-23,-24,44,-27,-23,6,-3,18,0,-48,4,-7,31,-25,4,-29,54,47,-11,-57,27,-30,22,21
+X89576_at,-44,-236,-326,-474,724,-391,169,-413,-222,-212,-213,-228,55,-253,87,-186,-507,-122,-134,269,-64,-377,-410,278,87,-28,-355,-343,-428,-377,-551,-357,-201,-175,-454,-468,-482,-478
+X89750_at,742,471,490,835,662,328,981,922,316,454,301,375,1344,206,852,787,1706,166,559,1582,1361,396,275,930,408,758,718,535,384,414,775,1040,601,354,633,481,481,1493
+X89894_at,181,43,245,51,104,117,100,352,174,68,192,45,112,89,79,88,251,109,50,182,29,100,39,178,63,130,264,145,72,154,43,236,158,122,153,24,240,239
+X89960_at,913,596,1099,896,462,311,1063,1034,1031,795,701,645,439,716,584,704,1274,574,252,235,148,566,782,469,734,594,1279,848,288,861,969,904,944,426,568,499,1269,1699
+X89984_at,115,168,114,75,313,172,122,320,219,173,249,136,121,176,253,135,242,110,232,191,9,376,205,305,253,214,309,310,122,183,116,181,109,175,56,206,336,289
+X89985_at,584,1014,851,312,446,549,478,527,984,402,1453,438,559,600,510,234,907,273,180,537,402,529,917,662,265,423,217,386,432,776,1076,785,605,598,812,898,811,1072
+X90568_at,-77,2,-37,14,-26,10,13,-1,4,-9,-27,-20,-31,-86,0,3,-73,79,34,-55,-41,-94,-77,15,6,17,-62,-83,21,-33,-81,-83,10,-30,-96,-47,23,-32
+X90761_at,692,430,690,576,397,553,754,802,799,237,475,362,394,547,408,444,547,389,408,381,426,512,710,469,443,462,691,579,613,543,560,761,569,251,419,650,789,818
+X90763_at,401,294,521,504,271,337,668,514,481,466,375,314,346,319,320,447,608,325,383,536,189,323,324,504,360,551,572,571,485,510,642,519,605,322,312,482,776,851
+X90780_rna1_at,-107,76,51,-126,-135,-67,21,-154,-123,124,56,-122,44,80,-31,-166,110,165,142,-127,-177,-45,-85,-327,-126,99,-109,23,-86,104,216,124,140,-170,-9,-137,97,213
+X90828_at,-16,-126,-118,-190,-79,-67,-104,-368,-180,-57,-78,-112,-35,-11,-83,-59,-193,-52,13,-85,-36,-126,-75,-18,-25,-7,-178,-33,-60,-76,-142,-126,-75,-41,-116,-153,-151,-153
+X90840_at,-73,-329,-102,84,-77,-350,-423,-37,-156,-137,-155,-227,-84,-244,-539,-105,-202,-91,-27,234,26,196,-70,75,195,-44,-402,11,-302,-146,81,189,364,-81,193,-443,-345,-421
+X90857_at,65,5,399,126,-48,167,131,73,357,-192,28,87,-19,-132,-23,-259,-120,71,312,-127,54,-77,-492,-67,-77,-30,-84,-248,-214,-152,43,-149,186,33,-330,-129,198,145
+X90858_at,124,520,232,21,216,-140,-151,145,99,265,-55,478,124,232,108,53,235,20,150,-216,161,210,127,188,117,113,-161,279,221,1748,2575,359,308,412,3705,353,457,723
+X90872_at,418,420,401,355,784,316,388,275,701,317,464,150,451,419,572,303,691,306,436,171,74,338,197,379,308,235,93,486,214,666,387,499,560,536,712,707,1053,556
+X90908_at,119,-17,148,82,-69,-96,85,59,36,-21,-24,-123,38,12,15,-6,-106,27,149,-13,1,14,26,-152,46,15,3,-32,-16,37,125,42,25,17,-166,-23,30,172
+X90978_at,416,274,513,588,209,565,522,637,563,272,306,372,236,340,372,266,639,172,217,358,302,342,433,325,304,219,148,380,379,457,461,417,358,174,232,378,414,451
+X90999_at,47,-70,29,-63,149,-26,-139,154,98,7,-3,-71,58,75,183,-80,6,87,46,340,18,-45,-11,22,210,70,-165,-50,-7,21,226,421,-81,186,-28,-13,68,-3
+X91103_at,36,60,183,30,85,32,99,277,2,67,0,53,3,106,58,84,263,52,19,83,112,24,5,95,77,74,70,52,86,168,65,152,123,62,83,-17,69,215
+X91117_rna1_at,8,-144,107,-6,-6,14,57,-31,-11,0,-96,-53,22,-188,-119,-1,129,112,7,-16,169,0,-18,122,78,243,123,195,480,104,-25,-44,25,-83,-129,57,18,123
+X91141_at,4,-50,78,-121,83,-1,-36,-10,78,-73,1,-37,3,-5,78,-10,39,17,22,13,81,-86,-72,29,-1,11,98,-66,88,-95,81,-133,-23,-43,-103,-70,-43,-143
+X91148_at,-218,-117,-118,-187,-55,-140,-120,-127,-49,-109,-62,-54,-71,-104,-106,-110,-260,-33,-112,-66,18,-132,-77,-98,-77,-70,-206,-264,-163,-243,-87,-40,-63,-47,-119,-102,-76,-138
+X91220_at,35,41,-25,-61,103,-26,152,124,98,33,-4,84,12,27,-26,2,217,205,-14,-13,8,-37,51,26,67,56,-82,41,91,-16,-69,14,3,29,3,-6,180,23
+X91247_at,924,1026,1508,1153,975,897,1186,1223,1356,814,1242,536,746,1494,1435,1039,3029,990,797,1978,898,744,908,1225,1104,736,1272,1028,836,689,1480,1831,1003,784,803,1058,977,1353
+X91249_at,17,128,46,46,59,1,-35,130,130,113,64,67,179,86,76,151,403,1116,177,376,206,100,144,78,87,91,259,26,-2,70,48,144,119,135,116,35,112,59
+X91257_at,1580,1045,1244,1596,1689,1242,1371,1428,2151,1405,1500,458,1148,1385,1455,1764,2025,1149,1563,2468,903,1076,1128,1476,1115,1608,1575,1222,1072,935,807,1522,977,723,1207,630,905,702
+X91348_at,-206,-141,-280,-366,-156,-113,-225,-389,-182,-157,-127,-209,-153,-190,-127,-133,-341,-47,-50,-72,-104,-133,-113,-131,-60,-45,-325,-121,-146,-154,-156,133,-145,59,-413,-200,-193,-59
+X91504_at,1546,2453,1463,1586,798,1705,2055,1632,1207,808,499,837,877,1694,894,1046,1943,1293,760,2165,1291,292,1582,777,2287,1336,1980,2008,745,3190,1097,1460,1432,302,1215,507,1607,1139
+X91648_at,91,-34,125,115,154,46,85,25,209,31,26,43,107,75,146,18,5,36,59,211,122,0,18,73,9,14,37,33,-7,22,31,18,16,-38,-55,23,96,110
+X91788_at,450,241,644,379,730,382,603,157,1071,509,416,152,413,734,676,502,2144,428,304,1363,498,77,397,643,343,377,319,477,315,425,269,210,481,431,782,493,532,280
+X91809_at,2440,771,880,2215,1876,602,1522,736,1180,515,440,681,1525,929,2682,1687,3219,458,554,2556,634,204,699,1734,833,1365,1549,933,839,1400,8,390,740,435,1181,1039,1672,890
+X91868_at,35,12,175,183,86,69,80,35,71,95,38,45,69,94,102,101,168,14,138,189,67,74,51,149,61,104,161,163,113,113,25,6,85,83,55,175,108,86
+X91992_at,-25,-28,-49,0,15,19,30,-206,25,-71,10,-44,93,17,56,31,-50,-68,-9,72,38,3,-49,-36,-8,-80,54,-90,4,-86,-91,5,-74,54,22,2,-87,52
+X92098_at,343,392,567,262,557,240,168,250,778,332,1286,261,404,470,505,326,930,205,465,436,21,355,245,421,331,126,276,187,211,548,321,357,389,455,1061,299,598,519
+X92106_at,617,639,809,805,932,501,880,679,1040,603,690,281,821,612,753,485,1292,383,487,1002,197,249,531,748,530,459,503,317,507,495,376,469,671,187,478,528,268,448
+X92110_at,309,125,394,286,300,174,339,292,262,154,134,70,274,275,197,351,430,207,184,395,169,213,279,252,198,225,384,241,230,224,182,157,244,110,200,215,393,407
+X92396_at,242,603,379,447,564,264,297,337,575,248,470,323,689,427,447,297,942,210,226,809,386,255,294,594,130,165,131,260,137,458,637,330,283,615,683,497,425,456
+X92475_at,-26,181,348,339,297,204,319,227,221,225,168,192,340,174,300,302,287,171,269,542,193,111,273,296,139,273,226,219,151,176,176,97,146,66,141,134,272,204
+X92521_at,451,285,486,352,206,279,398,451,345,298,162,189,264,150,247,283,262,306,190,518,98,418,298,432,272,183,536,533,526,546,508,306,316,194,246,436,494,530
+X92689_at,-127,-86,-134,3,-79,-3,3,-25,-60,-10,29,24,-62,34,6,-70,-33,-106,-10,-89,-31,9,-112,-1,49,-81,42,-16,-76,132,22,-50,3,6,76,-66,-34,116
+X92715_at,229,285,404,331,286,136,322,272,272,251,164,67,315,237,414,372,482,122,290,534,122,190,94,269,238,299,506,225,173,269,67,303,294,142,306,107,316,173
+X92720_at,680,459,509,742,478,298,576,551,604,346,297,104,421,616,574,242,293,308,501,263,382,368,338,561,375,324,719,450,495,444,496,481,505,11,503,358,505,816
+X92744_at,42,11,-58,196,105,60,-73,-65,208,160,157,-21,78,80,74,149,144,131,46,22,36,74,62,184,234,42,42,257,0,694,5,245,92,163,147,19,172,304
+X92762_at,370,248,28,304,345,256,389,880,88,234,314,280,366,-48,422,351,543,206,235,398,362,164,112,406,454,378,312,676,538,219,202,-18,331,226,341,79,162,356
+X92814_at,137,108,223,73,129,71,3,139,45,106,29,63,114,57,178,222,211,282,93,-39,24,20,28,45,163,52,61,25,9,515,366,167,125,89,367,65,293,122
+X92896_at,1422,1694,197,471,1086,723,78,-629,628,669,452,906,1315,704,1365,1023,1619,249,495,1228,239,-196,9,272,526,1159,92,284,716,349,444,1413,1082,753,431,393,819,408
+X92972_at,338,563,27,384,257,-104,-356,-298,147,-1,622,194,8,311,610,-3,776,85,56,422,96,130,-81,25,-85,243,-467,-124,-204,289,820,384,91,325,211,-344,168,-60
+X93017_at,88,-83,-132,-102,-18,-24,43,136,-3,30,29,54,-13,28,43,-38,-112,0,99,-10,74,-103,-140,-43,81,-79,-15,-90,-100,-101,-162,-139,-78,93,-10,-48,-11,-58
+X93036_at,-913,-571,-858,-822,-313,-659,-851,-976,-957,-301,-440,-415,-630,-689,-606,-265,-1295,-330,-310,-712,171,-646,-856,-243,-261,-261,-1159,-532,-827,-433,-661,-481,-628,-250,-935,-872,-607,-726
+X93498_at,-28,17,91,-93,-40,-35,-70,25,17,30,-58,-43,-33,-39,-63,110,360,-11,-27,1,101,-49,-34,47,189,-50,233,96,81,-7,-48,6,-36,-53,-27,-44,-4,-92
+X93499_at,292,570,412,333,510,284,247,359,287,256,152,198,203,267,426,230,822,255,164,531,-43,260,281,375,279,-8,136,163,192,580,745,419,441,150,904,327,589,655
+X93510_at,-446,-612,-501,-91,-412,-206,-95,-140,-203,-198,-284,-80,-243,-144,-511,-353,-575,33,-63,-372,-237,-6,-212,-305,-453,-220,-483,-302,-122,-280,-114,-404,-368,-2,58,-108,-450,-438
+X93512_at,2161,-14,41,255,289,24,67,229,102,39,40,12,347,108,338,196,24,57,453,136,27,52,-41,157,82,192,-1,14,50,58,56,-37,32,-50,-26,6,26,2
+X93920_at,763,419,7,224,256,-64,210,385,96,28,81,211,1482,224,423,187,-31,100,769,873,444,340,26,10,1667,1570,278,462,274,1874,2140,509,1982,356,4125,643,2969,592
+X93921_at,476,269,114,241,228,131,408,583,306,242,158,201,203,279,163,238,870,287,285,217,119,90,134,159,287,176,550,128,76,418,321,372,307,342,720,222,397,461
+X93996_rna1_at,439,129,847,1036,206,1175,967,1983,1029,560,588,544,122,602,405,779,470,-527,485,-184,668,295,1117,-714,311,115,1344,-283,-351,632,1122,936,646,-201,333,1179,649,731
+X94232_at,1161,1050,1861,774,852,590,850,890,1462,971,1324,468,1340,789,840,1220,1532,338,498,2268,1174,558,651,942,880,652,411,246,315,812,587,761,676,463,525,472,737,522
+X94333_at,-321,-274,-477,-312,-330,-216,-544,-455,-445,-461,-369,-145,-314,-263,-57,-298,-1555,-331,-362,-660,-232,-234,-140,-14,-347,-339,-718,-280,-375,-219,-621,-515,-476,-527,-201,-359,-544,-852
+X94453_at,93,246,241,171,555,122,127,143,370,332,182,17,261,178,583,125,339,451,229,472,-97,0,243,274,271,31,56,20,-7,160,49,36,262,159,207,277,225,143
+X94612_at,126,63,175,305,148,83,-1,118,-64,188,-51,-122,66,197,26,146,207,109,90,-83,107,45,-53,240,127,147,97,309,276,55,112,164,200,103,73,36,129,165
+X94629_at,-71,-56,-96,-60,-79,-78,-52,-100,-65,-73,-65,-43,-136,-85,-71,-80,-160,-66,-68,-112,-7,-122,-51,-50,-62,-92,-118,-225,-67,-91,-56,-91,-104,-49,-92,-60,-92,-96
+X94703_at,-209,-174,-199,-229,8,-58,-334,-199,111,-148,-40,-137,3,-171,3,-112,-369,-52,-83,-19,-113,-170,-186,46,-128,-244,-70,-30,-293,-186,11,-172,-274,-75,-7,-188,-253,-244
+X94754_at,814,717,1019,882,826,910,735,1121,1029,574,838,419,415,797,935,782,1017,545,548,877,303,367,816,868,611,552,765,942,815,763,1003,977,732,287,741,622,950,923
+X94910_at,-31,658,61,478,1188,394,10,245,1133,42,607,169,125,50,1567,77,181,587,456,1746,216,298,-241,1034,394,402,222,-122,490,1544,699,11,772,378,1317,902,12,-242
+X95073_at,204,181,168,185,287,106,142,290,123,68,57,30,153,174,315,175,222,109,100,322,22,70,93,142,126,34,120,65,38,136,96,81,112,0,111,35,155,62
+X95095_at,-69,-48,-333,-91,-56,-8,-23,-80,-97,-42,-51,-28,-20,-84,-109,15,-148,-214,-62,92,-2,-49,-11,-93,-105,-90,-6,-114,-50,-50,-123,-90,-123,-81,-172,-51,-120,-117
+X95152_rna1_at,137,76,94,74,93,87,-20,44,63,72,54,12,98,51,94,90,110,61,42,60,71,41,43,87,49,74,231,-73,64,110,72,86,76,34,85,111,44,-1
+X95190_at,-1256,-994,-1692,-1513,-701,-1010,-1302,-1688,-1282,-932,-857,-537,-803,-1050,-792,-915,-1420,-730,-692,-1019,-530,-850,-1037,-870,-978,-699,-1699,-1041,-1024,-1184,-1514,-1316,-1133,-479,-1278,-1190,-1638,-1924
+X95191_at,-120,-17,-185,-208,19,-94,-117,-16,-51,161,-35,-155,8,-70,-23,39,185,24,46,-31,-58,-9,167,-44,92,79,239,34,-151,49,-21,-17,0,-17,171,-145,15,-3
+X95237_at,65,42,-87,-23,-36,104,-35,-55,-27,49,-2,-5,-22,0,-10,-42,-2,-3,31,-55,19,6,-11,-45,29,-10,-25,51,-26,-38,41,43,-52,11,-1,-15,-24,-55
+X95239_at,12,-13,-65,15,10,-3,13,58,-17,-9,-18,-15,-42,54,-42,-25,24,-7,-18,-41,4,-40,-62,-109,-5,-32,64,8,-28,-11,18,-56,2,-7,14,-43,9,-2
+X95289_at,-200,-199,-309,-246,-177,-304,-184,-430,-265,-53,-93,-285,-28,-131,-251,162,-112,-51,-11,80,-174,-341,-151,-172,-115,-81,-433,-15,-293,-229,-95,-195,-180,-113,-217,-124,-146,-238
+X95384_at,-19,12,-109,18,40,-158,-40,-127,-51,-95,-104,10,78,35,21,-44,77,-13,-29,127,111,-143,-60,63,-39,-77,-195,189,-62,-125,-167,-88,20,29,22,-78,-150,-196
+X95404_at,12387,11446,15005,12183,11820,15237,10574,12246,16209,16436,12873,9263,10020,11905,12151,13423,17539,7676,8016,14251,6768,8018,9666,8173,8932,14745,12223,10798,8105,17320,13932,8841,9380,9109,17298,12237,12703,11390
+X95406_at,147,-164,419,565,40,-309,-109,70,-220,-149,149,104,133,43,-41,347,39,-201,-79,359,34,155,5,226,128,325,-298,13,151,186,-6,178,267,138,-426,34,291,341
+X95586_at,1116,510,593,1229,1659,515,959,1007,899,475,716,469,899,869,1114,908,1284,1069,428,1534,588,417,433,1021,571,653,851,839,752,758,601,762,918,514,715,633,573,963
+X95592_at,119,258,35,102,331,39,55,98,86,108,212,27,293,497,242,191,477,35,117,554,227,1,127,158,-10,61,64,17,52,111,179,211,98,291,133,30,79,36
+X95648_at,179,193,93,232,422,46,136,85,247,53,50,66,160,162,343,106,522,85,172,535,198,43,28,398,43,135,89,148,165,25,59,40,53,165,155,87,209,-49
+X95654_at,-86,-15,-85,-10,-13,-35,25,-10,18,-27,-17,-51,-20,-69,5,-75,-37,-48,14,-8,-17,6,-41,-89,-5,-8,43,-54,-103,-27,-40,-62,-35,-15,-68,-53,-37,-96
+X95715_at,112,-180,-5,94,24,51,80,-23,37,48,53,33,64,62,23,-53,-148,-13,33,30,23,-105,-100,-50,-23,81,57,-7,-69,51,67,-124,-116,-121,-45,39,54,159
+X95735_at,298,307,309,693,713,247,52,-215,-223,492,-25,408,724,360,938,848,926,390,615,827,68,122,-108,222,700,433,-674,2947,1050,4863,2612,1671,2224,3348,6218,1548,3297,3482
+X95826_at,86,-222,153,135,-170,-12,-45,142,-238,-515,-185,74,88,-248,16,19,-356,-452,-30,-123,-7,-37,60,-34,-275,-451,219,-822,-718,-250,73,178,-155,95,-297,6,98,246
+X96381_rna1_at,645,218,293,74,37,96,161,209,276,77,118,37,397,251,104,137,490,105,476,343,186,198,303,59,269,451,183,281,214,282,295,282,295,135,167,82,207,349
+X96401_at,824,452,943,822,663,508,1303,1051,347,287,384,468,402,38,557,576,367,256,510,132,258,595,959,332,207,201,627,572,548,-305,402,401,347,198,360,812,751,1358
+X96484_at,1273,1073,1593,1024,888,771,1453,1584,1643,1280,719,534,739,1070,933,1346,2139,581,1072,1249,286,515,748,1143,724,1179,1121,1153,1082,1181,1469,1135,1146,656,1056,1239,1637,1731
+X96584_at,3,65,47,73,-9,12,-31,67,67,35,19,-53,195,-5,0,23,-12,-52,-5,44,29,32,-9,-63,38,29,12,-27,-158,51,105,-3,14,-33,801,-11,0,90
+X96586_at,513,510,696,594,791,350,552,554,836,385,391,106,895,696,541,573,2966,192,427,1327,477,351,307,833,185,302,348,724,454,569,378,402,471,187,481,401,711,916
+X96698_at,152,221,351,197,433,14,310,341,382,192,176,24,180,189,136,205,860,99,155,564,82,217,159,240,200,377,245,227,173,328,125,135,424,81,133,243,299,341
+X96719_at,21,2121,109,295,60,-188,181,-203,-172,444,1111,1784,310,402,1336,348,107,160,517,451,-136,-126,-212,391,1548,374,-639,152,-456,604,176,152,1590,7314,613,-98,192,873
+X96752_at,259,359,414,418,576,385,505,176,654,601,471,123,813,460,581,1347,965,153,349,1027,158,111,400,431,192,254,143,184,43,275,181,216,311,65,274,309,345,147
+X96753_at,30,-162,-94,-72,49,-240,-48,-164,-35,-57,-49,-50,-42,-52,-31,-101,-224,-102,-117,-62,97,-108,-36,98,-31,-11,-262,34,-48,-131,-217,-164,-141,-70,-122,-139,-135,-133
+X96783_rna1_at,-245,-136,555,-613,-57,-92,-425,-98,-98,-188,-448,-415,-104,-525,-503,-146,228,58,-99,-121,-157,-37,-632,-530,-75,-88,-355,-105,-567,346,-20,-51,-50,82,-200,-223,-449,-432
+X96849_at,260,187,187,446,239,14,-243,293,295,414,305,-284,212,210,246,270,449,-124,-171,110,-382,385,256,396,-242,268,173,365,329,313,825,-29,-29,-295,496,-380,-256,-721
+X96924_rna1_at,2092,1046,3225,833,312,1130,1720,1197,1275,1065,3050,991,2403,929,1286,871,790,2506,466,2724,519,712,847,1337,674,746,1137,1434,1070,2954,1467,1481,394,635,369,2226,1759,1872
+X96969_at,637,267,791,743,371,225,709,1001,756,372,473,201,391,518,288,464,744,535,347,243,500,544,463,788,202,470,918,538,807,656,549,480,450,255,304,888,872,1105
+X97058_at,-21,28,33,116,-28,163,15,37,116,76,14,1,-78,203,78,54,229,17,-56,13,107,116,157,34,63,39,179,141,122,-81,-144,-55,-34,-57,32,-99,38,25
+X97064_at,48,21,11,54,8,53,0,97,50,18,22,18,30,10,90,17,-35,-5,27,93,-19,-39,1,-43,5,-43,40,33,-108,26,-60,18,19,27,7,-11,37,-2
+X97065_at,200,127,7,108,496,163,194,11,201,89,-91,-61,282,199,428,80,152,257,-31,458,-143,-10,-30,11,-110,-30,-1,-6,-346,337,-12,22,142,99,312,317,-21,12
+X97074_at,788,1691,1029,695,1627,1319,557,581,1980,1363,1424,893,1319,940,1718,1696,1833,770,880,2453,393,512,590,1321,1245,2009,109,962,892,2122,2018,1709,1270,1822,2147,970,935,865
+X97160_rna1_at,424,644,602,651,261,538,707,958,874,510,788,514,325,405,245,367,1275,402,361,366,431,302,431,402,611,479,741,614,471,569,572,688,635,380,633,618,771,873
+X97198_at,622,629,809,946,456,476,850,1149,565,495,472,271,536,485,410,773,1175,540,598,758,336,545,537,681,553,632,865,685,822,964,760,958,677,368,592,491,698,1229
+X97249_at,763,538,549,494,487,442,638,589,529,446,393,352,509,403,278,581,527,477,251,667,219,503,321,557,420,512,649,452,644,505,411,559,547,202,363,302,484,554
+X97301_at,-148,-150,-176,-52,-15,-103,-122,-155,-198,-164,-69,-96,-82,-48,-112,-138,-371,-110,-153,-282,-29,-102,-110,-25,-187,-93,-219,-88,-144,-119,-80,-282,-152,-93,-233,-102,-165,-153
+X97302_at,789,488,869,757,428,522,1240,1595,838,576,433,323,417,709,390,764,1162,611,526,706,367,538,902,587,631,550,1256,828,901,694,1131,1756,809,626,566,599,770,1183
+X97303_at,107,-75,25,152,339,55,-21,89,86,1,-35,54,59,83,103,35,-98,-27,32,167,-56,-2,28,70,-31,12,18,46,88,-77,38,153,-1,117,133,92,-5,35
+X97324_at,343,2648,66,446,745,163,87,-20,336,624,478,1132,396,140,361,227,612,11,83,-91,22,353,252,91,1691,57,-142,215,201,251,863,1346,346,155,3427,45,82,958
+X97335_at,159,113,164,212,231,71,171,100,113,54,107,47,279,154,161,173,178,100,111,409,-6,31,-108,200,72,142,172,92,67,76,81,106,82,23,49,58,83,69
+X97544_at,628,509,675,545,769,330,522,668,644,390,588,248,409,469,525,682,743,325,326,679,121,532,522,596,361,401,414,484,298,554,504,536,375,356,459,449,547,619
+X97630_at,200,44,169,176,391,396,70,161,530,30,171,103,-60,253,417,118,72,97,51,22,-57,103,243,73,67,-8,333,-99,57,208,-8,165,64,199,451,245,122,184
+X97671_at,-4,57,10,130,31,33,25,-40,-3,55,32,67,26,87,16,34,95,0,18,4,2,45,98,23,26,20,139,-52,69,43,73,181,85,18,46,65,18,70
+X97674_at,-1138,-665,-1538,-1078,-303,-1015,-1216,-1734,-1154,-814,-768,-357,-578,-857,-271,-602,-938,-384,-654,-728,-277,-693,-891,-862,-925,-833,-1173,-1017,-1009,-1351,-1398,-1309,-1099,-322,-800,-1162,-767,-1093
+X97675_rna1_at,9,5,-23,-20,-6,-55,-31,-88,7,-14,-53,-27,-1,-16,-44,27,6,23,-13,-30,-43,10,-15,10,-13,-26,104,-31,-55,-67,16,-11,32,-41,-1,-19,-20,-39
+X97795_at,171,101,42,-33,185,-220,-42,35,106,352,47,-181,288,-69,209,264,325,172,58,365,26,-109,184,25,-4,95,123,-106,-406,-69,102,-216,133,130,124,-96,-112,164
+X98001_at,395,765,526,250,539,396,317,241,461,913,745,231,497,447,524,561,576,186,333,687,860,541,552,477,527,356,211,414,339,499,344,592,590,262,551,241,370,383
+X98085_at,1545,1360,1295,769,1212,119,897,895,1478,1257,1115,744,1566,1637,1575,2282,2068,1921,1774,2483,1043,1046,712,864,1240,1633,1279,1355,1012,1442,1207,1363,1694,841,1776,999,1242,1974
+X98172_at,421,1843,1181,193,325,400,201,73,927,1033,1445,214,296,858,224,448,2080,295,423,499,244,196,636,470,64,314,253,500,319,709,313,621,482,329,923,423,590,324
+X98176_at,-63,79,-34,3,86,-85,196,158,22,72,89,63,150,124,59,107,126,161,132,294,91,193,254,232,138,283,234,248,141,97,164,199,12,79,-105,45,-62,86
+X98206_at,-30,20,25,-120,42,-106,-97,-92,-124,-101,22,-71,28,103,39,-109,86,-49,42,-17,17,3,-93,-14,26,24,-139,-15,-84,-123,-26,-17,21,-65,-59,-88,3,-42
+X98248_rna1_at,812,758,1116,745,756,609,519,820,1052,386,630,310,649,818,739,529,983,332,373,568,116,269,423,866,334,289,585,250,346,341,565,420,671,311,344,584,819,498
+X98258_at,197,61,126,-52,173,-5,80,-43,160,-10,275,35,84,204,272,68,188,48,80,282,174,117,58,342,95,41,-106,-25,64,8,1,263,60,118,13,143,196,-9
+X98260_at,418,642,444,415,527,435,636,610,563,480,1034,405,390,539,472,662,814,225,328,1047,1001,647,471,717,321,295,411,1575,605,832,320,1168,857,364,653,538,819,847
+X98261_at,981,650,1210,1022,617,835,1223,1208,1077,887,806,491,773,782,581,852,1092,716,615,452,399,668,782,812,598,736,1201,1005,856,1084,1023,991,1035,310,989,988,1471,1815
+X98263_at,228,241,408,222,260,284,154,380,382,219,221,133,282,301,320,279,754,157,25,146,407,283,184,222,124,284,312,124,137,264,157,34,171,163,214,137,422,277
+X98266_cds2_at,16,64,58,82,43,122,43,73,70,10,10,94,30,68,-20,55,24,-17,19,0,11,36,-17,-13,-87,-18,17,33,-4,-37,52,-52,81,37,50,34,38,46
+X98307_at,-64,59,-104,-153,-81,-106,-1,-109,-57,-97,-35,-44,-50,-106,-93,-9,-271,-90,-20,-58,-73,-74,-47,-67,-90,-71,-123,-47,-2,-31,-143,-85,-36,-51,-70,-53,-122,-93
+X98311_at,225,160,147,154,85,128,99,227,135,85,26,53,88,57,35,118,57,83,73,167,-23,295,79,67,93,57,217,89,274,-82,224,105,107,34,107,175,102,279
+X98330_at,55,21,6,22,3,28,43,-8,13,-10,29,21,-16,35,-40,-109,4,14,-4,-50,0,-91,5,-9,4,-20,-50,1,21,-76,-2,-42,-55,-29,-5,39,5,-42
+X98411_at,797,727,643,813,613,499,904,667,616,190,282,602,324,1628,653,460,1551,250,387,427,61,564,398,929,562,508,380,1111,966,1710,968,699,966,455,816,860,1300,1207
+X98507_at,86,98,34,33,112,144,336,137,317,266,76,-43,74,11,35,67,108,93,59,23,46,700,51,89,8,20,92,108,125,-19,189,76,237,15,297,11,95,260
+X98743_at,946,637,1333,817,874,588,935,1215,1458,731,677,234,796,938,1014,928,2455,600,635,2414,1099,583,524,1158,357,765,1143,942,769,703,423,691,799,376,370,473,833,964
+X98801_at,1365,1065,1313,1130,1067,1054,1040,1283,1545,897,1007,369,829,767,941,862,2099,496,594,1284,131,716,1286,1171,662,969,638,976,817,1015,556,931,998,305,674,1064,1114,876
+X98833_rna1_at,-302,-239,-426,-358,-3,-428,-468,-1040,-456,-44,-374,-199,116,-221,65,-94,66,-197,-185,-141,-33,-362,-292,-432,-484,-236,-333,-382,-288,-300,-749,-683,-267,-190,-254,-265,-344,-647
+X98834_rna1_at,180,107,131,61,75,154,105,-13,218,212,154,83,220,24,102,77,-47,15,104,177,126,88,205,174,39,49,-9,35,76,86,118,143,148,107,90,10,17,21
+X99050_rna1_at,141,60,177,180,211,49,38,274,99,45,110,21,180,73,245,116,254,241,128,137,176,105,85,142,26,93,59,256,43,125,151,162,159,159,140,214,189,106
+X99076_rna1_at,-2210,-1984,-2911,-2826,-1307,-1712,-2775,-3898,-2927,-1492,-1763,-1139,-1374,-1762,-1643,-1756,-3384,-1417,-1400,-1528,-630,-1816,-2336,-1888,-1450,-1521,-3232,-2293,-2474,1151,-1851,-2679,-1478,-1273,-1012,-2614,-2614,-2426
+X99101_at,388,228,419,492,188,369,430,226,379,195,439,316,302,334,211,345,320,225,326,494,279,200,495,443,390,453,294,578,259,362,439,733,199,254,210,281,633,601
+X99140_at,259,446,248,239,452,492,220,-388,227,349,287,352,316,147,384,256,1186,268,421,677,223,126,286,199,477,541,42,224,-31,364,548,614,343,299,125,332,743,838
+X99141_at,719,329,697,355,372,501,383,620,496,465,393,280,349,358,202,317,858,157,247,681,127,510,556,413,388,488,782,786,394,706,465,329,376,246,455,436,561,1031
+X99142_at,891,379,1164,674,437,163,927,1211,517,609,761,129,619,277,388,698,891,597,449,731,-46,765,710,824,446,748,866,724,375,822,574,892,810,402,201,746,1138,1516
+X99209_at,989,765,1352,584,873,588,924,592,757,398,400,290,1261,1032,1177,860,1065,155,447,784,124,147,668,1218,105,895,683,398,274,525,411,183,479,147,420,1263,1516,551
+X99226_at,-257,-231,-514,-257,-69,39,-25,-535,-419,-32,-147,-74,50,-282,-30,-152,-392,-91,-25,-196,-152,-270,-123,-140,-162,-157,-533,-198,-310,-365,-141,-433,-205,-94,-342,-193,-248,-267
+X99268_at,-472,-314,-467,-304,-244,-328,-571,-556,-441,-310,-304,-265,-207,-331,544,-241,-549,-186,-277,-260,-114,-328,-273,-167,-260,-90,-469,-326,-360,-307,-422,-317,-222,-167,-418,-311,-511,-346
+X99296_xpt1_at,-587,-544,-130,-344,-370,-382,-450,-31,-490,-100,-366,-396,-306,-438,-512,-511,-510,-309,-425,-374,-201,-261,-79,-423,-289,-44,-79,-96,-211,-440,-350,-522,-921,-382,-848,-671,-689,-348
+X99325_at,-283,447,602,436,1011,464,717,775,776,636,218,-172,932,335,785,540,751,125,434,1958,174,-107,332,877,408,525,120,210,423,111,280,307,-71,-2,335,537,743,48
+X99350_rna1_at,-145,24,-103,-34,-46,87,-161,-209,-215,-134,-98,-17,-82,19,-73,-119,-222,-115,-68,-140,-3,-35,-22,-65,-65,-121,0,-64,-170,-120,-174,-63,-32,-94,-184,2,-190,-67
+X99459_at,768,875,976,815,694,967,1077,1473,1752,1008,1036,668,656,1028,556,615,912,315,623,1463,1174,264,963,1077,651,833,873,872,1000,856,836,1224,946,663,669,587,857,1197
+X99584_at,132,732,505,78,204,293,134,80,345,480,551,116,204,203,281,46,251,141,98,44,59,129,220,127,78,84,-101,240,72,450,349,299,289,281,354,379,533,195
+X99585_at,967,1031,1429,920,1299,1248,702,818,1509,1128,1320,671,1097,976,1360,806,1150,729,749,1656,399,340,860,1077,690,511,535,556,452,506,695,481,766,439,810,739,1119,548
+X99656_at,-245,66,-436,-234,-18,-16,-409,-667,-439,12,-175,10,-23,-137,-105,-31,-1,-65,-53,-30,-316,213,-47,-80,-90,-58,-156,-65,-411,29,40,62,141,107,151,-265,9,126
+X99657_at,-231,-129,-962,-591,-278,-503,-630,-602,-697,-521,-539,-458,-311,-338,-152,6,-815,-270,-156,-519,111,-669,182,-181,-99,-25,-1078,-397,36,-753,-919,-721,-705,-199,-638,-565,-783,-866
+X99664_at,320,251,505,429,114,505,211,544,619,279,315,94,187,304,39,156,461,207,143,215,164,160,450,479,337,313,618,412,300,383,723,229,667,57,460,455,454,494
+X99687_at,613,317,548,506,288,599,532,578,573,295,490,370,289,281,382,301,588,271,343,533,373,482,645,449,442,363,538,298,442,724,412,407,563,182,325,506,523,655
+X99688_at,2013,1313,2479,1433,850,1612,3029,2647,3727,979,1237,1201,1235,1194,1245,1384,3570,1183,1006,1479,989,1382,1567,1497,1455,1060,2293,387,1902,1867,1663,1924,1724,989,1357,1349,1530,2154
+X99699_at,445,289,604,294,288,71,199,631,397,13,-17,77,417,345,828,307,428,115,458,1648,114,193,302,453,1164,384,81,211,132,228,1259,356,248,150,33,282,393,1577
+X99720_rna1_at,273,176,257,200,459,5,57,161,696,31,715,-21,377,294,586,211,437,118,278,942,246,231,243,314,189,450,-118,143,-2,301,189,491,223,134,126,197,73,492
+X99728_at,348,463,510,436,168,382,428,331,628,264,42,181,315,518,355,518,1104,318,290,751,428,184,374,222,143,372,546,445,358,519,177,381,369,476,510,270,460,425
+X99802_at,-634,-617,-590,-1101,-528,-833,-875,-544,-1070,-699,-572,-688,-547,-569,-575,-675,-1147,-695,-418,-505,-54,-562,-940,-474,-344,-600,-1139,-267,-389,-1233,-776,-900,-1040,-255,-902,-749,-805,-367
+X99894_at,43,-412,-184,-367,62,-293,-154,-692,-72,-36,-98,-117,-95,-251,-106,-59,-854,-109,-142,-143,-97,-100,-300,-167,46,-73,-492,-123,-375,-132,-71,-67,-21,-107,-559,-158,-38,-83
+X99920_at,-16,-102,-199,-199,455,-293,-262,-325,-336,-56,-61,773,722,-108,517,73,-72,38,697,458,183,41,-89,-92,605,1080,-150,-126,-158,-19,-253,-229,-34,-98,-52,-224,-131,-230
+X99947_at,-78,-13,-77,-60,-11,-23,-92,-55,-305,-65,-113,-84,-41,-181,46,-39,-242,-66,13,-55,-33,-81,-9,-245,130,-59,-98,-225,-28,63,39,-121,-234,-74,-10,-90,-148,48
+X99961_at,-161,-22,-88,-55,99,-69,-104,-95,-123,-78,-56,-5,24,-36,90,10,-9,43,7,27,12,19,-98,80,32,53,-131,-92,-115,-79,-43,-5,-43,-26,-35,73,24,-9
+Y00062_at,1122,2231,2598,1747,2700,1260,1414,358,2625,1029,728,347,185,3881,2582,1078,4991,1476,276,940,367,128,271,3269,118,391,190,838,355,1575,1440,1535,781,1156,1413,600,1414,1469
+Y00064_at,95,37,114,55,99,58,72,22,170,79,103,33,66,99,108,65,124,85,48,82,44,85,140,138,92,125,81,111,139,104,101,96,151,37,71,68,120,90
+Y00067_rna1_at,69,46,127,-15,-2,62,53,37,-28,9,11,-25,-33,57,70,-21,136,43,21,27,54,36,1,61,51,44,53,8,98,20,57,104,9,-41,38,-18,108,23
+Y00281_at,1351,1925,1881,1389,1283,981,1576,1196,3442,1322,994,1072,1590,1343,1392,1253,3103,697,1516,2275,1020,712,596,1853,1021,1227,1150,1393,2837,2028,1636,1278,1278,1182,1170,2274,1413,1134
+Y00282_at,1475,2651,1763,1521,2417,1278,1418,1107,3934,1564,3370,1212,2435,2957,2844,1382,5098,1478,1740,3689,1110,508,934,1660,1364,2968,1106,3108,1642,3544,2768,1396,2452,2390,4928,4560,3348,2223
+Y00291_at,-209,-166,-298,-193,-88,-236,-164,-170,-91,-111,-201,-112,-120,-86,-93,-169,-229,3,-142,-123,-94,-116,-210,-209,-124,-100,-239,-178,-317,-197,-254,-190,-229,-102,-117,-291,-215,-289
+Y00317_at,-72,11,-39,-93,-13,-56,-21,-77,-11,-22,-28,-30,-29,-30,4,-128,-115,-33,7,-7,-51,-1,-39,-25,-8,4,-39,-8,31,28,-45,-20,0,-10,-24,-47,-7,-65
+Y00318_at,165,73,134,74,33,49,104,73,61,86,36,51,57,28,101,38,152,66,54,69,102,66,24,29,142,107,115,110,76,56,82,125,82,11,61,41,31,129
+Y00433_at,7546,9601,2918,9491,10367,2263,9863,5886,5919,3387,2128,7797,14517,3531,12831,9546,17799,5039,11235,12049,1387,1726,1877,9198,8572,8670,3060,10227,7848,15609,15261,12468,11793,12352,15961,17124,13059,9895
+Y00486_rna1_at,584,2460,2671,1561,2197,2007,2127,1677,2777,1962,1793,1488,1401,2300,2175,1682,2749,621,2036,3540,960,579,1531,2407,1569,2646,1705,1481,1582,2016,1935,1300,1583,1242,2365,2164,1666,1773
+Y00503_at,-77,-39,-176,-59,-32,-42,-8,-158,-92,-68,-18,0,-68,-123,-88,-18,-64,-33,-117,-54,42,-138,-131,-1,-42,-49,-167,-100,-50,-120,-113,-1,-81,-51,-162,-54,-135,-51
+Y00636_at,232,96,4,501,658,12,578,556,52,25,116,112,324,209,634,95,575,574,260,969,433,78,81,514,260,96,109,29,-36,226,205,-27,81,101,218,126,180,289
+Y00705_at,-186,-96,-175,-176,-151,-120,-94,-239,-161,-99,-142,-54,-143,-111,-162,-195,-293,-100,-129,-184,-43,-155,-138,-181,-246,-258,-316,-219,-129,-253,-157,-189,-109,-58,-219,-150,-255,-264
+Y00757_at,-80,-139,-149,-66,-57,-69,0,-296,-54,-61,-40,-24,-58,-63,-65,-28,-385,-4,2,-92,-7,-35,-83,-90,-93,-35,-316,-70,67,-158,-62,-222,-139,-101,-151,-91,-148,-449
+Y00764_at,1637,2092,2887,1945,2622,1330,1268,1067,3518,2003,2418,1336,1706,2284,2829,1728,1805,1343,1599,1610,4898,1180,1639,2037,1571,1272,1480,2457,1644,2085,1978,1692,2678,1778,3760,1463,2054,1559
+Y00796_at,789,2949,1596,258,239,1771,769,1089,1349,853,1336,-324,227,1748,738,234,2540,839,53,364,76,351,748,705,582,158,854,757,257,1453,568,505,930,519,1871,718,992,886
+Y00815_at,65,21,94,67,-4,44,-15,148,110,60,56,-33,11,-3,14,112,86,72,-5,9,113,20,338,133,42,-19,136,54,233,62,57,36,74,-67,4,85,-18,139
+Y00970_at,-702,254,395,141,265,199,376,391,119,449,179,-204,160,260,296,-128,29,8,46,39,93,-115,-110,137,72,238,-129,-48,197,45,99,167,-16,9,-228,-485,245,398
+Y00971_at,22,307,201,164,198,96,142,136,349,204,273,97,195,294,384,60,358,165,40,136,156,23,117,205,177,62,107,86,122,136,188,127,142,58,100,115,107,168
+Y00978_at,124,6,112,102,134,72,104,196,134,129,24,76,132,188,43,24,463,67,32,133,107,45,87,208,63,40,98,0,36,118,35,83,66,0,61,49,48,70
+Y07512_at,31,36,43,31,25,51,42,95,77,42,44,114,6,63,23,-18,99,62,-21,20,-2,35,89,92,26,73,104,56,60,41,22,6,43,47,75,58,20,109
+Y07595_at,-385,109,-570,-92,159,37,-504,-431,-290,105,-389,-162,2,-119,197,48,-546,-171,-185,404,-122,-228,-258,63,-107,-234,-434,-47,-449,-529,-650,-149,-144,-61,-237,18,-290,-593
+Y07596_at,-64,9,80,7,6,33,-42,-17,40,4,25,22,56,31,32,23,49,19,-2,74,-11,-40,-41,39,82,-6,-140,30,-45,-3,68,10,60,-114,56,10,4,14
+Y07604_at,554,1555,1052,696,755,1033,322,1130,2042,1355,1264,300,540,145,1130,45,2084,547,825,1806,149,134,830,785,541,706,314,1604,2262,1506,2099,1504,2497,1423,1140,1990,977,1479
+Y07683_at,372,239,338,391,165,256,265,568,57,206,131,215,193,119,165,209,532,242,112,308,37,194,43,108,237,175,90,275,206,333,293,267,294,150,240,69,356,470
+Y07701_at,211,109,52,100,129,142,154,100,158,38,118,2,144,164,174,73,304,176,81,253,-39,-5,62,135,61,19,139,64,52,68,67,74,53,15,124,64,86,177
+Y07707_at,106,66,-19,-85,107,-28,-90,-79,-32,82,79,-11,83,124,149,-112,1,-11,-38,70,124,-43,-68,-2,-30,-13,-107,-49,24,5,-79,-75,1,-49,-24,2,-92,-64
+Y07755_at,54,91,-5,406,339,-49,97,-170,-116,-169,38,-12,196,81,404,-51,368,68,19,-26,-44,387,-169,283,93,374,333,484,-36,463,98,-197,-194,21,-425,-100,-238,67
+Y07759_at,-132,75,-108,-134,-18,7,-141,-164,-149,-67,9,-22,-11,20,46,-60,-138,-5,-25,0,-39,-64,-81,-6,-53,-69,-156,-103,-79,-50,-25,29,-84,39,56,-18,-112,-104
+Y07828_at,-26,-77,-96,-50,-87,-32,13,-86,35,-91,-82,-51,-23,2,-3,-39,-87,-29,-30,-81,66,-35,9,-50,4,-18,-84,-23,117,27,-63,-72,-67,17,-107,-58,-64,-67
+Y07829_xpt3_at,-19,21,-21,9,52,-28,-213,19,-51,1,56,51,88,10,114,14,-45,-213,-50,79,76,-11,-24,271,55,182,-1024,219,187,-95,-179,-102,117,14,152,-100,-101,-178
+Y07829_xpt4_at,583,174,923,587,275,505,774,740,404,584,499,270,194,304,282,475,465,218,520,338,239,461,771,305,184,221,818,626,189,451,560,499,509,309,660,499,915,784
+Y07846_at,-464,-562,-1058,-504,-374,-579,-594,-1137,-951,-532,-389,-412,-463,-669,-413,-581,-1234,-413,-491,-827,-368,-550,-661,-369,-610,-396,-625,-672,-680,-564,-762,-603,-817,-339,-1007,-589,-919,-1175
+Y07847_at,218,316,293,274,189,225,294,422,282,379,263,413,180,179,244,230,274,150,940,378,63,56,188,150,122,181,270,308,197,432,426,324,389,223,222,213,555,506
+Y07867_at,-122,-40,-76,-49,-13,-126,-82,-82,-42,-84,0,18,-56,26,11,-66,-77,-19,-38,-28,-21,-37,-55,-107,-31,-58,-147,-86,-74,39,-85,-70,-32,30,56,-54,-115,-118
+Y08134_at,470,323,618,322,280,302,356,277,563,436,443,362,321,335,306,319,309,340,392,340,204,272,275,386,407,330,317,511,375,663,351,281,710,210,111,490,728,798
+Y08136_at,53,42,-23,45,29,3,3,44,41,25,48,21,33,41,24,-10,36,28,6,8,6,1,34,-13,36,5,59,56,19,281,156,36,29,7,68,-1,58,70
+Y08200_at,1572,1373,1535,1681,1019,974,1754,1124,1951,1246,1105,918,1138,1238,1095,1541,2277,1233,1291,1835,743,834,1172,1061,1156,1141,1534,1576,1272,2161,2146,1826,1561,935,1684,1275,2302,2900
+Y08223_at,64,35,285,126,14,23,191,46,229,42,122,76,46,176,13,-79,40,45,53,-37,-141,-65,182,166,58,57,-50,122,-2,241,191,109,245,33,-16,52,-5,155
+Y08263_at,458,162,273,-35,104,378,337,287,397,649,177,317,112,221,-110,320,351,377,317,273,202,214,222,271,217,146,430,525,307,504,339,321,271,146,-181,419,-106,499
+Y08302_at,748,276,818,656,354,515,616,641,779,386,572,469,343,570,373,265,481,371,311,565,257,56,526,240,320,394,488,460,218,583,807,348,463,265,460,113,452,658
+Y08319_at,-6,60,33,31,92,-19,77,-5,91,67,63,30,-20,45,99,85,-28,1,29,62,72,27,13,130,29,-3,90,-31,-16,23,31,86,-2,53,25,100,115,84
+Y08374_rna1_at,-136,167,57,95,10,-32,-201,-158,-191,-82,28,-17,-43,-89,-27,68,44,40,62,216,133,181,-106,-70,18,-13,-65,57,108,-167,-222,-155,-111,119,234,-119,-169,-140
+Y08409_at,955,687,1001,523,539,716,720,1106,825,561,753,518,597,726,543,419,1031,320,453,947,594,814,659,284,639,204,782,218,896,1087,960,977,955,459,648,473,593,1210
+Y08564_at,-3,-62,-108,-41,-28,-72,-40,-64,-48,-47,-9,-30,-37,-29,-42,-72,-96,-104,-31,-41,-87,-2,-81,-2,4,-109,-187,-106,-113,-51,-22,-60,-7,-46,-70,-65,-90,-32
+Y08612_at,517,351,214,432,596,220,196,436,513,114,492,119,393,416,651,278,623,198,251,847,689,290,199,569,292,424,517,200,86,209,253,199,292,151,173,119,185,172
+Y08613_at,31,-84,-217,449,-238,-51,-223,-10,-163,-70,95,-148,-131,-74,-111,-202,68,-224,225,-57,387,-342,-113,137,197,-323,358,-109,238,25,-205,210,0,-23,-73,-181,-448,-4
+Y08614_at,993,992,919,1134,1802,531,904,673,1469,785,414,270,1865,927,1853,2088,3349,693,1301,2938,1679,366,452,1368,692,885,654,554,430,839,195,1710,334,287,546,449,417,412
+Y08639_at,192,153,145,40,139,136,57,-166,24,143,125,87,74,210,390,181,592,133,65,402,136,304,279,287,108,209,15,188,238,-180,32,87,-80,73,307,24,336,23
+Y08836_at,440,254,218,-108,98,353,236,781,332,8,238,229,215,202,-143,335,772,262,395,355,231,166,58,54,367,117,489,283,339,-122,615,790,351,193,659,-103,-106,459
+Y08837_at,-82,-65,-99,-132,34,53,-122,-104,-80,-85,-109,-20,-52,-88,-50,8,35,-103,-62,-25,36,-108,-167,-34,-92,-44,86,-153,-144,-215,-59,-72,-69,3,-22,-113,-98,-209
+Y08915_at,804,475,727,779,1077,455,744,314,1567,483,1101,511,1246,653,1285,1297,1383,1337,813,2048,840,512,446,1033,480,868,636,491,161,497,546,581,864,929,950,478,607,724
+Y08976_at,1975,1484,2741,2097,1023,1500,2212,3126,2657,1501,1256,1143,1265,764,1072,1547,3123,1366,1003,1639,931,1303,1582,1785,1316,1326,2160,1923,2092,2029,1393,1689,1866,1178,1612,2040,1897,2880
+Y08991_at,233,226,142,181,226,39,236,70,160,190,174,33,255,203,224,209,523,149,142,262,159,99,108,317,65,75,117,122,91,226,197,234,127,173,278,43,136,237
+Y08999_at,-238,-337,-240,-469,-110,-332,-302,-158,-250,-456,-189,-163,-75,-193,293,-32,-435,-338,-155,145,-106,-244,-142,98,-580,-245,-571,-300,-305,-57,-223,-195,-563,-13,454,251,-253,-502
+Y09022_at,-86,81,222,346,423,286,547,-86,196,165,-43,156,215,318,434,457,838,62,176,109,118,51,193,270,175,183,-3,120,-110,239,-154,-130,212,26,-215,529,-16,-54
+Y09216_at,1118,441,889,418,485,451,524,772,996,687,390,339,586,517,596,612,401,207,453,770,607,882,948,740,526,278,327,788,288,874,405,386,577,298,411,678,1230,616
+Y09267_at,101,-34,-100,23,-9,-32,-215,-13,55,102,35,-7,35,-17,-13,14,83,-16,-53,-165,-32,-23,43,103,55,21,-37,57,103,-184,-71,-2,80,43,137,96,-113,-122
+Y09305_at,105,132,187,-111,227,184,-75,-175,191,159,293,45,301,246,318,7,-111,112,-15,164,16,-116,20,149,154,94,-264,21,108,69,35,-129,133,147,-17,-22,101,-43
+Y09306_at,116,109,117,245,120,106,184,154,171,70,89,38,91,194,150,113,105,95,109,136,67,79,74,97,111,50,61,137,91,87,85,170,191,110,120,145,338,249
+Y09321_at,-151,-15,-72,-156,-19,-101,-60,-259,154,-143,35,-175,21,84,-27,-91,428,57,-60,-166,-48,-43,-93,53,103,-16,10,3,-134,88,-135,-54,-55,-37,-146,-130,-230,214
+Y09443_at,257,216,290,207,363,305,159,290,343,121,160,76,186,257,210,939,370,204,836,154,96,90,157,227,109,241,143,198,120,172,117,244,300,131,108,213,287,256
+Y09561_at,-300,-342,-445,-338,-213,-327,-347,-418,-385,-246,-290,-235,-144,-244,-34,-192,-506,-243,-167,-284,-58,-262,-322,-341,-271,-210,-517,-342,-271,-404,-363,-422,-384,-125,-310,-370,-309,-471
+Y09615_at,84,56,51,61,98,40,104,65,87,62,56,14,44,119,42,65,114,57,81,112,1,7,56,29,56,12,136,61,113,122,65,122,45,87,39,19,98,124
+Y09616_at,1927,1333,2115,1861,1064,1555,1952,2203,2040,1385,1180,528,1173,1824,959,1305,2078,914,1002,1555,908,1075,1299,1595,1063,1243,1769,1700,1618,1724,1081,1853,1600,567,1650,1086,2425,2380
+Y09836_at,-60,-236,-19,29,-139,-119,-82,301,-34,-50,-272,-133,-102,-46,-303,-69,-42,199,-65,-429,143,-2,-104,80,-152,-53,101,82,64,-355,-293,-229,-281,-234,-120,-410,-312,-408
+Y09858_at,31,240,130,186,32,60,107,140,125,21,0,30,95,177,35,89,202,116,64,54,-12,48,262,39,76,-31,-159,187,69,111,83,157,67,1,52,83,107,126
+Y09912_rna1_at,-766,-523,-475,-739,-294,-816,-426,-352,-528,-399,-354,-352,-131,-576,-406,-604,-267,-454,-393,-281,-465,-234,-689,-366,-459,-427,-373,-325,-105,-323,-134,-212,-321,-199,-350,-1466,-444,-984
+Y09980_rna4_at,53,-28,3,122,10,103,57,38,37,36,-39,114,-13,12,9,34,-131,-17,-23,-61,31,-5,66,51,46,-62,43,50,-2,124,192,125,103,18,169,26,193,93
+Y10032_at,203,307,74,35,147,209,48,293,134,335,95,239,183,258,169,217,363,184,56,192,107,175,142,184,411,136,308,186,60,1245,273,232,286,-11,613,65,204,299
+Y10055_at,303,360,140,426,376,151,640,508,130,171,282,149,263,436,513,301,347,349,136,244,61,200,148,581,607,377,380,392,250,868,573,644,354,18,340,160,431,836
+Y10202_at,-44,-30,-76,-69,9,-62,-25,-110,-14,-53,-43,-34,-26,-26,-11,-12,-22,-57,-30,4,52,-91,-96,-6,37,-30,-9,-91,-96,26,-106,-55,-48,-7,-38,-19,-46,-39
+Y10204_at,62,-4,-51,22,24,55,82,52,2,-62,34,22,0,50,-3,25,47,-27,3,-48,-9,6,7,-5,29,-32,87,68,-62,28,21,-49,-7,7,58,-6,-35,15
+Y10205_at,94,92,173,102,38,179,85,157,89,100,35,60,24,91,0,67,232,81,38,21,52,58,235,143,113,121,212,87,105,88,73,98,81,11,157,43,102,62
+Y10207_at,378,349,469,234,10,120,287,65,83,125,350,300,173,274,-112,145,710,309,273,19,-7,51,457,222,-118,237,377,111,-264,-279,470,-472,180,-30,324,73,-289,-359
+Y10209_at,412,263,-2,168,62,71,524,619,57,292,103,380,233,305,335,34,401,326,256,387,-167,45,170,-19,302,14,378,425,-69,312,367,477,484,-179,245,-28,361,645
+Y10210_at,-257,-91,-220,-180,-81,-122,-157,-167,-133,-91,-36,-103,-140,-119,-98,-97,-195,-128,-132,-170,-112,-151,-127,-157,-8,-95,-211,-144,-125,-138,-117,-102,-110,-82,-125,-129,-209,-238
+Y10256_at,226,-297,-383,-205,-445,-136,-534,-337,-251,-549,-206,-228,-210,-344,-354,-430,-226,-201,-460,-244,-51,-184,-581,10,152,-192,-375,-231,-33,-203,-704,-337,-82,-163,-132,-367,-245,-452
+Y10260_at,-154,56,-199,673,-176,521,-156,-493,-114,400,-72,-14,201,-158,145,-74,-425,-166,-293,-608,126,-277,581,103,-369,-192,826,-229,281,-168,-755,-846,-187,-368,-265,-109,-291,-713
+Y10275_at,130,86,80,69,102,-7,102,110,127,89,23,80,30,81,58,111,100,79,53,101,202,64,53,156,20,58,103,28,64,4,50,28,12,123,85,73,88,64
+Y10313_at,217,160,63,55,104,170,63,175,107,125,80,70,64,78,49,47,248,100,75,55,139,64,91,21,150,-4,264,247,134,113,45,204,269,26,79,44,141,141
+Y10376_at,1071,979,1238,1168,631,1013,1364,1506,1357,781,894,727,377,927,688,671,1599,256,806,881,373,904,1081,669,987,626,1783,1396,870,1988,1393,1383,1296,630,1273,1021,1357,1811
+Y10505_at,196,193,224,188,135,167,218,412,259,120,158,71,152,165,148,239,468,190,141,180,82,129,193,179,161,201,311,213,206,257,148,198,202,37,227,105,236,304
+Y10506_at,-3,-56,63,22,59,-10,21,-2,174,-42,44,-34,13,-1,4,31,-98,32,-79,-26,137,26,-62,10,64,119,57,-5,7,77,-47,-4,36,7,-80,17,-40,93
+Y10510_at,18,39,-28,9,-62,48,-65,35,48,31,-48,-27,-22,-10,-19,38,-49,4,-12,0,-69,-40,-30,6,1,-45,45,-44,-16,33,-79,26,57,49,-12,6,-38,3
+Y10511_at,84,97,212,37,40,97,25,197,126,68,36,-1,35,68,56,92,80,86,82,-9,-1,28,165,71,98,59,106,134,137,89,91,50,38,-39,81,117,43,150
+Y10512_at,-1,14,-54,79,-8,-24,119,10,-11,43,62,-15,92,68,48,81,38,33,120,-48,21,-70,-55,82,17,112,123,93,33,-33,-64,-37,125,6,-42,47,-51,90
+Y10515_at,-208,-128,-124,-240,-71,-172,-193,-233,-199,-217,-106,-38,-116,-126,-84,-134,-274,-73,-54,-163,-78,-109,-121,-34,-52,-59,-280,-120,-93,-185,-175,-180,-156,-70,-183,-73,-241,-265
+Y10517_at,56,2,9,-8,20,-17,1,62,-1,-26,-29,15,55,11,-25,32,-8,-16,47,12,44,35,-26,17,37,2,39,14,26,2,43,-44,-7,-14,28,5,31,23
+Y10518_at,75,58,108,105,72,83,47,95,81,61,110,53,1,89,6,75,106,21,125,29,67,43,13,195,23,36,18,78,50,94,4,111,147,26,22,69,10,55
+Y10571_at,80,46,86,3,88,44,16,61,36,36,46,7,70,37,86,96,53,46,72,57,72,23,-37,90,61,-1,48,18,45,16,20,24,52,15,21,51,97,79
+Y10615_at,164,25,117,134,91,184,72,152,195,91,106,87,26,64,124,138,3,60,104,194,136,57,77,176,26,174,73,114,110,73,112,95,24,37,20,111,153,87
+Y10659_at,-13,17,-20,37,105,17,-82,0,12,41,-23,12,60,-4,-10,37,-14,3,30,55,-68,13,28,3,-36,-22,14,-2,-33,347,87,37,18,-15,575,236,65,131
+Y10812_at,114,-186,-31,-221,-125,-140,-275,-197,-275,-109,-77,-171,-59,-179,-61,-65,-261,-114,-249,-161,-226,-35,-245,-262,-52,-15,-361,-57,-531,-47,-471,-63,0,-225,-175,-248,-33,-39
+Y10871_at,1125,703,981,1012,527,1180,1048,1134,1028,526,253,636,732,790,720,777,750,600,649,463,-156,1314,887,237,806,518,1017,982,1192,1151,1091,878,1165,466,810,1127,1338,1365
+Y10936_at,83,431,364,360,198,538,282,436,852,588,342,102,157,730,244,236,723,121,41,288,183,170,387,349,190,277,550,248,413,208,217,357,227,97,216,275,318,260
+Y11174_at,-23,-84,-34,-12,-40,-7,-18,-140,-44,-18,-17,-33,-70,-79,-59,-90,-162,10,-23,-114,-28,37,-75,-9,-35,-12,-100,-160,-103,-104,-134,-73,-18,-67,-88,-56,-43,-97
+Y11180_at,91,56,98,33,-1,-17,8,124,-27,56,-1,17,-2,10,19,-1,84,7,3,32,-7,-18,-34,-46,-20,-58,-4,-45,81,-142,59,78,54,-69,29,81,92,-88
+Y11215_at,604,11,1337,319,181,729,589,176,666,385,308,123,142,1174,152,322,-21,698,89,466,221,289,379,122,300,483,267,371,298,529,294,700,211,125,-20,302,341,592
+Y11251_at,248,166,330,238,271,215,411,484,398,193,299,173,251,368,412,266,495,241,172,376,94,133,286,378,190,202,245,247,245,283,282,240,265,93,221,120,322,391
+Y11306_rna1_at,397,444,755,620,225,264,668,-122,333,86,238,148,210,390,12,286,527,-150,191,301,569,457,110,205,-122,445,649,235,283,432,483,677,604,-91,374,146,880,836
+Y11416_at,-139,-564,-336,-281,-429,-92,-75,-131,-127,-205,-104,-145,-219,-300,-386,-240,-533,-219,-133,-364,-32,-43,-229,-414,-170,-241,-353,-391,-204,-264,-295,32,-552,-195,-243,-14,-471,21
+Y11651_at,162,93,215,222,507,140,50,122,178,160,277,20,134,121,315,195,292,146,50,236,298,137,89,311,155,86,-7,63,-7,178,112,203,150,89,186,28,51,7
+Y11681_at,1158,1022,1033,1520,1617,1079,1510,613,1881,916,847,265,881,898,1176,948,1540,889,647,1495,338,775,927,1065,788,744,1007,946,771,1082,1087,1259,1131,538,482,987,853,993
+Y11709_at,-469,-173,-491,-573,-144,-474,-509,-686,-507,-230,-394,-340,-178,-321,-218,-289,-345,-150,-240,-158,-149,-285,-379,-207,-366,-340,-312,-453,-459,-279,-481,-304,-169,-189,-262,-473,-302,-475
+Y11710_rna1_at,1222,537,887,455,456,538,394,538,870,384,330,323,375,372,351,623,1508,355,418,573,232,511,402,553,449,350,791,914,783,673,597,702,857,249,662,749,1027,1236
+Y11897_at,845,536,1368,767,500,545,722,1134,720,495,549,308,476,459,329,639,1406,678,572,1062,349,567,668,713,542,837,766,699,733,684,703,849,732,342,469,551,806,1274
+Y11999_at,-477,-172,-420,-772,-123,-190,-751,-679,-728,-601,-218,-262,-218,-209,-311,-313,-566,-143,-222,-102,-207,-180,-260,-220,-197,-255,-449,-358,-360,-354,-344,-318,-217,-115,-162,-315,-349,-397
+Y12394_at,250,169,-7,130,204,106,77,22,106,7,156,-25,62,28,219,79,195,68,81,91,37,78,62,71,19,-10,-20,14,33,125,132,190,110,134,73,-5,151,39
+Y12478_at,-520,-329,-199,-505,135,-117,-539,-520,-145,-14,-243,-77,89,-253,-157,-180,-202,0,-161,-662,87,-313,-429,-109,73,-325,-503,-254,-331,-216,-161,20,-213,169,-215,-100,-513,-553
+Y12556_at,-784,-324,-741,-446,-342,-279,-500,-661,-391,-397,-250,-329,-442,-371,-128,-459,-1229,-385,-600,-187,-164,-506,-393,-445,-533,-496,-790,-721,-605,-742,-486,-404,-358,126,-561,-252,-683,-954
+Y12670_at,600,337,574,716,524,270,463,689,262,167,174,258,201,180,625,330,784,314,146,636,371,180,780,655,402,190,273,1807,1038,1051,1064,2538,733,1296,647,1085,1467,1513
+Y12711_at,139,143,11,88,228,176,90,44,358,327,287,214,341,149,87,130,267,51,62,281,112,34,374,98,-46,5,-129,-93,-141,160,148,153,197,79,58,397,103,165
+Y12812_at,-32,-21,-1,-37,26,-71,-8,-10,-61,-4,4,10,-102,5,28,-10,13,-34,-36,31,6,-24,93,25,-25,-89,28,-161,33,-91,-10,-17,-8,-5,-25,2,-54,-53
+Y12856_at,377,598,122,235,278,67,120,68,400,320,456,219,231,289,225,196,684,175,205,401,308,134,191,83,476,58,478,385,230,101,282,264,273,189,236,355,340,392
+Y13115_at,236,191,385,367,226,225,221,382,423,379,511,221,610,257,206,92,378,159,206,180,329,177,509,352,134,213,403,269,367,365,359,345,247,187,176,406,148,300
+Y13153_at,25,93,67,86,71,48,94,181,197,64,64,18,17,126,74,47,240,180,118,96,57,54,239,71,127,114,132,35,185,119,216,189,109,82,34,105,80,87
+Y13247_at,997,238,938,838,586,437,932,916,785,830,385,395,520,648,491,640,706,313,66,44,449,606,560,736,215,485,345,477,630,603,98,-109,758,153,788,623,803,905
+Y13620_at,193,677,255,-137,180,145,-52,347,392,762,434,-53,322,433,142,263,183,238,501,611,714,155,393,262,133,124,646,-41,144,289,161,349,318,-7,-314,91,115,188
+Y13896_at,54,-21,130,26,-38,-10,45,61,-20,-13,-18,56,-11,51,6,-6,-12,-19,-30,-4,-42,-82,39,-9,20,-5,61,-42,-50,-77,-53,68,65,-27,-58,58,52,99
+Y14140_at,1607,1089,1866,1553,780,1148,1567,1875,1284,1071,939,468,926,882,705,768,1708,889,664,1441,392,610,1229,999,846,880,1502,1150,971,1358,1015,1257,1088,550,1595,1391,1535,2260
+Z11502_at,-186,-4,-258,12,-129,167,-6,103,-323,-115,-293,-50,-233,-165,-128,-114,-283,-134,-200,-227,-181,-190,271,-324,-164,-173,-355,-325,-129,-323,-300,-205,-272,-117,-254,-78,-380,-381
+Z11559_at,115,157,167,179,248,126,161,167,210,173,155,120,119,229,138,155,438,84,-45,231,88,136,186,195,149,94,106,127,197,117,205,145,129,38,148,125,150,202
+Z11695_at,-67,2,-77,-135,163,-87,-136,-233,-141,-120,-64,-133,17,-102,249,-74,-334,-201,-111,-47,-112,-173,-34,-66,-17,76,-470,-294,-341,9,-117,-44,-206,-57,-142,-151,21,-101
+Z11697_at,125,773,-2,40,213,284,73,199,98,160,205,1198,339,288,45,44,16,777,161,184,341,351,34,121,1389,1093,98,672,45,3850,1300,346,2270,129,2506,198,641,1896
+Z11737_at,-366,-769,-449,-359,-287,-455,-572,-1178,-942,-477,-471,-267,-403,-282,-494,-394,-1125,-252,-60,-496,-336,-442,-590,-455,-378,-315,-810,-443,-620,-681,-285,-376,-318,-157,-612,-1011,-425,-755
+Z11793_at,49,-13,148,42,28,51,21,-40,86,-10,36,51,-8,74,-27,45,1,27,20,50,108,-6,85,91,126,22,115,63,108,10,55,207,140,183,306,54,67,64
+Z11850_at,-114,-150,-150,-135,-93,-154,-114,-320,-62,-112,-41,-162,-111,-1,-22,-225,-249,-72,-91,-3,-171,-160,-36,-100,-74,-62,-242,-37,-218,-3,-223,-217,-84,31,-200,-130,-99,-192
+Z12173_at,-15,-7,-38,57,51,30,110,-56,-45,-38,-23,10,-8,49,45,-60,64,28,-20,4,-69,-18,3,7,-38,-29,-50,-18,57,177,63,-36,52,49,242,24,131,27
+Z12830_at,223,216,249,330,447,170,141,110,388,200,345,209,413,165,333,311,669,270,252,273,79,235,-1,224,153,113,162,162,125,585,289,235,191,392,628,404,526,208
+Z12962_at,16258,14570,17008,16017,17258,24528,21840,18943,13129,18960,16974,21421,17200,14992,13949,16610,12987,19782,17360,11538,17004,19092,26573,17425,17105,16958,21808,15987,28689,17491,14642,16731,14475,20653,13378,19275,16074,15952
+Z14000_at,1979,1644,2790,1480,1132,1372,1377,1710,2332,1230,1160,617,1183,1104,1242,1583,2189,1301,1135,1512,539,1574,1134,1779,1897,1618,1223,2169,1651,1892,1332,2030,2135,566,802,1267,1667,2511
+Z14093_at,-419,-499,-777,-576,-268,-695,-378,-475,-308,-393,-578,-307,-215,-460,-83,-252,-998,-218,-398,100,-2,-358,-370,-220,-350,-86,-553,-395,-440,-280,-437,-351,-407,-143,-344,-183,-333,-618
+Z14244_at,1295,1692,1839,1483,1920,1114,712,404,1838,1108,1610,1542,1781,1421,1922,1161,1081,509,800,3727,2810,610,913,903,1188,704,780,410,367,960,1569,1197,1006,1951,2018,948,717,822
+Z14982_rna1_at,1655,1065,359,699,1858,538,265,226,246,365,39,366,1353,1593,2896,956,1226,1390,800,3104,76,238,55,851,637,1301,35,72,45,804,496,-565,-344,227,341,328,18,-1
+Z15005_at,250,-7,131,172,92,120,134,50,85,50,87,-8,342,82,119,92,119,96,11,159,64,279,18,128,39,23,-62,242,134,124,155,156,54,75,67,2,97,-18
+Z15108_at,-302,-237,274,-118,-162,545,-210,-28,-258,-202,-199,44,-147,-44,-133,-171,-360,-141,-134,336,408,2622,144,-140,-230,-205,-112,-94,-189,-104,-149,-241,-36,-78,-125,-69,17,-254
+Z15114_at,978,499,987,782,484,545,618,688,865,745,645,367,327,471,451,690,976,454,529,564,362,660,664,594,437,438,937,861,711,563,647,576,828,261,625,739,725,1035
+Z17227_at,345,148,269,359,361,240,221,236,174,95,102,265,379,331,642,255,895,262,119,666,323,51,60,539,65,220,4,75,43,397,129,34,79,175,250,156,242,180
+Z18859_rna1_at,254,140,398,266,129,193,314,320,170,126,221,143,155,199,125,325,354,251,138,204,183,181,246,220,163,230,352,188,262,271,265,214,272,82,163,177,362,256
+Z18948_at,-168,-265,-27,-65,23,-104,-110,16,9,-364,19,-71,-159,213,-54,56,-350,-166,-10,-434,-259,-71,-56,13,-38,67,-697,129,36,252,31,145,213,46,-229,22,-111,373
+Z18951_at,31,38,-43,68,-107,76,-102,29,42,-12,20,-18,-116,-8,-66,-128,-157,-27,-88,-160,-164,7,-20,-44,20,-104,-42,50,14,47,-19,97,-8,-65,43,-14,-5,75
+Z18954_at,164,27,35,119,127,126,119,140,235,277,96,-50,188,225,80,392,551,239,269,258,79,115,58,272,226,208,139,254,139,295,236,182,301,181,396,36,370,386
+Z19002_at,-658,-228,-912,-719,-182,-428,-636,-676,-438,-409,-435,-377,-288,6582,-466,-501,-569,-400,-268,-375,-347,-449,-478,-520,-386,-260,-713,-121,-86,-640,-664,-126,259,23,-511,-657,-789,-832
+Z19574_rna1_at,-482,-251,-383,-416,-211,-279,-470,-557,-307,12,-199,-247,-247,-208,-25,-173,-448,-248,-298,0,-178,-298,-144,-50,-211,-188,-101,-476,-464,-343,-434,-428,-227,-379,-463,-400,-521,-508
+Z19585_at,-166,-145,-193,-43,-104,-88,-156,-130,-565,-117,-114,-33,7,-67,89,-13,-28,-77,-11,-4,13,83,-113,118,-147,-96,-172,54,-197,-2,-134,-124,72,7,199,-71,38,190
+Z21488_at,738,351,1041,447,702,375,210,1137,815,386,487,234,404,371,249,646,439,568,572,478,728,732,273,737,542,613,635,1066,379,448,294,862,395,266,308,897,414,634
+Z21507_at,1820,3141,2788,1301,2778,2178,278,526,5660,4566,2946,971,3559,1573,4952,3414,2643,1214,2424,6722,4116,1698,1603,3138,1040,3729,583,1135,1262,1557,477,1553,613,1682,1327,159,1490,518
+Z21707_at,-153,-139,-214,84,-70,-136,-198,-91,-124,-30,-152,-110,-143,-124,-105,-88,-182,-35,-188,-114,-59,-48,-129,-138,-128,-81,-209,-131,2,-204,-158,-194,-196,-90,-95,-197,-250,-226
+Z21966_at,84,31,66,31,144,-184,-68,109,75,99,81,-93,165,37,54,179,165,97,121,296,-39,45,-17,9,105,191,132,118,48,5,-8,237,155,75,42,52,2,73
+Z22534_at,47,-12,-26,-24,32,23,62,68,37,-28,-48,-28,11,-3,-7,-2,-33,-9,-106,64,102,-7,-60,69,-76,-19,120,26,-16,-92,-49,2,23,21,-77,-15,-8,31
+Z22535_at,-33,2,42,-69,-57,17,-68,26,-73,-39,-46,-10,-50,-23,-49,4,-148,-17,-37,-139,0,-11,-24,57,-112,-45,-34,-99,-38,-110,-101,-19,-82,-57,-125,-56,-20,-54
+Z22536_at,425,366,517,428,114,339,425,868,493,263,307,191,50,347,52,459,1091,112,303,528,144,431,231,339,344,397,539,371,189,531,213,650,433,211,131,544,369,759
+Z22548_at,-360,-346,248,-634,-243,227,-658,409,-131,864,850,-244,14,66,-390,-334,-780,385,108,1514,193,11,585,-210,642,10,-134,-600,485,-590,5330,5202,322,3260,-131,218,-117,595
+Z22551_at,247,222,133,228,335,119,122,193,261,131,77,89,329,308,296,289,502,136,163,728,478,163,151,290,207,116,161,112,86,-43,115,96,82,141,144,177,240,132
+Z22555_at,1946,624,179,199,703,83,483,1067,666,536,428,616,581,275,1243,870,744,799,478,1246,-9,850,49,514,471,442,275,597,139,412,85,273,523,309,91,652,1140,810
+Z22780_at,-22,43,55,25,47,-49,94,-113,17,114,11,41,2,63,-13,15,-33,92,47,8,-26,-83,-26,42,-82,-9,-26,-14,76,7,21,-8,70,3,-92,-52,52,103
+Z22865_at,56,26,5,75,74,53,126,-31,-52,43,47,0,26,51,-1,43,-54,1,34,21,28,54,98,61,-1,49,82,-2,0,-67,9,59,1,22,92,57,61,-21
+Z22970_at,146,55,218,107,30,74,129,139,186,54,31,51,102,184,21,53,280,58,59,77,17,36,100,94,2,84,32,17,93,13,71,74,58,-3,62,70,77,120
+Z23064_at,1732,1146,1690,1272,1742,928,951,1253,2205,894,1511,737,1271,1026,1491,1232,2815,782,1086,3206,743,1182,989,1450,945,918,913,777,646,719,710,805,1452,748,1020,771,790,1133
+Z23090_at,3215,1582,1798,11688,2597,2222,-527,3679,3119,4927,1174,4857,5308,1105,3260,1845,683,1088,2415,3555,1762,41,801,1394,16107,4610,-710,443,-591,1720,1117,807,2317,143,8364,1756,2406,451
+Z23115_at,747,1043,970,706,431,611,771,1947,889,386,732,367,273,539,577,376,904,344,899,1149,264,762,761,626,744,422,403,576,500,521,1478,2070,552,542,539,481,818,1798
+Z24459_xpt5_at,27,69,-58,20,42,-90,-45,-77,-61,-3,1,63,25,41,-36,-5,145,-5,-21,47,72,-125,60,-165,35,1,165,-71,-146,-101,73,9,60,17,82,-20,47,-151
+Z24680_at,217,166,210,175,169,236,156,244,321,80,-23,471,125,35,92,300,791,442,163,79,162,244,41,143,232,208,491,536,615,201,41,479,311,145,234,485,179,494
+Z24724_at,53,70,128,126,204,64,104,64,213,36,28,28,204,219,240,88,369,22,83,483,191,94,32,133,-55,32,-10,138,26,119,293,94,63,57,135,37,46,467
+Z24725_at,110,72,112,49,84,0,53,130,74,25,49,2,107,47,70,88,146,59,64,33,59,95,102,117,40,58,179,92,21,55,56,88,28,86,76,60,84,101
+Z24727_at,74,27,301,135,101,131,112,-37,231,103,85,87,95,149,48,155,323,67,86,217,64,120,140,70,133,184,245,132,201,168,267,363,223,147,210,91,326,145
+Z25535_at,208,184,176,179,344,103,201,274,191,113,436,125,820,367,351,286,704,167,326,948,533,238,121,291,133,157,161,390,269,395,256,406,343,138,328,164,174,353
+Z25749_rna1_at,8616,10125,8846,8786,12713,7612,7626,6358,13532,9079,13383,10268,6158,12465,13110,10457,9218,9526,9005,14819,16014,8223,7905,9995,6827,7655,6116,9149,6504,7334,9246,10642,11611,13069,9860,8898,10191,7754
+Z25884_at,808,518,908,678,207,705,919,1358,861,547,446,669,143,620,290,592,783,414,436,480,376,621,796,568,534,380,791,607,685,400,860,808,888,146,751,903,726,1108
+Z26256_at,-290,37,-315,-309,-76,-234,-215,-433,-22,-437,88,222,-20,60,85,-429,-1193,167,-375,-299,-84,292,-117,56,236,-244,131,-687,197,-530,282,182,-349,30,-239,-423,-493,-711
+Z26317_at,75,102,-69,-304,92,-172,-398,-305,95,-103,-9,109,-80,163,-78,152,-307,-127,205,-835,-67,-85,-79,70,28,-197,3,-285,206,-114,220,-132,-41,123,79,109,-311,-161
+Z26634_at,35,75,109,-13,35,-10,1,17,66,18,71,7,38,-5,6,47,49,11,-39,86,24,53,24,53,48,62,97,-67,-14,67,-19,50,76,47,32,18,10,107
+Z26653_at,-66,-43,-44,-215,-22,0,-45,-46,-59,-76,-96,-48,-131,-150,-11,-57,-8,-87,-86,-13,-62,-19,17,-58,-40,-49,-78,-167,-88,-114,-89,-145,-119,7,-111,-43,-155,-96
+Z26876_at,14113,15157,14563,13183,15733,17872,17560,16048,14907,14186,17036,18739,15392,15857,15872,14159,13383,15096,15526,14013,22822,15327,16703,17095,16234,13817,18660,16466,14980,15603,15026,16530,14178,18673,16736,16168,16024,13424
+Z27113_at,951,1266,1596,1170,1786,1408,1055,1565,1773,785,852,788,1144,1472,2384,1441,1353,359,1055,2311,1434,1027,1141,1007,1314,1089,1283,643,930,1185,1538,1345,1189,787,483,1314,1082,1250
+Z28339_at,100,22,86,42,58,51,5,107,86,22,46,30,33,8,88,-11,83,70,32,26,63,53,20,116,48,72,101,78,-43,37,65,85,62,0,76,43,113,151
+Z28407_at,8868,11636,7422,10420,14877,8371,6632,5937,13954,17067,11311,12908,16249,14053,16649,11518,12492,14283,11973,16895,9758,8473,7079,12468,15190,16136,10258,10736,8158,12107,16980,15662,15236,17796,13689,8750,11115,14308
+Z29064_at,396,655,296,159,611,90,179,203,826,135,481,148,365,305,545,372,1803,1004,616,997,1183,309,155,559,323,375,164,206,293,143,449,353,509,428,291,251,177,90
+Z29067_at,26,20,90,-13,45,-19,31,-47,98,43,27,12,23,18,26,78,84,102,-9,-105,74,100,60,39,-31,45,48,170,62,216,-63,109,39,-34,52,126,193,23
+Z29074_at,-460,-460,-672,-485,-180,-257,-588,-1007,-679,-263,-274,-235,-225,-359,-245,-116,-1139,-273,-88,-409,-156,-132,-250,-316,-244,-232,-591,-504,-514,-469,-373,-698,-397,-263,-502,-347,-438,-532
+Z29077_xpt1_at,-54,134,60,190,133,149,208,283,211,68,46,60,11,183,108,98,-108,38,59,112,76,230,178,118,192,63,-148,2,40,-122,212,403,277,75,15,187,101,33
+Z29083_at,7,-19,-69,91,46,-28,376,-49,0,-41,-4,7,-47,-13,83,338,192,-20,281,-13,43,104,22,138,-49,15,15,94,-62,-15,-7,476,70,9,11,-53,-4,-59
+Z29090_at,241,252,169,231,240,88,152,701,152,44,163,67,233,71,274,308,297,68,213,862,104,432,157,367,69,166,97,49,81,65,74,194,254,53,96,92,167,232
+Z29331_at,-67,9,-152,87,28,-48,97,14,41,36,234,-58,68,10,226,11,102,137,57,395,168,91,-22,71,5,5,-7,-132,-180,-159,173,394,105,209,-18,-7,91,349
+Z29481_at,674,54,612,290,378,801,749,322,771,601,572,571,357,300,665,522,624,416,511,61,199,512,636,226,474,452,425,792,721,746,564,713,558,406,739,851,832,1087
+Z29505_at,3115,2989,2689,2403,4232,2210,3268,1593,5012,2077,3358,497,3148,3907,3767,1967,7725,2404,2137,5859,3203,1156,2021,5404,1389,2622,1207,2852,2065,4298,3121,2689,2864,1859,4294,1989,1888,3995
+Z29572_at,83,136,90,131,28,-33,129,118,177,102,43,24,96,96,67,172,462,201,76,176,111,11,241,191,62,196,75,78,96,98,13,87,85,-10,137,78,115,90
+Z29574_at,200,204,435,23,18,97,47,20,209,108,34,-12,111,151,94,169,264,1010,44,224,108,121,81,142,105,133,200,121,120,22,212,143,25,5,150,-70,74,117
+Z29678_at,508,430,226,342,306,336,403,826,447,263,445,158,206,105,89,177,1405,618,259,416,221,342,269,407,418,414,622,688,88,706,481,782,401,245,462,449,712,863
+Z30425_at,486,270,767,279,277,152,289,886,431,648,97,192,442,367,202,643,526,492,194,-114,152,289,302,42,265,550,740,129,298,462,342,802,91,19,352,353,967,683
+Z30426_at,989,2541,688,159,665,90,131,851,800,644,1239,1261,2494,372,504,601,1396,239,2069,3975,251,43,45,358,4296,2079,402,501,122,116,222,143,1186,390,182,130,757,730
+Z31357_at,466,530,886,628,276,369,772,1052,560,339,421,445,19,565,384,543,878,467,422,483,312,513,311,207,560,330,771,591,327,637,726,350,679,219,493,395,779,673
+Z32684_at,20,11,-61,-115,5,-69,-38,59,23,-54,-9,-18,-62,42,17,3,-110,30,102,157,1,-2,5,-16,131,19,73,-49,74,-21,243,232,175,213,8,-56,62,75
+Z32765_at,1986,1875,2582,1669,1249,1717,2202,2418,2140,1502,1608,1097,905,1831,1120,921,1911,971,1363,1396,854,1411,1506,1377,1697,995,1813,1748,2108,4437,3572,3523,2376,1467,3227,6516,2182,2868
+Z33642_at,-46,131,182,-11,118,62,30,-25,143,9,121,-47,-3,32,46,38,194,178,-25,203,-99,24,56,107,223,-17,98,24,-125,149,135,114,20,-23,176,52,178,233
+Z33905_at,-209,-223,-419,-523,-40,-405,-794,-688,-749,-28,-321,-346,-50,-283,-172,-5,-231,-86,-264,-392,-369,-316,-311,-331,103,-174,-322,-154,-403,-401,-559,-514,-172,-99,-309,-473,-420,-570
+Z34897_at,206,242,313,77,95,-33,199,251,114,96,155,156,236,133,204,259,360,118,103,271,-24,134,64,169,23,473,261,221,211,119,124,74,87,46,134,77,263,-4
+Z34918_at,360,70,167,277,225,193,352,212,149,106,101,100,218,179,325,236,364,111,213,352,129,62,138,289,137,185,208,314,298,256,185,58,184,73,262,231,349,152
+Z34975_at,-116,24,-111,-122,183,-24,-57,-91,37,-42,-31,-150,53,55,130,80,-5,-8,7,320,-38,-164,-30,63,-81,-33,-200,-177,-170,-56,-105,-93,-121,-39,-78,-247,-89,-134
+Z35093_at,477,734,555,407,774,558,495,581,718,768,351,454,943,735,1109,441,512,353,818,1595,877,381,366,922,568,825,344,495,312,773,722,271,202,733,886,383,630,566
+Z35102_at,536,120,558,485,424,206,527,884,340,126,212,166,913,859,947,436,884,195,250,828,133,240,252,850,283,328,738,201,264,176,117,87,201,103,202,158,569,115
+Z35227_at,451,2723,1400,353,396,1107,468,1146,1527,1445,1309,617,655,1894,876,918,2264,213,426,2217,193,562,617,564,881,848,522,273,149,401,436,757,1355,257,67,180,646,563
+Z35278_at,66,349,42,24,-1,56,-57,52,189,1,185,168,325,438,374,-137,990,397,25,-50,-18,-58,-55,-118,-28,155,-170,104,129,183,347,75,504,430,181,240,734,849
+Z35307_at,196,144,265,119,99,396,196,307,278,269,222,123,-85,199,126,44,232,121,112,63,139,313,191,33,-26,76,92,-88,149,233,616,189,300,30,38,113,94,238
+Z35309_at,43,-414,-22,55,-123,49,-265,5,-113,-132,66,-94,76,3,-169,-234,-918,-312,19,-61,-2,-69,-9,154,-354,-196,-400,-43,0,-322,-80,-590,-73,-311,-515,23,-238,-553
+Z35491_at,93,544,116,134,312,158,112,401,675,373,247,50,213,299,167,254,499,121,190,1380,366,133,102,367,218,283,98,336,204,313,264,585,276,209,333,79,209,212
+Z36531_at,148,112,347,86,44,161,90,175,267,68,24,107,25,319,128,113,217,53,50,98,42,162,108,56,156,130,244,161,151,343,139,202,83,133,410,141,457,463
+Z36714_at,-232,-481,-290,-233,-163,81,-455,-1127,87,-96,-444,-143,165,-515,163,-552,-754,641,-316,-691,-373,-664,-750,-110,-473,250,-1455,-84,-127,-315,-528,-722,-849,39,-804,-517,39,-839
+Z36715_at,748,558,815,1122,458,593,811,515,202,636,324,471,886,466,503,703,947,339,609,813,274,689,706,441,665,654,558,458,322,297,1050,375,594,293,1102,482,532,380
+Z37166_at,4181,4510,4481,4018,4227,3712,4046,3440,4399,3358,4641,1207,6268,4352,5176,4316,9659,1692,3290,6969,2197,3108,4158,4878,3078,3352,2154,6737,3784,6181,2846,5211,3941,1784,4453,2452,2217,3037
+Z37976_at,201,381,407,132,185,131,147,323,122,254,12,25,153,33,210,241,395,153,56,68,149,173,146,64,313,288,411,148,12,256,201,303,233,89,131,187,236,413
+Z37986_at,1633,1767,2257,1293,1353,1417,1391,1593,2853,1189,2201,1557,1643,1705,1396,1063,2714,1403,1108,1554,828,1065,1331,1339,1891,1440,1301,1361,747,1740,1460,1826,1588,927,1801,1136,1452,1686
+Z38026_at,-263,-194,-282,-321,63,-392,-403,-415,-241,-55,-117,-237,31,-124,-35,-8,-155,-97,-62,103,-98,-248,-284,-240,-35,96,-486,60,-182,-191,-299,-98,-101,137,-109,-333,-152,200
+Z46376_rna1_at,-207,78,-217,-112,34,-160,77,10,-135,-85,33,5,-122,120,226,-75,619,-59,33,158,-24,18,-161,103,32,-99,86,-82,-245,-8,-148,106,-125,-10,12,-146,-173,-110
+Z46629_at,-18,34,-59,-69,-12,49,20,13,66,-10,-20,48,5,64,26,-54,88,-3,-42,15,-19,-9,-18,-72,25,-14,40,-30,-9,38,22,51,46,-14,42,-30,12,66
+Z46788_at,-146,-42,1,8,-42,-80,10,124,-111,107,-101,-1,-43,-59,-37,-60,215,-65,-82,-92,-2,19,-24,-102,-120,-16,126,-62,-134,-62,-10,63,-62,-26,-185,52,-93,-113
+Z46967_at,-138,-173,-123,-262,-58,-232,-80,-118,-68,8,7,-114,-55,-357,61,-181,-430,-5,27,-23,-258,-163,-81,-262,-92,-24,-406,183,-67,-135,-60,156,-124,29,-294,-122,-45,213
+Z46973_at,2038,114,72,533,220,117,300,47,80,32,157,70,329,155,212,221,297,54,136,453,42,31,28,557,101,116,43,132,43,71,64,28,69,110,56,88,40,1
+Z47043_at,-27,-143,-133,-184,-133,-37,47,92,-14,-88,-107,-112,-32,-116,-26,19,-88,-96,-72,-234,-51,-138,-119,-176,-75,-152,-79,-110,-24,-68,-182,-155,-115,-99,-151,-107,-166,-73
+Z47087_at,512,626,843,464,648,414,626,604,1023,490,965,380,664,629,547,484,630,302,627,1261,411,388,469,629,608,321,572,961,290,664,834,1194,958,511,525,684,786,1141
+Z47553_at,122,104,191,34,64,119,62,224,115,65,117,63,42,112,50,98,156,41,38,140,58,103,106,259,38,134,120,166,103,71,117,159,97,165,95,71,59,82
+Z47727_at,627,880,1365,941,952,839,887,965,845,625,636,458,690,848,959,642,820,420,317,892,364,576,699,1121,667,274,481,426,473,946,790,990,764,402,678,733,754,797
+Z48042_at,1565,1315,2225,1975,2540,1595,1890,1428,2182,1543,1317,547,1888,1814,2633,2639,5368,1251,2139,4295,605,941,1301,1989,885,396,1340,1244,694,1672,1086,1052,1437,1274,1852,1283,1435,1490
+Z48051_rna1_at,99,91,216,50,73,60,147,205,186,20,67,76,74,77,59,128,171,90,47,136,144,43,146,156,62,99,75,140,146,98,57,117,176,22,133,99,162,150
+Z48054_at,310,833,927,828,567,654,584,320,734,754,665,326,316,588,560,342,836,138,103,692,128,485,562,195,341,272,467,412,307,331,698,394,355,374,671,340,648,538
+Z48199_at,529,315,78,526,148,519,519,491,377,502,233,288,241,287,195,416,608,186,478,381,346,219,425,33,308,385,442,751,411,637,248,489,464,282,82,349,520,512
+Z48475_at,-1282,-1574,-2687,-1876,-1503,-2144,-3340,-2947,-2131,-1457,-1860,-1176,-1691,-2198,-1813,-1696,-1734,-1030,-1003,-2133,-1084,-1616,-1626,-1808,-1161,-1068,-3110,-1346,-1567,-2217,-2140,-1982,-1750,-1441,-1166,-2851,-2409,-2615
+Z48481_at,638,233,1051,481,148,633,618,859,919,178,765,375,241,623,355,385,998,74,389,397,57,755,788,640,603,129,895,859,675,202,898,456,355,139,664,221,142,918
+Z48510_at,-41,-19,53,42,-23,35,-1,68,37,-12,7,-27,-6,-6,-30,53,22,-3,-30,-44,-27,-40,-81,46,8,-35,9,37,12,3,20,-52,-2,-45,96,17,-38,-66
+Z48511_at,191,69,327,103,108,80,129,191,296,117,128,77,61,81,166,148,115,79,29,130,121,62,189,66,94,133,165,81,84,105,133,164,141,-7,133,-22,-1,138
+Z48512_at,323,240,296,303,227,195,403,359,547,292,230,60,120,140,142,390,824,282,106,79,214,156,264,153,279,340,444,44,300,354,293,127,418,42,341,247,192,415
+Z48520_at,-48,35,-27,-120,-40,-53,-100,23,-69,-33,-43,-94,-34,-78,-61,-28,-7,-4,-40,-48,-23,-61,-113,-70,-25,-16,-67,-140,-55,-49,-31,-45,-58,-49,8,-134,-30,-119
+Z48541_at,164,72,191,50,66,62,117,158,49,97,55,28,75,79,41,62,346,233,44,31,21,35,43,109,98,99,134,74,45,52,29,155,66,21,63,20,63,175
+Z48570_at,27,97,29,24,48,49,58,128,31,21,82,2,48,40,48,54,71,55,-58,30,61,-6,146,56,65,67,183,33,48,10,93,126,-23,2,90,6,44,37
+Z48579_at,255,-7,452,396,637,248,452,238,86,97,55,-5,119,122,960,362,235,48,11,166,134,-23,235,340,3,68,118,-84,45,241,174,105,37,105,78,221,280,85
+Z48605_at,122,47,99,114,108,17,89,67,103,86,-29,-10,-29,113,88,71,175,9,69,140,122,1,-30,28,46,59,89,41,108,25,25,60,-25,47,68,94,61,-8
+Z48633_at,1248,542,1465,716,1147,743,712,935,1088,159,744,17,588,1478,1797,710,1105,264,211,1141,857,255,953,1434,732,589,189,883,1110,337,192,750,-21,98,101,196,470,295
+Z48804_at,-21,-96,-38,18,-46,-369,-164,86,-453,-237,8,-116,-60,79,-35,-139,-295,-66,46,76,138,24,-15,192,74,232,-757,-339,-2,-367,-7,45,-206,21,-374,-232,-240,-310
+Z48923_at,199,304,241,138,155,234,331,415,326,159,326,73,113,131,227,178,532,180,82,242,134,162,208,58,268,250,276,104,43,210,318,327,334,137,142,143,402,273
+Z48950_at,8463,18588,11825,8847,9449,9106,9011,7850,9491,16254,6240,7218,9713,3590,8024,7524,15606,2345,5854,15573,13083,11354,9368,10048,15902,4344,7989,19485,5008,14407,13157,22822,15876,7688,13884,10842,11572,13841
+Z49099_at,1281,1310,1628,1193,1551,1253,1520,394,4038,2091,1453,1534,2840,1608,1669,1500,2480,787,1169,1718,1294,554,1282,1356,1403,1059,952,1406,1012,1889,1436,1134,1739,896,1461,1217,1456,1274
+Z49155_at,234,-68,12,-137,249,-49,-149,280,-201,-39,-55,224,-12,-151,14,26,-246,33,-10,5,307,256,81,219,19,-7,275,-26,593,-9,257,-82,-33,-9,-109,-100,43,-64
+Z49194_at,1656,-10,-91,166,405,-14,-11,524,-4,-26,66,44,530,0,443,1016,-161,1110,962,1501,247,62,-123,117,349,1529,39,-83,-16,21,-129,-126,-54,-38,-73,-79,-49,-112
+Z49205_at,-44,0,-14,-144,-30,-56,-3,-107,0,-130,8,-73,-58,-54,-30,-66,-54,17,-85,-47,-69,-74,1,-65,2,-35,15,-118,-149,-34,-66,80,-42,-82,-150,-68,-70,-71
+Z49208_at,-74,43,-7,-11,5,-35,-68,-58,13,80,14,1,-31,29,-12,-25,33,83,9,37,-1,41,-30,9,20,28,-26,66,48,69,14,43,82,2,-20,49,-25,38
+Z49254_at,1054,1100,1433,724,1762,753,920,271,2678,1436,1455,548,501,1172,1394,1011,1606,833,722,2220,79,281,816,909,576,1014,608,770,860,1382,410,618,1151,789,1698,787,581,474
+Z49269_at,-459,-239,-513,-260,-24,-156,-285,-221,-175,111,65,15,-96,-16,-224,-65,-463,-17,-221,-110,-76,-217,-463,-321,-118,-80,-508,55,-473,103,-45,-430,79,-135,910,43,235,-81
+Z49878_at,574,526,829,553,682,689,559,235,1059,1018,782,251,591,622,852,307,1040,486,677,745,359,103,714,601,773,811,363,460,548,313,493,477,992,331,426,839,971,552
+Z49989_at,159,-235,-490,-104,-254,-3,5,-448,-41,-138,-165,8,213,-190,-7,6,-248,-35,-514,-806,-214,-343,-3,-522,-157,-195,-248,-210,-45,57,-528,-781,-386,-470,-39,-136,-99,-1116
+Z49995_at,-210,-213,-270,-242,-71,-254,-267,-379,-298,-94,-124,-43,-10,-249,-25,-154,-202,-62,-239,-247,-56,-189,-74,-115,-131,-252,-294,0,-127,-195,-275,-238,-215,-123,-188,-142,-174,-337
+Z50022_at,579,1732,1849,975,1563,689,1471,751,1977,882,1894,142,1206,826,1860,1224,7034,907,931,2462,733,418,492,1407,215,415,197,1512,1058,1338,864,1410,998,1224,1406,1131,2329,109
+Z50053_at,173,39,210,253,81,158,107,70,345,94,66,152,105,85,35,162,82,85,4,58,221,210,41,138,93,96,23,157,175,160,134,98,187,27,179,163,109,152
+Z50194_at,-37,-17,126,26,-107,-202,-436,-35,172,80,76,-58,-121,-31,-77,94,-380,-28,-32,-159,-12,47,-207,-231,-116,-308,-107,-64,-504,-1,124,-210,185,18,276,-270,117,-242
+Z50749_at,254,393,550,350,364,501,231,272,614,242,333,204,315,461,479,279,435,299,187,668,83,85,239,531,165,245,308,187,149,307,248,140,221,190,301,312,448,132
+Z50781_at,2845,3388,1959,1780,3000,1902,2752,4533,3188,2726,3432,4169,2890,1084,2585,2107,2073,499,1934,3440,647,5203,1177,2024,4861,1538,1544,1496,1591,2521,3012,1915,6706,3058,2473,1139,3438,2469
+Z50853_at,433,1188,1028,396,905,825,307,157,1462,746,1567,283,447,844,1065,211,402,410,155,639,227,258,552,678,60,453,-239,267,238,9,225,264,522,340,546,251,239,47
+Z56281_at,671,624,866,836,880,960,389,19,812,641,237,423,728,765,1248,1081,1270,536,462,1484,158,116,587,726,747,1426,413,805,187,621,376,117,452,129,301,-6,552,142
+Z67743_at,569,536,737,873,496,510,665,928,651,492,467,362,377,522,532,547,1508,375,505,634,259,631,588,787,466,403,436,753,577,783,738,844,557,455,614,610,891,795
+Z68129_cds1_at,1032,453,627,573,367,565,482,325,804,530,480,439,689,467,633,581,358,404,395,1035,344,221,530,549,277,842,175,314,240,803,542,793,369,399,721,507,422,464
+Z68204_at,127,136,76,44,449,94,-26,-137,144,67,77,-10,105,257,311,107,181,117,19,252,1,-61,-11,217,51,58,-200,-99,-12,16,-73,-75,164,3,165,-37,4,-213
+Z68747_at,163,14,245,80,316,74,119,67,124,30,102,-22,187,349,310,268,405,166,137,754,97,24,121,269,155,279,75,65,43,32,-11,49,119,15,-3,-10,73,52
+Z69720_at,392,365,481,559,411,359,744,742,411,242,228,261,185,352,471,351,473,311,190,194,194,498,552,453,259,326,636,492,408,433,385,345,485,428,406,351,483,336
+Z69881_at,1766,2015,3556,828,1496,2606,473,2067,4461,1777,2744,291,3578,1706,2041,3847,8578,111,576,5796,-11,1628,1962,1306,892,2452,760,784,406,118,43,214,172,371,292,248,618,-203
+Z69915_at,617,451,710,504,381,545,379,607,710,384,856,317,479,409,525,378,1159,169,430,753,157,338,569,547,358,144,303,202,440,295,434,335,407,378,337,226,698,473
+Z69923_at,7,-153,60,-159,-83,-76,-94,5,-62,-38,-223,-57,-31,-84,-136,78,-10,-42,-10,12,-74,-71,64,51,-98,-16,-100,-27,-52,-58,-216,-369,-31,-6,-260,-96,-149,-121
+Z70219_at,506,344,265,472,311,124,336,500,609,218,335,45,318,497,310,400,565,311,222,339,108,273,288,388,324,533,386,275,264,257,511,452,364,167,255,244,402,502
+Z70220_at,-624,-176,-253,-159,101,56,159,-128,-298,-163,-387,77,336,79,141,-270,389,-294,-54,603,-126,-115,-235,-277,-132,-261,117,-522,-456,208,253,-203,-493,167,-136,-158,-148,-230
+Z70222_at,-776,-464,-424,-547,-186,-346,-467,-479,-436,-699,33,-645,-372,-764,-615,-654,-732,-444,-602,-668,-312,-359,-459,-259,-562,-448,-1073,-789,-375,-355,-1086,-644,-803,-544,-49,-393,-399,-610
+Z70295_at,-47,-53,-108,-56,-140,-129,85,140,-350,-18,-70,-143,2,-97,-131,-101,-189,-2,62,-15,54,19,-55,-127,141,-79,-214,-126,-33,79,-331,-476,-144,-45,-180,-190,-149,143
+Z70723_at,1,-31,-43,-11,-22,-3,-10,-17,-49,4,-10,-12,1,15,-6,-10,-27,-32,-4,-33,-72,18,-32,-8,1,-14,6,-71,-24,-16,-6,14,-14,-39,14,7,16,-23
+Z70759_at,16514,15019,18034,17725,18478,23815,23369,22753,15348,20012,16253,22497,16115,16465,17202,17756,13658,17086,16390,12565,16516,20888,29191,19097,16714,15861,22113,18911,35612,18167,17086,15612,15944,19003,14035,19949,18099,17099
+Z71389_at,-34,-80,-53,-327,-47,-282,-403,-512,-245,351,46,-222,-322,5,-54,171,-108,2,25,370,-257,-39,53,92,119,-152,76,114,-52,-476,-267,141,-350,-118,-47,-262,48,-860
+Z71460_at,1675,1443,1399,1354,769,1146,1181,1229,1530,1135,1035,658,821,983,805,1281,2539,1191,790,1008,457,789,1079,1105,814,1023,2146,1068,877,1370,1515,1780,1170,696,1510,1276,1883,1876
+Z72499_at,753,1302,1243,499,659,1168,522,893,1353,518,1548,372,895,595,979,537,1016,1240,497,1264,869,971,925,849,199,464,677,591,396,1372,876,1113,827,560,1064,434,969,931
+Z73497_at,-466,-666,66,-280,-439,133,-641,-1292,-681,-175,-114,-390,-247,-30,-427,-209,-610,-133,-160,-323,-54,-209,-193,-328,-596,-252,71,-504,-519,-424,-1790,-137,-373,-321,-279,-324,-676,-692
+Z73677_at,302,366,506,263,137,129,134,266,334,251,250,90,305,65,174,321,203,92,154,514,74,222,243,55,251,344,139,40,-122,428,264,401,325,99,247,155,469,270
+Z73903_at,-520,-197,-590,-38,-231,12,-117,-682,-324,-148,-408,-205,-327,-160,-74,-65,-724,-218,-291,-199,-39,-306,9,-278,-325,-275,-178,-688,-478,-637,-223,-458,-591,-274,-827,-196,-146,-801
+Z75330_at,48,65,57,100,111,51,78,49,103,62,29,27,142,104,116,77,117,70,37,69,63,64,104,115,63,73,31,61,60,8,47,70,89,34,43,81,99,97
+Z78289_at,264,177,244,124,244,211,211,239,11,161,97,116,141,254,88,172,71,207,126,264,104,105,41,10,174,153,43,213,161,136,78,199,247,17,-36,3,212,191
+Z78290_at,-10,-6,-31,2,6,19,-33,38,-48,2,-19,-34,-30,0,19,27,-20,-27,-1,5,34,-9,-13,-27,-24,-18,-4,-11,-43,-35,58,-14,35,6,-24,-49,-12,-88
+Z78291_at,-156,-197,-305,-173,-94,-163,-211,-169,-201,-159,-185,-146,-179,-257,-183,-151,-402,-128,-161,-223,-241,-177,-243,-204,-187,-181,-499,-224,-300,-382,-166,-197,-160,-71,-245,-107,-223,-332
+Z79581_at,-60,91,149,-2,21,55,60,115,121,73,10,21,40,108,-90,30,308,32,18,-20,29,65,91,47,-19,-20,179,146,242,58,51,73,135,-42,158,2,62,93
+Z80776_at,-42,101,28,-54,-13,-10,-6,38,90,-36,-116,10,-23,0,-17,-11,2,-27,-58,61,37,2,-7,4,33,285,14,29,-43,-114,10,29,63,-33,-3,-64,-13,-16
+Z80777_at,31,-168,-187,-102,-75,-39,-146,-175,-98,-26,-131,35,-28,-56,-46,9,-162,-30,-19,-51,-101,-43,-20,0,21,21,20,-86,-84,-226,-157,-49,-118,-1,-108,-133,-4,-107
+Z80788_at,-103,-135,-188,-115,-94,-154,-52,-263,-30,-66,-10,-58,-52,10,-116,-84,-150,-90,-16,-93,28,-132,-224,-113,-63,-146,-101,-153,-127,-130,-172,-163,-138,-59,-38,-146,-158,-112
+Z81326_at,-153,-145,-161,-123,32,-209,-247,-70,-82,-206,-127,-45,-62,-3,-77,27,-281,-85,-76,-107,899,-136,-113,-254,-25,-113,-220,-218,-64,-246,-191,-129,-227,-79,-134,-143,-78,-284
+Z83741_at,-110,-17,-269,-133,22,-99,-26,-229,-83,-15,-133,-77,-35,-139,-102,-90,-389,-90,-83,-191,-63,-120,-226,-158,-55,-85,-23,-221,-185,-118,-160,-114,-257,-45,-35,-211,-209,-184
+Z83742_at,66,159,252,163,108,49,304,371,-20,347,145,99,232,13,39,139,-41,79,31,246,153,-20,-87,426,389,113,250,147,-43,124,133,219,292,2,419,-17,208,149
+Z83745_at,50,-37,21,-9,22,-83,89,40,87,26,29,28,-46,28,-59,18,26,51,39,17,68,52,119,42,-2,44,84,126,122,16,33,79,60,38,136,31,45,48
+Z83799_at,-430,-431,-327,-427,-175,-448,-552,-376,-371,-143,-171,-336,-162,-247,-192,-134,-908,-276,-165,-408,-176,-436,-364,-392,-153,-170,-589,-263,-476,-420,-178,-496,-497,-69,-322,-466,-310,-660
+Z83800_at,-41,-38,17,17,20,16,13,7,44,-16,42,-24,2,-15,-3,-34,-108,19,-38,-53,49,3,24,14,42,-10,-39,-67,-38,38,-21,33,-16,-33,-4,-13,25,37
+Z83802_at,45,57,27,51,41,49,105,131,149,117,-11,-37,-5,91,16,71,110,98,4,8,68,65,108,85,80,118,111,80,115,58,95,56,58,13,86,5,64,86
+Z83803_at,-1020,-878,-1025,-821,-379,-673,-1100,-1079,-826,-519,-503,-523,-446,-554,-498,-557,-1561,-492,-690,-675,-186,-538,-687,-669,-760,-492,-1303,-677,-856,-936,-1224,-1001,-722,-579,-788,-686,-937,-1264
+Z83804_at,-24,-43,-122,-114,-10,-51,-25,-73,-133,-2,-55,8,-61,-41,-19,48,-90,-65,75,-30,17,-22,-3,98,5,-47,23,-123,81,61,39,-14,50,87,-75,69,-89,-103
+Z83805_at,-193,-906,-237,-78,-87,-92,13,-131,-249,-82,-234,-70,-148,-87,-89,-106,-535,15,190,-161,-86,-124,-203,-338,-240,-14,-275,-51,-72,-279,-65,-171,-169,-127,-329,-132,-167,-195
+Z83806_at,-45,1,-50,21,-9,-37,-26,10,-2,-21,-47,-28,-16,14,-43,-48,-37,-48,-6,-35,-71,10,9,-63,-14,-4,-12,-39,-57,-21,-18,17,-54,-34,-32,-5,-8,28
+Z83821_cds2_at,7,285,17,10,-9,-62,225,4040,-93,-10,-240,-262,-119,45,35,46,179,-224,1362,5815,234,444,-302,-69,2248,139,-82,-61,976,1,8374,13197,1191,5220,407,99,179,4694
+Z84483_at,154,91,289,282,14,128,248,329,292,212,160,86,140,85,-3,224,325,153,94,116,-27,95,172,57,16,71,123,180,50,80,150,18,181,6,110,179,340,359
+Z84718_cds1_at,-1187,-735,-1739,-832,-682,-1406,-1507,-1835,-1913,-826,-768,-612,-382,-1030,-970,-526,-2014,-312,-340,-519,-349,-1009,-1480,-917,-546,-365,-1974,-1009,-1238,-1317,-1437,-1482,-1079,-411,-705,-792,-1514,-1478
+Z84721_cds1_at,302,294,37,287,-13,-49,247,920,-151,204,-13,-14,146,348,-22,223,463,-11,879,1138,8,354,131,252,445,173,183,612,743,-93,1722,1962,278,1193,214,209,406,1845
+Z84721_cds2_at,8656,13285,15704,15691,3390,3085,23015,17601,143,5013,10580,5501,8567,14585,456,6725,11630,74,12670,7720,2810,20226,3184,4462,14550,13276,9956,10079,29588,9547,6839,9211,14629,17503,12593,9554,15235,11886
+Z84722_at,-156,-241,-581,-267,-235,-275,-302,-595,-453,-440,-247,-204,-98,-279,-361,-411,123,-302,-128,-254,-144,-137,-208,-261,-96,-28,-447,-192,-490,-658,-264,-312,-502,-111,-293,-166,-592,-484
+Z93784_at,434,506,770,348,484,423,413,391,944,479,369,181,440,560,880,459,668,124,388,1015,42,133,427,566,235,187,259,170,197,256,203,274,372,139,226,87,554,172
+Z95624_at,116,94,57,179,66,140,63,155,206,65,125,57,52,139,84,120,85,33,53,75,69,136,165,142,72,64,151,67,165,147,110,99,102,63,20,214,147,227
+Z96810_at,-122,-40,-38,-58,-45,-56,-104,-119,-93,15,-61,-79,-34,-105,0,-65,-59,33,1,50,43,-14,-121,8,21,72,-15,-93,-40,27,-53,-4,0,-54,-2,-58,-29,-7
+Z97054_xpt2_at,398,649,701,533,448,448,683,658,570,283,436,317,1027,607,516,335,875,553,334,929,159,238,351,412,446,418,510,658,420,749,864,558,503,301,699,515,364,570
+Z97074_at,188,147,131,448,106,248,265,115,380,7,163,146,292,180,285,224,133,13,141,452,173,115,163,146,218,-29,567,124,120,15,111,82,-64,115,115,205,202,-70
+AB002332_at,179,29,139,295,93,39,73,38,-44,24,74,4,147,82,98,121,-61,-17,110,158,213,90,9,231,54,50,46,163,100,47,143,129,92,135,75,202,198,238
+AB002533_at,10933,14011,11217,13028,15706,17956,14685,12649,14759,12743,14355,15757,12570,12852,17153,13025,14114,11156,12315,17591,14678,13942,18829,15029,7906,16111,13946,11377,18796,12401,12800,12673,13237,17574,13531,11078,11443,14506
+AB006782_at,5096,3141,5586,4037,2232,3529,4740,9718,2433,2829,1996,2888,3431,2803,4973,6845,4945,1886,2254,7969,2868,4470,2804,4323,3674,4817,5110,5723,4775,5733,4611,3675,5012,3051,4144,3752,4222,5526
+AF001548_rna1_at,150,197,287,296,77,119,204,325,234,129,48,107,130,236,122,186,287,66,137,141,129,88,163,246,233,182,275,127,206,166,28,59,277,29,65,56,225,82
+D00860_at,613,447,384,231,348,257,317,431,652,243,531,261,878,299,329,307,801,131,282,519,286,224,326,408,168,220,297,179,238,293,279,346,261,218,289,264,321,458
+D10040_at,71,282,15,182,227,5,369,-52,40,83,36,130,32,-7,42,85,841,257,103,422,88,138,39,647,7,30,45,191,57,2757,1245,579,226,351,1288,62,64,2414
+D10925_at,-574,-190,-516,-543,-36,-570,-519,-953,-434,-219,-293,-393,-37,-412,-185,-158,-926,-390,-345,-219,-286,-550,-370,-197,-277,-337,-492,-455,-456,439,179,-606,-344,-50,204,-463,-191,-103
+D13146_cds1_at,2343,2230,2564,2182,1859,1102,1478,2908,3627,1504,1636,1024,2578,2247,2034,2053,5077,1992,1753,3592,1835,1636,2334,2304,1969,2346,1552,2693,1772,1934,2647,3592,2367,1426,2138,1731,2310,3236
+D16105_at,983,876,1093,1663,760,867,1720,2341,1768,917,1043,786,474,1017,1039,978,976,515,993,1493,538,1263,1193,1318,1430,864,2012,1505,1286,1529,2035,1672,1399,1209,926,1124,1583,2704
+D16480_at,-247,367,-717,363,1073,167,-223,-1069,1185,190,396,-194,245,328,1019,550,-238,441,767,1371,-709,-388,-379,380,284,218,-1220,3,-312,600,592,207,400,965,688,618,185,-588
+D16481_at,297,372,416,412,653,193,440,215,351,67,330,181,510,336,787,572,1339,285,395,1106,633,-1,140,640,172,222,126,554,290,410,354,272,285,705,603,338,455,407
+D17532_at,192,-135,-134,-132,24,-170,35,56,240,-38,201,-41,-77,198,-47,64,-101,-30,160,-17,112,88,89,135,47,163,-62,215,233,-56,-119,137,57,-22,-54,73,126,121
+D21235_at,1120,847,946,1171,959,837,893,835,1139,830,1026,659,983,987,1072,488,1688,608,698,1806,439,58,849,1050,1301,1198,654,656,836,911,1202,1065,748,755,1130,489,713,1088
+D25304_at,937,371,375,283,621,176,307,-59,157,-282,-107,280,1251,198,2903,867,1901,-193,90,1911,-39,-219,-140,1557,24,216,64,-15,779,-33,-563,-495,-239,22,-262,298,-221,-595
+D26070_at,650,807,125,73,128,23,73,118,0,-33,25,137,212,149,233,401,433,122,574,312,182,14,70,78,66,331,50,151,144,249,82,79,140,47,161,81,539,108
+D28791_at,-65,163,27,-40,57,-8,-122,-46,-13,83,128,37,86,7,-6,21,-38,-13,50,78,187,30,32,-9,25,-3,-14,5,-69,97,113,226,44,45,167,-61,-37,-6
+D29805_at,3263,3592,690,995,716,958,799,3628,1341,480,2842,2200,889,1243,1624,1887,882,856,1732,2642,1049,12224,459,549,2500,1509,538,562,459,3909,2647,3340,1745,972,2145,946,1120,3083
+D31889_at,154,373,425,300,124,357,336,482,439,158,231,204,94,251,120,260,686,128,64,203,132,175,15,122,129,251,369,146,307,148,336,175,352,74,143,252,281,327
+D38073_at,994,539,1441,680,950,1258,509,331,1974,664,884,314,1991,1062,1030,675,1731,762,800,1158,1185,141,767,1145,521,700,456,238,382,245,267,342,832,294,148,309,259,256
+D38081_at,105,140,120,58,118,-42,488,161,-63,-73,148,-4,207,90,10,966,159,91,827,51,-11,15,174,149,183,560,228,-49,74,-61,25,109,41,-59,61,87,166,18
+D38122_at,36,56,119,3,65,23,-3,-4,45,82,93,7,2,90,17,0,156,90,88,48,12,34,-30,-16,47,89,35,55,40,9,146,44,8,43,88,121,70,76
+D38502_at,-210,-109,-167,71,10,158,8,-215,-275,-135,-174,-22,-94,146,131,7,140,-140,-80,-40,-414,-3,-214,-50,-27,-374,-588,-208,-127,-231,-73,242,-180,85,-376,2,-115,-167
+D43968_at,81,95,1299,205,470,805,325,233,793,584,565,217,248,559,875,153,882,175,180,534,577,413,336,773,269,72,-173,183,670,-213,238,-360,244,66,185,-413,732,638
+D45132_at,619,124,378,332,288,126,352,808,301,224,255,462,415,152,518,710,309,453,509,923,857,1543,165,369,782,577,480,811,341,539,277,440,189,101,212,457,545,437
+D50405_at,1013,780,1556,1041,683,730,1024,733,1219,595,726,435,732,864,1158,1103,1721,714,550,1594,429,317,670,1008,365,635,1004,531,598,680,571,512,722,245,458,752,1234,589
+D50550_at,-285,-412,-751,-336,-304,-746,-371,-869,-771,-216,-397,-343,-175,-303,-508,140,-439,-48,60,588,56,-311,-305,-146,201,86,-363,-121,-201,-519,-666,-235,-349,103,-475,-313,-482,-439
+D64108_at,-60,33,69,-49,-22,-53,-18,-37,-33,-20,-5,-5,5,26,-27,-48,15,-2,-15,-66,-64,-13,-37,65,71,-33,-62,-115,-69,-46,-37,-86,0,5,-87,-43,-31,-47
+D80000_at,129,193,226,247,576,199,260,224,598,165,337,156,1318,356,703,211,642,138,158,451,356,68,199,768,209,312,161,98,223,253,250,99,266,173,93,124,118,78
+D82347_at,28,33,-3,20,-2,39,63,71,1,62,5,22,22,31,12,64,144,-8,-7,-13,49,31,45,15,40,0,136,9,-33,4,47,-18,1,-35,35,19,36,-38
+D83646_at,252,66,84,139,58,142,122,133,153,214,82,133,129,100,137,125,435,65,126,132,179,224,241,252,183,80,107,210,214,212,70,110,175,83,92,134,267,210
+D86550_at,579,1606,501,448,853,318,625,653,1412,675,1781,1280,1890,777,1225,795,1780,312,473,2896,1414,1089,307,1094,1765,735,153,574,262,791,1224,1390,805,1022,947,460,591,791
+D86958_at,164,158,122,140,196,28,8,56,123,37,246,61,325,115,229,165,229,22,41,395,164,151,91,224,-5,102,97,55,40,69,129,226,142,146,50,104,163,269
+D86988_at,804,1447,1597,1535,697,1232,2105,2343,1566,426,1648,936,962,1426,1224,997,1511,964,1233,1659,695,1153,1542,1756,993,1160,1129,874,892,1800,1836,1637,1375,470,1526,1398,1360,2738
+D87002_cds2_at,-262,-419,-542,-248,-204,-771,-569,-611,-290,-599,-343,-296,-203,-830,-279,-228,-805,-43,-497,-856,272,-408,-218,-330,-406,-393,-492,-166,-786,-633,-1050,-468,-422,-277,-683,-269,-290,-608
+HG162-HT3165_at,318,49,-53,-54,174,257,191,250,175,114,118,-21,21,136,-10,134,173,148,91,143,284,112,-43,-30,112,-81,-9,335,257,165,140,259,133,-34,-7,126,-17,334
+HG2465-HT4871_at,204,99,272,206,122,78,136,283,252,163,130,61,107,136,90,125,371,38,48,187,124,125,129,137,94,125,248,106,204,137,129,260,193,50,124,96,126,280
+HG2743-HT2845_at,184,126,108,94,38,122,75,52,98,13,38,86,29,30,46,65,91,17,33,122,33,162,-17,112,21,22,68,78,62,-19,156,42,81,17,180,65,77,79
+HG2841-HT2970_at,72,17,47,35,-6,103,10,44,44,28,13,68,31,15,-10,30,13,-17,16,-5,22,28,115,10,18,5,-35,31,79,3,-16,16,37,-5,-15,5,-2,30
+HG2846-HT2983_at,275,344,518,430,488,462,208,97,1032,217,337,173,755,276,581,232,747,122,668,439,247,262,89,418,324,280,212,109,199,269,225,220,300,141,57,156,174,124
+HG3543-HT3739_at,900,376,716,563,323,398,460,1397,475,408,178,222,349,141,103,248,622,242,224,3551,482,296,450,274,90,217,524,931,500,763,488,305,799,155,481,490,651,262
+HG3859-HT4129_at,168,36,90,133,76,26,55,71,78,35,76,11,28,-40,0,-43,30,43,36,66,102,98,24,79,29,63,104,74,76,97,23,10,36,-3,87,31,76,23
+HG4679-HT5104_at,23,0,-35,0,-29,101,-18,-7,26,-3,0,20,-38,-97,19,-11,-142,-14,38,127,78,121,47,-53,-1,-20,-132,17,-76,1,6,-1,37,-43,-34,15,-16,-12
+HG651-HT4201_at,1295,1127,1062,1372,2104,926,3157,709,1579,560,1260,502,1191,986,1221,924,2191,608,797,2012,297,791,794,2200,365,961,464,730,860,1082,753,821,913,841,832,868,1271,660
+J00220_cds4_at,-138,-146,20,-384,-57,-152,-126,122,311,-305,-259,160,-164,-185,-106,-369,-517,-381,66,-67,93,-57,37,-271,-343,-271,-377,-227,-283,-525,-41,275,24,-198,-179,-62,-467,219
+J02783_at,103,488,-10,-66,1106,120,1,-46,2728,458,2261,517,834,301,602,228,597,498,301,977,1023,81,24,495,-15,492,-563,1342,509,3070,1649,1051,79,1939,5140,1052,267,1140
+J02986_cds1_at,252,89,307,191,120,113,248,271,324,243,145,90,166,102,155,138,89,211,167,157,152,243,265,203,162,197,283,325,331,249,303,268,285,42,116,231,165,258
+J03027_at,138,3,41,118,36,48,35,28,104,65,27,100,79,-69,-52,6,29,100,-4,70,-13,-43,41,-35,23,124,95,17,55,-26,-2,54,165,-25,-52,18,78,238
+J04168_at,114,56,123,139,149,92,367,320,255,195,132,143,100,109,88,98,227,134,117,92,74,132,226,240,232,146,117,119,180,285,91,250,149,65,197,122,187,314
+J04182_at,854,1675,648,1359,1432,458,898,550,1494,886,1156,402,1651,829,1657,637,2616,536,809,2148,1685,708,275,1553,323,1238,425,1259,555,2776,1735,1198,1032,1245,3848,1336,2887,1362
+J04449_at,-587,-324,-168,-463,-170,-151,-307,-520,-355,-50,-355,-225,-209,-380,-196,-291,-354,-168,-39,-342,106,-13,-471,-316,-157,-47,-158,-160,-379,-197,-370,19,-44,-161,-297,-222,-495,-108
+J04513_at,-45,37,-52,-36,23,30,47,-74,-23,-2,13,37,46,35,-8,-67,-24,5,-13,-10,-49,-10,24,7,36,9,29,9,14,177,2,-43,3,30,-5,-23,39,13
+J05633_at,-61,-94,-112,14,-9,-19,-15,86,-23,-7,-6,-53,-211,-110,-250,-180,-7,23,90,-247,-174,61,-41,95,74,43,18,-107,-52,31,155,34,-113,33,29,109,-269,-219
+K01900_at,108,135,197,155,119,21,289,32,208,90,71,146,107,126,128,64,220,116,94,123,82,137,56,107,65,146,129,269,117,134,127,74,116,63,199,194,241,159
+K02766_at,11,103,66,18,5,60,115,31,92,25,79,5,11,103,57,50,-45,40,47,60,17,44,157,-20,110,29,161,24,45,7,155,172,64,23,-32,65,44,115
+L00058_at,98,244,9,1564,2039,90,295,176,168,239,147,63,282,2109,1013,63,2243,42,57,370,872,5,134,1039,111,62,75,44,62,73,24,82,75,121,45,2,21,60
+L00205_at,339,86,-43,-17,188,-32,216,361,186,256,260,146,185,100,59,4,542,136,73,378,116,-22,-51,205,112,221,-129,82,206,-26,261,261,345,130,204,-61,18,-73
+L04282_at,609,547,403,591,395,481,329,851,663,291,412,143,541,612,610,637,1246,495,260,957,109,258,157,519,310,453,460,452,254,233,359,229,387,173,265,307,599,698
+L04569_at,-689,-132,7,-725,-242,-163,-206,-607,-133,-245,-61,-472,-369,-210,-288,-382,-1241,-456,-318,-319,-219,-529,-218,-475,-334,-38,-295,-727,-307,-890,-625,-315,-235,-181,-393,-180,-710,-584
+L04731_at,960,529,1034,1170,265,136,-309,1433,756,-576,56,-459,-11,202,-145,-256,1380,-178,-75,710,-346,-345,-457,417,-469,-142,855,1090,-726,523,741,870,710,-319,671,-495,822,907
+L04751_at,13,-66,-120,98,-5,-44,-6,107,-155,-18,-95,126,16,65,44,30,-197,-57,-27,-185,154,62,161,115,-83,59,-114,109,48,-226,-43,-352,-23,-94,142,124,-35,-196
+L06133_at,7,44,118,136,41,108,89,20,123,26,35,30,184,-8,27,43,118,35,39,156,-34,-11,112,-101,-56,-26,87,15,-67,2,90,75,8,25,34,34,1,-69
+L07615_at,73,17,85,27,20,49,-13,47,21,57,33,20,17,8,-13,55,115,19,18,18,-18,49,32,72,36,64,10,-6,40,-5,-33,-25,16,-9,3,26,27,25
+L07648_at,39,363,-33,-9,192,-21,-18,971,114,164,230,2,521,155,143,56,933,203,492,1787,343,260,260,-18,268,261,-117,539,360,311,1211,2099,311,749,347,321,432,1192
+L07919_at,89,-44,149,57,57,19,38,113,112,70,40,-17,20,36,12,31,-29,-4,5,-41,13,18,58,6,35,20,-4,44,67,2,-50,-24,-20,46,-156,31,97,74
+L08895_at,3822,0,-79,2717,2023,-55,1021,529,-135,-49,-33,145,1558,-9,2562,1148,1265,1077,921,482,33,588,-121,3189,712,1357,-14,83,113,-29,-8,-42,0,25,1,39,1170,132
+L10413_at,1922,917,859,1691,2150,645,1599,746,1958,410,787,229,2080,2035,2127,1278,3520,635,764,3718,2347,591,381,2198,660,937,790,768,507,692,405,480,452,494,937,472,777,710
+L11066_at,1208,1584,1349,741,2024,711,1238,853,2812,1795,3021,514,1962,2195,1702,1960,2825,916,3134,4246,1861,906,955,1396,1183,1456,1638,1336,1055,1705,1147,1787,3663,1570,1779,1004,589,2408
+L11284_at,675,416,505,465,747,385,515,118,691,292,749,169,576,425,526,451,907,394,413,828,346,204,125,641,208,202,204,165,120,747,350,372,590,362,491,201,555,656
+L11702_at,143,41,354,41,204,305,221,358,220,68,183,103,7,245,-5,33,417,74,81,-40,74,145,96,236,178,12,298,265,-48,204,36,216,236,45,100,213,304,231
+L12052_at,-110,-114,-90,-287,-91,-87,-97,-68,-345,-165,-154,-99,-46,-67,-37,-29,-181,-11,-45,-21,-59,9,-115,-213,-126,-105,-184,-164,-125,-43,-155,-27,-161,34,-89,-207,4,-123
+L13744_at,50,170,111,29,61,87,33,50,159,78,9,33,49,120,52,7,299,54,0,72,22,54,66,56,83,72,123,45,45,33,66,34,111,-2,25,81,109,-7
+L13773_at,639,501,379,770,488,312,843,881,728,259,584,97,914,179,572,599,1572,111,503,1823,602,251,480,1384,207,428,286,309,343,409,517,584,637,211,431,136,1122,538
+L20688_at,14552,18931,21497,15979,16141,22097,16599,18077,16795,19497,15282,13914,16150,18813,16449,18315,22334,10127,13491,18329,10248,12201,15917,17069,15835,17792,12030,14719,9765,20839,8142,3911,12096,8177,17437,17044,18788,12311
+L20860_at,77,-58,74,18,60,-101,-47,151,-20,7,24,-90,5,-108,8,64,67,10,16,-7,11,22,-64,128,198,61,-139,48,24,258,-74,80,-6,-49,10,3,98,96
+L20965_at,599,594,769,533,361,453,482,800,589,423,411,308,297,480,241,517,689,391,519,458,399,411,455,611,612,456,467,281,420,521,361,491,390,354,374,329,490,1044
+L21998_at,151,456,-23,603,533,252,-58,754,1694,814,786,467,219,725,487,781,537,575,526,1769,183,502,438,543,689,661,278,595,870,531,725,729,825,703,595,599,663,-167
+L22454_at,458,217,655,348,265,300,534,464,626,280,608,218,467,261,338,405,818,277,89,725,188,227,353,283,316,352,413,470,91,661,195,432,458,286,158,150,362,639
+L22569_at,-309,-333,-246,-481,-160,-307,-809,-1022,-487,-381,-203,-298,-384,-253,-353,-408,-801,-194,-393,-226,-337,-451,-837,-591,-394,-436,-797,-848,-945,-271,-478,-268,-290,-338,-434,-453,-485,-438
+L33075_at,2414,1034,2001,2135,2388,1059,1813,1166,3025,1093,1200,597,2403,1477,2096,1767,2275,695,1487,2270,1041,351,849,2427,626,1132,1178,421,644,1784,387,134,698,233,1244,939,1110,998
+L35263_at,221,248,126,217,281,117,233,152,261,96,340,125,503,301,419,202,611,129,298,1016,263,147,-18,288,145,152,3,152,81,327,163,517,173,331,104,-47,285,218
+L36870_at,216,-130,-201,-255,85,-103,-89,115,32,-60,127,-25,107,123,114,-46,63,-40,-129,158,59,31,-98,68,-62,35,-204,-130,-38,58,-129,-165,-107,-51,30,36,-113,-138
+L40397_at,310,936,766,260,913,449,95,67,1546,1058,2609,264,681,336,734,442,2480,223,278,784,1937,503,385,306,161,231,219,435,214,1449,1065,545,827,1855,2903,554,669,1142
+L43576_at,108,248,-51,109,26,147,97,130,-11,93,78,45,-30,126,58,104,130,7,114,86,183,56,201,190,-80,101,-56,-11,40,-1,25,103,21,50,-22,6,6,-27
+L46353_at,-31,13,150,30,23,94,25,32,12,2,23,15,-6,34,86,16,92,34,27,38,109,-14,53,126,27,68,56,44,57,63,63,72,64,21,87,10,37,21
+L49380_at,2763,2199,3309,2551,2330,3462,3160,4340,4319,1783,3470,2254,2715,2398,3025,2417,5128,1148,1641,5001,924,3978,2534,2798,2971,2618,1760,4100,2601,3767,2553,3557,3274,1708,1982,2961,3534,2978
+L76517_at,580,221,290,552,490,366,388,601,424,242,287,89,635,456,589,501,1267,173,300,725,241,370,186,543,299,375,154,326,420,309,428,365,271,331,285,266,369,962
+L76569_at,-28,-34,-34,11,4,-64,57,-32,-85,-67,-20,-58,-13,-33,-54,9,-45,-20,-84,25,-48,18,-60,-166,33,-12,-3,-101,-156,-118,16,16,36,-37,-73,-18,46,-81
+L76627_at,-95,-85,-52,-71,-9,-26,-63,-83,-36,-20,13,-21,-28,-55,0,-81,-54,-2,-24,4,-28,-83,-7,1,4,-34,59,13,-26,-85,-38,14,14,-25,-44,-6,-11,-7
+L78833_cds1_at,158,55,214,57,181,81,157,127,243,32,43,35,236,90,183,5,284,109,38,84,86,34,5,113,49,63,150,49,125,-29,52,112,93,5,57,83,27,76
+M12783_at,-450,-277,-580,-316,-110,-489,-480,-643,-196,-233,-239,-208,-228,-161,-183,-259,-357,-209,-212,-312,-166,-162,-286,-328,-241,-230,-308,-193,-218,-122,-432,-619,-128,-183,-252,-290,-312,-138
+M13577_at,-402,-229,-524,-500,-129,-419,-539,-224,-434,-195,-247,-258,-168,-334,-181,-228,-328,-232,-194,-134,33,-221,-347,-191,-247,-143,-395,-121,-163,-420,-476,-481,-370,-73,-131,-105,-379,-490
+M14123_xpt1_at,-2,-62,39,0,67,-33,-10,5,-10,16,-35,-18,85,0,18,-4,121,32,20,0,-58,3,-58,30,16,47,1,-25,91,4,10,9,18,-47,-17,-5,26,-82
+M14745_at,516,312,293,702,423,211,388,569,334,149,125,60,875,320,863,272,2109,203,200,1444,187,99,212,942,274,322,355,269,339,188,94,171,139,71,111,196,312,276
+M14758_at,68,-7,98,56,33,33,26,67,46,14,32,15,23,83,32,23,77,28,34,44,7,23,-49,85,47,58,42,28,129,41,33,125,98,-27,53,-20,181,155
+M15169_at,86,-17,208,-44,26,-67,11,-130,112,54,53,-159,91,143,73,83,167,1,-10,6,63,58,113,258,60,86,-57,67,43,321,48,232,37,11,-36,134,53,179
+M16276_at,598,-70,-282,-150,243,-195,-173,20,-161,-123,-133,133,1827,-89,-72,-3,-138,477,-44,496,333,-115,-191,431,14,230,-170,-90,-24,183,-79,-386,104,-22,-16,-149,-196,-208
+M16342_at,1430,2014,1805,1370,2205,1241,1130,1118,2771,2541,2079,959,1928,1560,1756,1735,2946,813,1197,3268,1961,810,1299,2894,1120,988,639,1157,985,1659,1715,1330,1736,1088,3011,1188,1271,1729
+M19154_at,34,0,-42,-14,0,-149,-1,13,-25,-19,10,54,-1,37,19,-99,-1,-3,-23,1,52,-31,-79,-4,39,7,-54,-54,26,-5,-44,3,14,-26,-16,5,17,19
+M20566_at,-64,-88,-214,-36,91,-147,-142,-109,-138,-62,-86,30,60,-40,98,-145,2,-21,-47,-122,7,-18,28,-4,-2,39,-114,-23,-7,135,-8,-101,-13,-7,88,-91,8,-85
+M21535_at,389,82,114,159,251,53,84,436,18,179,81,142,430,25,221,122,500,115,184,394,73,96,56,170,122,218,112,221,110,49,1,-35,75,74,-49,39,137,21
+M24283_at,124,366,-149,138,18,74,215,25,178,206,-23,219,88,148,19,15,94,301,21,10,166,234,58,155,78,144,194,143,319,2423,1072,75,327,85,884,180,341,729
+M24900_at,560,279,266,496,198,236,546,581,397,426,133,97,127,174,178,261,815,242,104,217,162,164,265,137,251,204,561,587,495,498,496,295,468,170,454,534,742,907
+M27691_at,145,22,104,128,211,24,102,292,3,27,-82,-5,134,159,401,30,240,19,-5,220,67,-13,-127,433,-5,-37,107,-22,69,23,95,-9,30,6,4,-31,150,93
+M31724_at,996,852,822,787,683,385,546,931,666,593,637,366,719,814,1048,737,1395,573,563,1117,473,714,518,752,535,534,572,1123,550,2164,1403,743,1072,311,744,671,1166,1584
+M34276_at,384,313,293,301,181,232,357,362,266,338,200,283,207,265,245,227,365,223,313,376,308,173,260,330,201,248,341,366,348,234,408,371,365,259,316,296,273,458
+M34715_at,168,91,242,154,98,184,73,80,160,142,140,63,152,77,79,127,138,111,137,220,63,58,199,151,59,50,287,213,81,243,189,203,119,54,200,116,164,168
+M37712_at,375,20,174,230,38,211,278,175,205,136,216,60,311,161,174,141,236,19,124,269,144,49,131,110,143,45,292,135,108,98,124,136,56,69,140,128,198,231
+M38258_at,412,162,569,214,212,298,21,223,41,307,330,139,298,165,214,574,329,393,384,521,124,413,220,312,419,474,403,341,72,474,486,565,480,142,-374,-15,265,519
+M55683_at,-157,-117,-379,-138,-69,-343,-67,-470,-82,-66,-104,-41,-98,-421,-43,77,-555,-184,-15,-201,-22,-92,-11,-320,-109,-525,-361,-122,-379,-403,-241,-228,-146,-57,-217,-130,-123,-676
+M58026_at,199,199,392,82,161,280,312,362,419,286,128,165,-43,157,318,181,403,150,238,37,-57,219,37,11,154,111,585,420,639,203,278,240,325,5,229,92,569,374
+M60503_at,142,16,91,21,47,58,112,64,84,49,74,-28,6,52,53,36,122,91,24,26,49,79,93,101,36,16,84,85,50,38,72,93,78,33,53,43,80,101
+M60828_at,56,24,98,11,22,-10,67,122,116,51,28,0,35,28,41,97,91,38,12,79,63,39,93,64,46,23,25,87,21,46,14,12,54,-2,29,-52,95,23
+M61853_at,72,43,180,-55,29,-1,-33,85,38,-64,-49,30,29,-14,44,-36,162,9,-32,-26,-72,-53,-83,121,24,-1,143,-118,-64,-69,-56,-116,-41,-41,-54,-24,-91,-74
+M64231_rna1_at,279,214,476,-387,74,-179,-240,494,364,41,326,54,223,-128,182,237,147,216,23,383,109,-82,66,426,317,350,-17,217,-21,534,127,490,350,158,191,69,115,612
+M65062_at,-266,-88,12,-372,-67,-279,-443,-509,-214,-167,-185,-166,-78,-318,-198,-198,-347,28,-292,32,-79,-223,-442,-358,-274,-117,-162,-195,-298,-226,-348,-335,-439,71,-80,-275,-418,-295
+M69013_at,670,331,540,430,197,161,359,872,604,201,349,229,425,338,453,443,444,321,309,718,218,542,290,329,468,439,469,517,266,419,288,419,652,98,266,400,463,785
+M69181_at,872,507,910,140,148,684,221,838,1571,288,567,40,827,529,248,219,404,850,701,718,1234,183,737,220,208,358,597,224,216,358,317,612,286,267,130,303,254,310
+M73548_at,125,-13,23,45,64,-7,15,113,-79,14,40,33,-14,2,75,85,212,-4,-3,39,48,95,15,-13,67,93,56,24,-21,79,-7,63,82,53,85,81,-29,115
+M76729_at,-663,-571,-815,-715,-522,-579,-631,-638,-762,-583,-532,-425,-502,-674,-368,-671,-941,-515,-333,-813,-406,-426,-697,-679,-599,-570,-686,-817,-694,-590,-787,-652,-604,-426,-774,-495,-726,-873
+M81883_at,62,50,75,91,48,-14,38,98,-12,79,27,44,23,22,6,86,80,33,44,35,14,61,83,68,41,64,128,12,113,-8,33,59,107,5,25,57,126,123
+M83664_at,430,89,43,96,259,142,156,248,24,102,66,127,835,-15,272,181,71,1325,228,400,99,818,134,141,67,273,298,133,690,142,16,9,216,266,159,166,119,404
+M84424_at,259,140,262,239,143,186,189,281,119,74,89,107,171,213,197,176,339,175,139,211,46,88,106,176,175,197,341,192,86,182,147,411,182,146,150,82,197,212
+M85289_at,-112,-483,-463,-212,-135,-238,-272,-215,-512,-388,-316,-215,13,-348,-226,-105,-1130,-67,71,-213,-133,-6,-262,3,-60,4,-26,-199,0,-73,-500,-328,-308,-39,-799,-337,-319,-155
+M87770_at,275,75,229,260,72,140,272,323,192,218,185,51,103,233,105,148,250,262,161,137,102,113,199,193,137,223,240,188,158,228,156,229,249,51,60,260,259,433
+M91463_rna1_at,458,345,597,699,156,215,430,971,606,442,459,183,319,327,100,169,316,130,505,535,58,98,163,27,354,321,394,537,538,721,707,531,661,444,152,830,909,373
+M93651_at,2392,4588,2846,1803,2485,1747,1970,2049,3987,1965,3336,1102,1721,3444,3171,2230,4394,828,1486,4796,1514,924,1723,2103,1731,1072,1649,1164,1195,1230,1134,1096,1894,1586,1853,2133,2466,1374
+M94046_at,4353,5115,5658,5041,4263,5583,5933,5929,9391,5610,7164,1503,4864,5508,5491,5279,8681,1666,4605,7264,2844,2973,4147,6395,1983,4378,3556,4847,4075,6042,4065,5106,3146,3782,4359,4710,5250,3379
+M94055_at,-18,-8,215,179,-3,103,6,76,41,53,71,-44,26,-71,1,73,-35,8,-19,17,112,68,56,61,9,15,40,32,50,49,-74,32,-22,18,22,78,-10,-89
+M96843_at,206,443,-39,233,395,37,40,364,16,112,-43,990,115,518,110,5,31,313,168,1418,137,64,0,-11,1087,241,59,4,43,722,66,59,174,153,616,196,111,731
+M97252_at,-266,-65,-214,-170,-135,-35,-250,-172,-242,-94,-154,-103,-147,-114,-70,-167,-193,-49,-147,-118,-84,-296,-144,-88,-44,-140,-76,-142,-93,-212,-65,-73,-87,-97,-108,-184,-241,-272
+M97676_at,560,263,556,533,282,455,662,616,654,415,270,280,360,273,312,293,517,408,366,462,177,354,406,406,254,357,671,268,507,445,650,344,223,185,129,363,642,515
+S41458_at,316,65,291,71,51,188,16,215,280,124,112,102,85,150,32,79,188,109,102,513,331,54,172,221,214,66,114,140,146,140,95,63,280,10,46,105,234,135
+S60415_at,-183,-183,-333,-103,-125,-35,-124,-356,-190,-141,-102,-54,-68,-59,0,-65,-277,-117,-79,-326,14,-260,-96,-236,-270,-291,-416,-310,-348,-171,-348,-267,-246,-107,-240,-136,-327,-444
+S66427_at,123,316,103,208,131,106,198,106,108,279,221,77,257,185,273,131,266,165,181,334,157,104,93,130,113,-10,132,82,146,235,191,320,215,223,229,139,249,173
+S66896_at,42,40,80,-54,4,53,25,149,118,61,65,8,32,73,37,47,132,26,-38,65,8,-35,34,22,80,59,25,37,16,55,34,-17,18,-15,27,53,69,30
+S68805_at,47,6,18,-31,8,1,-40,205,44,32,-31,-25,-5,59,-15,2,835,93,5,290,-2,9,20,30,-9,17,-6,-15,43,-77,-14,-28,29,7,38,124,47,28
+S69369_at,-241,0,-307,-136,-48,-128,-33,-353,-243,-32,-217,-91,-102,-43,-213,-88,-404,-60,-88,12,-134,-256,-26,-4,-38,-28,-106,-149,-228,-43,-88,73,-143,-34,-105,-61,-188,74
+S76638_at,162,34,301,109,41,5,247,293,-46,-39,136,137,41,180,96,29,-54,406,12,119,127,53,182,-19,26,8,14,83,141,1239,898,603,448,35,487,171,0,667
+S77410_at,37,-6,98,8,32,-23,21,100,212,70,134,-4,53,47,100,13,251,128,102,228,122,136,157,106,90,109,140,-42,-21,270,69,160,167,110,69,13,-5,87
+S78234_at,37,95,6,33,121,67,3,2,65,0,110,21,104,35,87,75,206,54,56,106,136,23,108,69,84,65,84,4,26,43,71,13,21,141,52,32,-29,40
+U04636_rna1_at,-27,23,-74,-63,25,-106,-43,17,-2,3,9,-94,17,-7,-6,-3,82,9,33,22,6,0,-53,43,18,82,111,-55,-74,1661,360,45,1717,25,12,-61,227,1420
+U07139_at,-167,88,108,14,-3,160,45,-17,620,44,163,-89,0,-157,83,94,-102,210,-65,341,-32,-153,-134,-47,-122,413,9,-173,-341,-235,44,-109,-118,-46,-1,-227,-236,-175
+U08021_at,-752,-408,-388,-289,-13,-496,-127,-382,-551,-194,-335,-290,-106,-338,-94,24,-550,-337,-68,-377,-362,49,70,-644,-275,-73,-707,-355,16,-218,-887,-597,-296,119,-10,-443,-373,-518
+U09279_at,49,50,53,24,14,12,23,76,52,28,16,-10,14,41,25,102,87,64,10,44,-34,7,20,129,62,69,67,-4,52,100,-5,62,44,5,22,43,52,36
+U09609_at,141,85,221,114,48,46,156,199,97,80,98,51,68,93,11,43,242,181,24,94,86,61,70,169,103,130,230,195,110,231,74,141,125,66,48,77,124,180
+U10886_at,103,56,74,80,40,28,89,109,30,-2,41,-5,23,93,-28,68,118,64,-5,19,74,17,18,78,61,32,75,22,-28,124,25,24,33,22,117,70,49,59
+U11287_at,-76,-7,-173,-146,-38,-129,-114,-44,-124,-35,-86,-21,-30,5,-93,-5,-83,-61,-112,58,-19,-27,-83,-21,-5,-141,-4,-11,31,-100,-109,-37,-92,-42,-44,-64,-83,-28
+U12767_at,73,183,106,131,44,49,105,550,84,153,306,232,19,169,8,263,21,98,112,129,436,266,169,105,103,200,120,511,129,625,228,139,484,115,158,64,84,1237
+U13022_at,262,269,659,245,419,312,243,439,737,184,235,126,396,308,233,255,1174,402,189,710,191,209,262,277,109,375,358,120,343,448,265,497,519,93,485,238,511,795
+U14394_at,811,482,834,675,489,426,764,947,937,589,536,464,338,614,346,607,1186,454,478,480,263,393,541,736,481,483,1015,778,740,897,621,656,773,321,632,715,727,956
+U16307_at,7,58,19,115,95,16,35,64,40,26,55,30,28,29,-13,1,2937,24,41,108,-11,0,-83,54,212,48,17,202,233,241,88,144,-2,78,612,406,166,72
+U17838_at,668,161,716,319,188,473,21,91,499,80,223,159,423,190,345,663,642,237,128,28,426,99,362,366,-81,177,317,577,194,548,-48,-54,-7,-19,125,429,308,-87
+U17969_at,1145,1988,2125,367,43,723,578,4,4590,-626,1558,1027,413,3997,534,156,1108,200,522,939,282,-181,792,342,494,451,1015,366,276,1957,1584,1072,1435,329,637,2286,1057,1639
+U18259_at,540,-120,-19,345,446,8,16,508,-15,-97,19,-30,409,-25,817,121,296,426,305,1370,168,-85,-191,518,-73,378,-128,-110,48,13,-159,-145,-1,9,-27,90,116,92
+U18422_at,-150,447,286,-9,-63,451,-13,32,166,235,39,-73,-92,-75,-4,-24,-4,-24,-39,29,157,-35,1119,56,-72,-2,-287,-79,-81,-109,82,32,88,182,-89,14,-67,-154
+U18550_at,-510,169,-354,-271,271,-245,-119,-1296,-271,20,116,-68,-131,-148,6,66,50,-27,-154,33,34,-398,-326,-208,-323,121,-510,21,-192,432,-174,-430,-59,-129,-176,-385,146,-426
+U20760_at,158,52,148,202,84,245,136,137,246,83,19,93,35,-72,59,120,8,117,151,23,31,102,180,55,138,-32,-34,100,153,86,88,32,166,37,382,222,153,88
+U20938_at,35,255,223,157,94,147,124,65,304,21,175,-17,65,353,156,89,615,38,217,299,58,40,-24,192,17,15,164,65,96,203,44,63,64,9,83,90,86,36
+U22680_at,-161,-116,-139,-125,-137,-119,-100,-161,-73,-30,-72,-83,-31,-149,-91,-68,-103,-29,-40,-79,-88,-47,-119,-113,-32,-130,-184,-15,-72,-67,-119,-165,-119,-91,-50,-112,-76,-109
+U22815_at,43,-26,156,12,31,-5,-16,43,9,-7,47,-24,23,26,60,51,5,15,-9,55,19,-35,3,-5,-8,53,-29,55,55,23,68,29,30,22,-17,-36,54,12
+U22816_at,31,50,45,-6,18,17,48,71,76,35,18,-1,40,29,35,76,39,49,-27,38,-12,37,-9,81,1,19,65,-9,40,43,9,32,-8,-38,-7,-17,39,47
+U25771_at,201,178,339,350,125,339,260,485,387,79,34,297,166,217,181,167,357,154,-9,142,114,173,279,197,163,144,334,-5,158,68,181,324,227,35,135,282,164,337
+U25988_at,1083,1447,1481,1003,713,1799,1003,1332,1138,695,777,405,406,1052,805,499,1331,806,284,631,-16,214,1360,798,531,951,-6,582,646,1762,996,486,833,222,1747,1103,1228,1383
+U26424_at,113,63,51,112,148,14,107,22,41,8,0,-30,297,46,105,135,107,39,19,261,19,0,-36,153,64,110,17,8,36,41,27,-6,23,43,-64,-19,-25,55
+U28049_at,344,176,354,344,157,312,406,500,384,236,99,271,141,205,174,228,429,175,151,596,-79,253,302,199,288,229,447,223,180,328,280,298,310,173,273,173,141,475
+U28055_at,45,71,172,166,-12,26,181,302,106,76,128,83,69,-18,104,115,245,133,37,233,167,-6,98,69,132,162,82,86,221,-15,35,99,107,46,-11,113,48,226
+U31556_at,513,272,255,233,112,97,-5,835,275,429,261,74,419,441,188,315,6,440,176,2186,613,559,205,412,-51,197,93,26,86,-57,127,118,146,49,26,-10,178,116
+U33632_at,54,27,66,84,43,10,48,112,53,54,81,-8,-14,77,70,64,83,32,22,61,58,49,138,116,35,30,15,-12,33,13,59,70,37,46,6,24,67,50
+U33841_at,611,35,460,463,317,202,297,511,160,101,169,37,162,102,352,280,247,188,130,339,77,14,115,398,256,214,219,74,201,207,155,60,135,81,148,85,155,61
+U34587_at,640,111,148,618,224,190,159,274,163,96,175,132,445,392,405,625,767,206,492,249,208,86,545,448,177,203,555,235,182,197,115,204,177,159,506,124,576,270
+U35376_at,-18,0,10,-6,23,-17,33,-35,-62,22,-3,14,14,22,-1,-5,111,-32,4,61,12,-11,41,6,-12,-49,40,-72,-12,-71,-7,3,-30,27,-16,11,-50,-54
+U36341_rna1_at,849,659,737,1144,617,684,1110,1010,916,607,450,377,300,658,481,735,1125,485,629,690,64,904,634,450,646,411,874,504,901,886,1708,2813,771,1459,982,829,1072,1913
+U37146_at,569,1162,1520,455,839,1098,567,383,3034,922,1667,178,981,1058,923,767,2546,670,1095,1434,668,209,739,666,281,1116,275,994,440,1603,676,677,1439,534,1136,527,1963,1433
+U37426_at,138,-37,108,206,294,23,-36,-17,457,107,292,-11,751,189,420,23,26,260,85,38,151,-68,241,25,-36,55,-90,-85,-60,-16,37,43,95,126,-56,-40,-75,-47
+U38276_at,644,757,1156,718,363,389,557,608,852,448,376,675,366,271,388,505,931,168,390,308,322,282,606,455,322,384,519,405,678,413,1066,482,539,483,1196,315,670,311
+U38291_rna1_at,287,545,70,111,101,336,154,320,465,-33,238,137,79,203,94,214,495,108,233,259,78,48,231,83,194,23,380,192,67,475,444,163,151,146,357,303,378,399
+U40571_at,106,55,23,21,118,92,87,154,88,134,123,27,-17,89,53,296,55,130,125,17,87,60,115,60,-6,120,366,201,55,43,65,34,156,13,167,121,72,110
+U40705_at,-38,-19,10,338,-16,-55,-110,295,338,-163,-29,148,60,153,72,-31,-8,-64,-77,149,21,-70,-72,-160,-127,-105,-275,162,36,128,148,-127,-47,-59,227,147,-444,272
+U41518_at,448,260,341,473,186,270,344,589,419,417,312,156,234,288,260,297,633,271,441,394,147,299,201,403,292,339,430,353,456,339,848,1011,425,384,407,325,536,775
+U41654_at,656,998,319,752,801,92,398,473,444,472,268,173,880,791,794,448,1256,344,293,1775,963,364,233,833,598,311,114,227,141,396,273,341,330,181,686,172,303,517
+U41740_at,191,186,231,160,156,124,99,169,61,120,344,-11,305,204,198,163,301,143,177,463,272,120,72,112,94,59,14,154,165,192,258,395,166,163,266,65,117,281
+U43653_at,-158,-101,-226,-60,-84,-147,-75,-103,-169,-88,-121,-30,-70,-57,-100,-88,-228,-96,-93,-44,-44,-71,-43,-145,-88,-121,-46,-94,-62,-190,-24,-65,-105,-10,-52,-71,-70,-162
+U47077_at,251,318,241,174,436,248,179,257,386,123,220,41,479,457,395,212,597,175,156,756,131,81,265,479,53,209,319,153,96,166,179,125,206,118,75,90,167,159
+U47292_at,56,32,94,-18,23,-8,117,119,75,88,95,79,82,29,49,67,-13,91,63,107,1,27,125,163,119,130,-106,140,24,144,121,137,48,11,62,95,162,67
+U49516_at,-83,-61,-39,-20,-26,-17,-67,-38,-22,-41,-36,-37,-10,-12,-11,-34,-84,-53,-66,-26,-63,-15,-55,8,-43,-47,-17,-31,-45,-56,-22,-63,-36,-77,-41,-54,-23,-64
+U50196_at,238,228,424,297,339,117,299,337,301,213,214,107,220,337,361,242,414,275,176,519,575,168,180,548,88,224,414,289,250,262,172,188,230,185,307,299,280,293
+U53204_at,1860,1351,2056,453,1058,2048,969,370,2844,1201,1754,640,1799,1285,1109,1307,1421,1110,154,1060,51,631,1288,1376,772,1437,1555,825,269,2204,884,221,772,366,3721,1017,1730,2931
+U57627_at,-74,-98,-69,-136,-86,-204,-53,-199,-156,-68,-167,-156,-39,-79,-13,-118,-241,-150,-49,-123,-112,-37,-115,-27,-164,-158,-200,-85,-91,-98,-116,-167,-181,-85,-75,-167,-127,-157
+U58675_cds1_at,-25,-52,38,58,-24,-28,23,74,20,56,-58,-38,49,-33,-61,110,33,20,16,-36,-41,66,20,33,42,52,73,63,28,113,44,40,-29,-2,42,3,-3,126
+U58675_cds2_at,428,373,643,285,326,323,325,322,619,311,227,-145,269,-48,141,439,864,298,347,499,384,421,243,517,295,131,697,490,151,486,242,399,423,157,-39,36,366,742
+U60061_at,126,131,20,277,393,58,322,53,205,94,198,8,261,132,518,368,556,51,133,983,452,54,100,452,-1,173,46,103,50,198,187,312,84,127,98,112,163,122
+U61500_at,192,112,242,213,142,188,258,188,263,50,124,50,209,222,144,159,362,124,111,312,144,120,188,312,71,128,204,83,161,206,72,174,127,65,78,109,192,244
+U61981_at,115,88,141,82,141,97,5,-4,62,16,32,22,71,78,140,130,215,42,48,195,-33,30,75,131,-7,62,97,30,36,8,32,26,42,71,62,112,134,7
+U62438_at,40,3,69,74,62,-103,104,-40,-28,67,35,28,80,38,-70,130,-4,-97,-32,101,-81,-45,62,-5,101,-52,-89,14,113,-21,-85,47,-60,5,22,-45,77,127
+U67615_at,8,7,6,90,166,152,75,-47,-24,62,-86,34,287,88,207,10,252,58,25,112,-28,-30,265,132,67,-18,17,169,-81,555,-64,-75,-10,15,217,77,-15,-15
+U72649_at,2344,4202,1579,1974,1964,1438,1413,3165,2324,1864,1482,1191,3840,1078,2549,2535,2846,1510,1417,9190,3057,3422,459,1014,3942,3051,3880,1541,889,3273,2936,3857,5150,1037,1803,1412,3448,2828
+U73936_at,-72,-1,-15,50,11,64,-25,-43,22,42,-4,-47,7,24,6,-31,-21,-2,49,39,-48,64,39,-3,-21,-67,-46,79,2,113,49,96,12,50,24,51,37,105
+U74324_at,7,-153,-106,-69,-4,14,-92,-182,-30,-72,-7,-51,-51,-33,-45,-90,-47,-39,-85,47,32,-117,-163,0,-103,-48,-255,-163,-64,-188,-171,-188,-148,-70,-206,-87,-43,-131
+U82467_at,-147,-73,67,-86,268,-209,-161,-343,-185,-141,-107,-369,65,-206,-122,166,585,274,-254,-77,-171,-34,-229,-175,-20,-94,-303,-183,-170,98,-73,32,-263,-17,294,-141,177,-429
+U83171_at,1391,1170,1435,1480,1076,620,988,1520,1422,1234,956,569,1029,1059,1032,1192,2407,8672,959,1100,298,885,929,764,988,1216,1361,1332,1281,1964,1561,1444,1277,655,1348,1068,1456,1748
+U94832_at,456,459,442,319,835,362,512,329,1099,573,1246,192,1155,643,676,511,1799,496,505,2193,564,281,334,1098,351,632,147,445,432,616,458,603,836,463,457,357,500,578
+U94836_at,-47,-142,42,-26,235,-131,240,-641,-186,-367,79,45,392,-41,87,316,-643,-114,149,389,212,95,70,214,-137,-134,-633,-132,-278,-492,-553,-178,-339,-171,-749,-132,-436,-613
+U95626_rna3_at,-27,-31,-30,-89,31,-49,-117,-76,-42,-42,-3,-35,-14,20,2,8,-48,-48,-49,33,-43,-32,-28,-15,-60,-32,-65,-48,48,-38,-24,33,0,-11,-11,47,-68,-18
+U96131_at,288,284,638,319,250,197,307,286,472,375,290,113,337,289,222,322,630,166,320,435,127,211,243,456,150,250,372,333,247,281,336,280,291,142,270,231,359,426
+U96136_at,26,13,118,42,39,62,67,67,132,27,59,28,56,59,-23,53,124,61,-2,17,-11,26,-34,144,23,47,28,61,26,19,25,36,23,26,35,68,43,87
+V00536_rna1_at,75,102,131,-10,25,32,48,43,20,39,65,74,31,73,-9,101,121,39,89,114,-3,7,94,68,104,58,137,76,-21,170,141,170,2,43,0,27,137,83
+X02160_at,2864,90,2,662,457,23,1443,473,36,8,46,181,160,41,844,250,102,45,276,333,196,685,20,345,150,294,342,39,81,130,36,96,99,11,123,154,49,159
+X02883_at,-90,-73,-63,-121,-122,-42,-104,-209,-146,3,-109,-63,-60,-86,-125,-115,-72,-103,-103,-22,-47,17,34,-187,-77,-118,-137,-102,-144,-104,-52,-42,-103,-82,-114,-228,-74,-188
+X03350_at,53,90,125,34,59,138,149,76,148,78,48,18,101,63,11,126,138,39,68,154,28,150,81,-7,23,70,151,119,189,33,6,78,126,-11,88,14,53,166
+X04526_at,2762,2064,2767,1909,2649,1900,2169,3365,5018,2101,3320,1159,2820,2190,2863,3034,3399,966,2096,4457,3219,2323,1519,3467,1087,2055,1433,1514,1062,2266,2066,1018,1697,1668,2278,1896,3046,2392
+X05309_at,114,66,140,25,90,199,63,86,147,165,236,21,68,86,20,51,37,7,38,67,-39,49,81,31,59,195,3,126,129,356,83,-67,106,49,109,85,190,178
+X05610_at,439,235,441,377,156,277,544,458,434,287,253,247,265,252,128,225,305,260,185,617,209,296,288,334,276,285,514,435,175,225,345,349,382,215,412,440,438,643
+X06268_at,173,146,230,193,132,161,147,110,184,80,108,18,116,105,28,80,153,91,55,133,51,177,167,151,185,144,81,148,96,144,141,257,71,61,73,74,227,258
+X07203_at,280,7,-80,-61,-59,126,-151,-109,-111,-21,-43,-22,85,0,73,2147,-14,1163,3113,1,22,-6,-51,-60,-26,592,128,-99,-16,-83,4,-20,-61,-19,25,-28,-60,-64
+X12671_rna1_at,3354,5648,5144,3901,6790,4500,3110,4607,9451,5971,9401,3735,5823,5639,7977,6167,11671,4316,5103,17788,18364,5902,5659,6107,7104,7323,6072,5140,4032,4819,5419,7479,10213,7804,5970,3260,3718,5136
+X14766_at,695,406,729,663,415,416,777,620,676,287,489,419,419,467,294,444,1039,423,346,461,257,473,389,524,487,555,876,462,476,668,577,533,435,275,401,384,663,858
+X15422_at,88,36,107,70,29,60,25,62,45,18,54,28,44,47,-13,0,70,-5,28,32,17,32,-1,-2,15,46,75,37,52,-52,37,70,21,18,10,17,69,19
+X15675_at,-189,-51,-110,-21,-35,-160,-57,-152,-51,-109,-148,-11,-71,-96,-66,-78,-220,-65,-68,-60,-2,-171,-131,-176,-153,-75,-42,-50,-197,-265,-118,-156,-176,-39,3,20,-105,-167
+X16281_at,-58,-6,-140,-41,-16,71,-6,-173,-120,-55,-50,-93,13,30,-19,-134,-125,-57,-36,44,-13,-32,-18,-40,-53,-84,-173,-13,-125,-86,-50,68,-60,-6,-41,-51,-59,-99
+X16323_at,10,12,27,20,108,19,-36,49,5,30,-5,10,8,17,75,-26,1149,8,4,168,-56,-14,74,27,20,6,18,45,67,-1,-6,44,12,65,32,-10,34,52
+X16866_at,47,-15,-65,93,170,110,-78,-262,60,-31,116,70,-25,142,102,180,155,20,-49,167,48,75,70,102,231,-24,4,-33,-84,-73,268,-13,197,74,-46,103,249,-16
+X17360_rna1_at,283,208,328,211,235,51,120,-50,163,184,223,74,-10,177,68,132,438,179,25,185,-188,180,32,251,54,52,-181,167,74,240,11,62,387,17,333,137,199,435
+X52022_at,96,-25,19,26,97,110,35,-14,104,2,81,47,52,170,5,121,54,13,559,157,-9,34,-32,2,75,269,103,114,86,37,200,79,49,121,193,124,86,84
+X52075_rna1_at,9,0,-28,157,35,16,-20,143,20,-37,35,30,-17,193,54,-17,68,-114,-15,167,-69,17,-66,60,-118,-27,-248,46,31,-129,-209,-94,-32,-27,-110,-39,84,-272
+X52228_at,-318,-17,-70,-93,24,-649,-144,-2,-112,-357,96,-61,-46,-118,-111,13,-1194,-384,-109,277,34,-11,-53,16,190,25,-92,90,396,-300,129,-109,12,83,-508,-258,-107,87
+X54741_at,-1062,-1549,-1186,-1643,-662,-874,-1658,-1934,-1856,-961,-616,-310,-808,-826,-609,-991,-2171,-290,-632,-770,-449,-836,-739,-1071,-1014,-738,-1744,-778,-601,-658,-1274,-574,-1102,-676,-1331,-1205,-1929,-1322
+X55005_rna1_at,432,391,565,582,309,638,730,430,491,364,312,311,301,339,270,409,775,380,298,771,322,334,410,450,323,424,694,549,466,529,433,519,542,265,567,421,602,628
+X55990_rna1_at,320,257,558,522,2670,332,443,284,396,125,182,337,263,302,212,340,284,168,222,282,124,185,245,432,295,195,403,702,146,1111,1051,284,403,3247,802,950,339,764
+X56841_at,1370,2601,820,1288,1437,633,915,1200,972,450,1162,1498,2953,2146,3374,710,1752,1224,1579,4806,624,2040,469,1399,314,1619,555,621,430,2266,1264,684,1051,1407,1629,655,2527,1470
+X57985_rna2_at,469,81,20,168,377,24,620,32,66,521,34,1225,559,-139,237,319,2492,-29,22,997,239,69,-75,1090,605,351,56,1357,-45,208,707,797,209,129,515,372,994,-83
+X58072_at,-31,404,260,-55,-4,103,-166,358,214,508,132,27,-40,1029,-37,-138,-84,43,-41,1209,-53,-26,332,-68,172,7,-64,-71,-108,-122,-70,-109,-36,-39,-40,-91,-32,-116
+X59739_at,30,190,128,176,174,23,90,125,174,13,266,61,639,181,222,16,414,-55,249,130,16,28,5,333,-1,119,40,9,38,2,134,-3,5,3,84,60,66,20
+X63468_at,219,84,116,122,270,87,184,65,143,103,61,-33,231,180,269,299,371,200,95,316,13,111,13,288,47,104,139,65,74,58,16,90,117,17,40,1,109,96
+X63717_at,313,175,376,130,229,209,243,235,137,221,102,192,73,303,163,57,341,235,100,83,112,124,5,147,83,189,148,51,192,488,435,345,234,155,309,155,192,380
+X64994_at,249,126,362,262,166,115,-21,427,324,157,289,60,234,115,41,70,280,146,92,224,74,32,151,241,127,57,167,236,134,45,244,315,229,97,-46,257,245,277
+X65463_at,-311,372,118,-577,162,-113,-97,-704,-296,256,265,18,304,154,249,85,453,142,18,572,139,-5,248,389,223,158,-740,-17,168,469,410,320,847,-203,535,-236,613,608
+X65488_at,1245,1820,1452,1058,2007,962,927,956,1881,1443,1849,329,1911,1704,2092,1414,2164,622,1524,3165,798,630,1590,1991,904,1291,694,1118,615,1506,618,723,1965,668,1125,1102,1730,599
+X65857_at,294,53,277,310,153,174,320,352,220,140,153,84,52,349,23,160,125,87,144,147,189,142,81,191,50,187,425,291,327,301,243,272,144,103,242,338,231,380
+X66087_at,98,105,195,25,64,55,104,98,103,79,88,31,112,48,28,45,75,62,82,50,161,34,100,88,47,56,170,64,132,26,63,27,55,33,52,90,122,90
+X66785_at,1854,1435,1949,2289,906,1646,1552,1316,1320,1532,962,1076,1174,2153,1015,1246,1506,573,1200,1960,1885,980,1430,1724,1307,1551,1688,1483,976,1578,1410,1353,1084,672,1512,1325,2228,1437
+X70811_at,190,206,213,80,138,94,70,82,-10,71,147,97,109,102,70,92,290,121,67,193,84,164,49,159,167,226,350,84,168,129,55,149,118,42,143,66,156,181
+X71661_at,-43,40,4,-2,7,-14,-10,-43,63,-32,82,1,44,8,14,-57,-12,-10,31,40,13,-81,-20,-38,-2,-15,18,-4,-7,-65,-9,14,56,9,37,-14,35,38
+X72727_at,2182,2724,2676,1336,2417,1191,1313,2214,2719,1250,4192,659,2611,2173,2586,2468,4246,850,1853,5957,4639,2058,1567,3378,1465,2287,1034,2537,1728,1969,1670,2265,2506,2133,2505,1033,1744,2057
+X72889_at,653,733,120,749,1119,120,1356,310,345,78,29,-22,966,464,988,563,1388,489,347,1621,685,159,303,1236,92,342,-76,683,461,117,271,148,310,302,296,306,560,44
+X73478_at,922,1338,1205,207,751,512,347,613,1746,857,521,248,1564,631,945,1136,2732,446,760,2141,378,784,786,750,549,1525,727,747,605,983,837,926,1043,788,1069,234,619,774
+X74142_at,35,-14,-35,-119,-13,-12,-53,-61,43,-16,-31,-56,2,-36,6,-596,-91,34,-80,2,-32,-41,-15,45,25,18,18,-35,-48,-166,20,9,15,23,-11,-23,-78,-58
+X75918_at,-30,65,-104,-68,1,-8,-6,-20,-9,14,-56,145,52,0,32,-16,-22,-24,281,-12,-2,-20,-20,-9,56,771,-46,60,-9,-2,91,9,568,18,5,57,216,654
+X77753_at,167,50,182,79,34,62,73,61,168,54,46,24,58,42,71,93,215,33,50,102,6,57,89,134,74,60,103,84,76,117,32,125,139,43,104,56,58,176
+X78338_at,872,1197,1227,651,631,899,504,983,1097,385,1063,372,559,1061,480,496,1346,542,492,897,216,444,621,717,476,632,643,1398,627,583,737,935,1122,546,465,1114,1075,1206
+X78686_at,131,22,76,144,23,53,1,113,24,35,63,53,49,65,42,70,155,54,14,43,-2,81,74,76,56,10,107,73,88,28,45,80,52,35,79,74,93,76
+X78932_at,-11,20,10,-39,-30,-46,-100,-86,-15,1,50,12,57,59,35,-78,-32,-53,-40,39,-23,-20,-18,-125,44,-68,-82,96,-33,-51,37,49,108,35,-10,-56,-30,32
+X80818_at,3506,2649,4016,3108,2560,2517,3069,2739,3337,2244,2244,2096,3177,2667,3023,2886,4834,2470,2221,2307,1532,2316,2897,2835,2730,2736,3928,3963,2104,3876,3058,2047,3599,1048,3444,2410,3767,4148
+X81625_at,256,401,369,331,606,186,238,166,470,258,614,195,339,353,364,572,682,153,640,841,392,291,138,456,269,165,255,573,170,644,733,722,1023,355,679,241,234,1282
+X82209_at,-150,-263,-473,-222,129,-170,-134,-260,-452,-247,-137,-5,20,-192,-78,-111,1067,-186,-145,209,-83,-163,-254,-213,-8,-97,-248,-209,-144,-202,-52,-104,-28,5,-110,-109,379,-181
+X82835_at,-63,-38,-7,-72,-17,-12,-107,-107,-23,-1,-42,-47,-25,45,1,-64,-27,-55,-85,-52,-16,-28,39,-142,4,3,-51,-103,-38,-99,-37,-48,-23,-31,-58,-61,-55,-77
+X83228_at,-111,-62,-119,-99,-24,-85,-117,-128,-74,-18,-78,-91,-31,-10,-30,-92,-25,-77,-109,-32,-101,6,-77,-64,-70,-89,0,-131,-50,-128,-22,9,-86,-58,-30,-51,-101,-107
+X89430_at,357,-40,-47,144,183,192,-65,130,50,12,-34,132,75,239,149,195,269,-55,316,17,42,249,138,-46,78,38,20,72,-98,-63,119,-14,-43,98,161,-9,47,4
+X90392_at,478,81,-210,57,48,53,72,32,28,-96,-83,166,275,42,79,30,9,36,63,206,7,-71,-5,35,107,120,43,73,-165,100,143,9,-22,202,264,31,297,5
+X92368_at,32,21,26,7,8,-62,30,-70,46,20,-29,48,10,19,-4,-52,15,24,-16,-46,22,-37,53,-31,-48,13,-4,-49,9,22,-32,41,31,-31,-53,-1,122,-72
+X95525_at,67,-8,134,92,99,8,77,28,154,85,67,-14,137,119,36,-6,190,28,-11,62,31,51,81,137,53,100,-37,65,151,-33,29,102,114,9,17,39,77,60
+X95677_at,119,141,550,62,88,373,-75,112,413,109,158,-35,86,61,84,-63,-15,-47,-62,66,-51,15,305,147,-24,-17,25,96,-38,-53,-4,171,141,38,-20,3,39,-121
+X99975_at,66,-21,-33,-5,28,87,-21,-35,-86,47,-6,45,3,-75,-5,139,0,9,60,32,58,69,68,132,48,41,206,114,-132,59,-20,49,52,58,-26,-102,-69,135
+Y00264_at,320,34,63,-11,125,-12,-35,268,37,32,-27,181,721,25,121,196,1295,148,328,2551,998,167,-68,72,74,207,344,-25,252,23,28,-31,132,10,222,28,574,401
+Y07909_at,83,11,39,10,340,14,-11,-14,173,12,10,66,58,22,51,6,796,9,-1,-13,0,22,3,23,104,112,54,7,26,15,156,10,101,98,853,-3,231,317
+Y09445_at,-588,-263,-796,-360,-196,-213,-401,-583,-385,-322,-462,-162,-151,-208,-231,-474,-371,-194,-256,-453,-399,-247,-273,-212,-254,-158,-416,-675,-678,-353,-579,-714,-565,-34,-347,-366,-767,-741
+Z15115_at,8444,1920,3118,4261,3425,1790,3810,6153,3303,1329,2525,1277,6216,3382,5831,5617,3714,1616,4692,11241,9114,2572,1601,6110,2242,3074,5374,2271,1082,2007,802,939,1238,967,1365,1568,1843,936
+Z18956_at,107,114,182,115,94,147,154,71,261,113,198,44,128,168,138,120,234,116,143,176,103,64,174,228,123,124,289,312,144,213,142,167,193,127,417,116,254,282
+Z23091_rna1_at,-24,-51,-101,5,-30,-12,-36,-94,15,-13,13,-112,-58,-11,7,-58,-89,8,-59,9,-24,-17,13,-11,-41,-73,-115,-71,-113,-81,11,-71,-44,38,-22,-107,-19,-46
+Z31695_at,-573,-235,-479,-617,-11,-819,-115,-565,-319,-570,-540,-333,-17,-193,52,-547,-284,-252,-335,-704,-284,-729,-383,103,-288,-298,-1259,-304,-264,-379,-266,-275,-271,-134,-567,-728,-646,-93
+Z48482_at,-502,-166,-597,-819,-381,-693,-811,-1054,-984,-434,-563,-616,-390,-684,-394,-533,-1314,-399,-511,-744,-760,-799,-701,-180,-647,-465,-1089,-1006,-658,-982,-913,-862,-950,-560,-614,-612,-818,-1267
+Z74615_at,954,1749,1822,1549,453,1728,2118,2722,1753,789,1499,1494,1392,1323,466,1577,826,1365,1345,1440,1061,1527,1419,1136,1412,1175,977,2017,1555,2701,1805,2003,631,1269,705,1216,649,2507
+D86974_at,21011,25240,14950,31449,12606,24722,30267,34136,13273,6933,14048,9098,16617,23337,30256,27268,28952,13297,33143,27358,7570,11829,29611,27983,13679,12146,24899,28698,25366,12956,23363,9820,14161,9486,15288,13854,22266,11386
+HG2157-HT2227_at,-34,-80,-394,-122,-3,-328,-325,-11,-301,150,-64,-182,38,-35,-4,-46,-735,137,-46,-91,-294,-214,-75,-245,-180,194,-660,177,14,-95,-530,-908,-282,-166,-325,-260,-275,-201
+J03060_at,-370,-182,-107,-142,-57,-69,-132,-517,-232,-80,-114,-58,-33,-149,56,5,-161,-148,-109,-220,-103,-266,-136,91,-328,-99,-212,-57,-274,-339,-563,-237,-322,-130,-160,-279,-211,-486
+L41390_at,124,118,-2,108,118,-51,3,271,41,-25,6,54,42,-1,116,59,360,48,53,81,81,61,20,97,28,57,-7,2,100,71,11,-11,44,25,192,54,4,16
+M37485_cds1_at,-310,-120,-239,-191,-163,-110,-201,-308,-145,-105,-171,-58,-171,-133,-89,-80,-350,-131,-55,-118,-56,-107,-146,-174,-202,-152,-256,-124,-132,-158,-43,-143,-132,-79,-117,2,-174,-43
+S62907_s_at,-87,-63,-130,-96,-58,-26,-104,-55,-4,-26,-80,-41,-40,0,-23,-56,-134,0,-37,23,34,-24,-129,-66,-29,-56,-123,-81,-62,-63,-65,-58,-31,-31,-58,30,-46,-53
+AB000381_s_at,29,8,11,38,50,35,142,122,80,72,-12,-8,52,89,72,90,127,80,18,39,-31,-24,-62,113,62,45,73,48,-31,9,120,147,-16,70,44,61,104,110
+AB000410_s_at,-336,-361,-508,-116,-129,-448,-331,-562,-542,-89,-281,-379,64,-295,52,-282,-625,-104,-290,-40,-106,-334,-321,-78,-99,-137,-603,-307,-322,-438,-385,-464,-209,-205,-342,-524,-530,-520
+AB000816_s_at,-30,-5,-94,-20,8,19,-31,-25,-209,-38,-40,-70,-20,12,53,-73,-54,-97,-129,-54,-2,-53,-20,-141,14,-52,-68,-128,38,35,-68,-104,-38,-13,24,-92,-47,-86
+AB005535_s_at,-16,-53,-130,-41,-41,28,-92,-119,-86,-68,-49,-67,-24,-49,-27,-27,-175,-55,-57,-48,-41,-7,-125,2,-13,-29,-125,-79,-9,-124,-98,-28,-11,5,-63,-32,-78,-70
+AB002356_s_at,1813,1033,1900,1502,1467,1171,1759,2112,1969,862,932,728,1442,1369,1230,1561,2896,1289,1565,1739,773,903,1134,1646,914,1288,1686,2023,1625,2141,984,1820,2084,1329,1436,1004,2167,2801
+X95808_s_at,708,175,236,476,345,44,428,-35,603,462,293,1,736,497,156,120,807,90,120,154,392,64,402,676,118,603,369,705,307,203,-123,-70,240,66,137,315,175,139
+Y12393_s_at,112,240,65,111,143,-3,10,164,106,96,134,33,65,104,98,67,276,0,65,202,0,99,30,165,145,66,197,42,100,50,195,266,218,118,304,81,227,494
+AB006781_s_at,3,70,247,56,105,136,68,67,104,175,43,204,41,-38,7,56,-15,34,206,230,74,179,155,77,147,177,107,259,79,38,242,228,114,43,22,79,62,144
+Z49107_s_at,3226,2033,3065,2567,2090,2350,2517,5309,1739,1199,1199,1493,1316,2099,3194,3468,2361,527,741,5692,181,1582,1795,2253,2015,2470,1664,1754,1562,2022,2942,758,2300,1543,2279,3198,3241,2983
+AC000063_s_at,414,299,459,214,96,382,569,545,378,287,266,258,349,179,165,297,483,219,174,349,174,234,218,353,196,272,539,360,55,457,424,340,385,79,358,234,491,390
+AC002045_xpt2_s_at,2538,3684,2309,3237,2541,2519,2977,3141,2342,1093,3164,1069,2277,3351,3629,1755,5179,825,1638,4648,1148,1081,2220,3714,2150,1014,1586,4372,2921,2198,1860,1441,2050,741,2569,1158,3591,1926
+S62027_s_at,-77,-30,-79,-27,-41,23,-31,-44,-23,-36,-52,22,-47,-37,-64,-56,-44,-39,-42,-83,-73,-18,-131,-64,-5,-127,-6,16,2,-17,-19,-32,-26,14,-34,-17,-31,-51
+AC002477_s_at,840,752,675,726,544,398,569,356,545,466,560,455,476,586,563,508,778,453,364,816,490,427,324,520,839,486,763,420,298,876,459,577,577,444,644,544,694,414
+AD000092_cds7_s_at,58,128,55,5,-174,156,287,-1188,323,-706,487,70,-333,-532,-108,-143,-966,-266,-77,-431,18,-189,5,559,550,260,-1605,-449,-524,-432,373,-279,-591,46,326,-167,-26,259
+D10667_s_at,-145,-75,-47,-89,-32,-76,-89,-100,-121,-83,-12,-120,-19,-39,1,-62,-127,-55,-60,-141,-122,-175,-140,-103,-61,-81,-115,-1,-88,-101,-101,-172,-60,-62,-12,-79,-59,-187
+AF001787_s_at,-178,-63,-114,-123,-33,-94,-38,-188,-73,-119,-131,-60,-65,-94,-46,-117,-166,-90,-100,-127,-123,-103,-81,-108,-52,-86,-132,-87,-103,-59,-148,-214,-24,-55,-152,-142,-189,-174
+S76853_s_at,10,0,-35,53,-18,30,20,-56,21,-39,-26,-25,5,0,-4,-17,-52,-23,-11,-25,-28,-20,-64,13,6,-35,4,-69,16,20,16,44,0,-22,-31,-28,-48,39
+AF012024_s_at,257,46,139,168,94,197,188,61,269,99,132,54,89,199,147,182,358,-1,65,128,123,-2,98,93,153,121,90,28,50,29,98,41,43,50,12,45,68,4
+AJ000099_s_at,987,713,1102,1267,1006,1333,1571,1697,1722,687,1242,939,803,1192,778,1459,1809,1623,695,1687,837,1294,963,1228,1428,840,1209,982,762,1278,1323,2140,1294,1012,701,1093,1665,2735
+D00408_at,-58,19,15,38,46,-44,28,118,44,-12,32,71,6,-11,7,22,101,-22,-14,4,-12,14,39,-2,35,24,25,-14,-2,-3,-9,-20,-55,7,35,6,1,33
+D00408_s_at,315,78,345,138,144,247,285,620,247,96,16,93,-4,130,57,106,614,27,82,155,112,255,294,5,314,232,696,227,197,81,157,381,342,98,132,128,119,173
+D00003_at,-963,-592,-1074,-937,-548,-732,-888,-1344,-1459,-507,-827,-635,-666,-663,-536,-686,-987,-632,-493,-711,-348,-884,-843,-1007,-616,-585,-941,-836,-841,-1179,-944,-874,-972,-470,-668,-714,-929,-1170
+D00003_s_at,2,-21,1,-266,-22,46,43,49,-41,-42,-8,-54,-22,-7,-55,-89,68,-81,-119,-62,-91,-133,-172,22,-77,30,3,-223,4,-98,3,1,16,-142,-31,-64,-54,-29
+X83416_s_at,117,494,55,283,235,67,245,232,316,118,310,408,559,204,630,171,767,28,180,361,1115,278,58,607,607,76,100,112,93,329,561,247,329,269,727,132,231,478
+M23178_s_at,68,840,58,114,55,48,191,235,99,241,139,313,74,132,83,107,218,191,19,46,143,51,148,122,8467,136,195,147,33,14080,5450,1180,1464,-34,1718,370,556,3985
+D00097_s_at,-240,-78,-61,-183,-83,-51,-216,-259,-165,-54,-8,-127,-59,-121,-117,-33,-157,-51,-53,-39,-11,-142,-208,-145,-96,-71,-190,-115,-187,-17,-142,-72,-110,-11,-126,-56,-121,-264
+X02419_rna1_s_at,104,1,13,186,35,101,20,221,225,66,38,-14,76,130,3,-11,321,147,18,61,-23,154,89,139,-25,66,312,111,62,-43,100,86,210,199,326,39,77,567
+M18700_s_at,577,511,634,384,259,430,307,632,484,141,419,298,284,181,467,314,627,528,321,539,194,189,600,591,278,179,488,232,413,409,272,426,778,235,497,269,540,473
+Y00097_s_at,918,1217,2016,737,1564,1024,383,1296,2806,968,1455,186,469,1942,804,775,1669,959,549,1261,177,347,1305,984,451,460,600,881,485,1012,350,405,804,362,1130,742,720,632
+M37271_s_at,667,1439,3448,650,524,2946,710,805,3467,2418,1368,692,223,4174,674,658,1380,381,380,826,-49,591,2304,341,616,100,622,678,589,728,708,551,849,528,564,873,1700,1045
+D00749_s_at,1897,3753,8776,1208,1489,5585,1211,1104,10739,5078,3920,688,1144,9437,1034,2660,4848,1206,971,2224,892,716,4609,1188,1020,1555,1319,1048,803,1854,917,1147,1508,892,1120,1603,2549,1397
+X15331_s_at,1262,915,1652,709,348,944,806,1466,633,544,480,454,1115,-164,525,788,1732,537,340,39,6,396,877,787,84,356,153,367,471,1306,807,805,1113,-110,-222,523,750,1158
+L09229_s_at,879,549,853,802,500,369,1428,1083,877,706,416,456,427,542,303,421,2097,754,412,705,84,647,414,1464,452,426,835,1078,675,7891,4259,1333,832,574,3292,855,495,6723
+X62429_s_at,40,6,33,24,24,-26,85,107,35,14,22,-14,3,23,9,35,-8,-7,20,-12,-6,20,3,-57,-9,3,75,6,-4,-2,66,34,7,-21,20,69,78,53
+L32832_s_at,-16,175,-7,166,133,1,139,850,96,117,91,135,102,41,215,331,-47,306,237,551,92,58,-39,689,115,190,190,200,173,117,18,28,111,50,68,90,492,180
+D10326_s_at,-2598,-2822,-2549,-2839,-1751,-2633,-2743,-3233,-3110,-2111,-1831,-2092,-1694,-2681,-1970,-1805,-4748,-1210,-1842,-2467,-1173,-1605,-2289,-1994,-1721,-1622,-4281,-2519,-2402,-3001,-3301,-2648,-2576,-1288,-4821,-2885,-4493,-3205
+D10537_s_at,334,434,209,337,134,362,534,721,457,311,111,600,-8,289,234,45,433,288,155,83,279,309,302,104,137,279,561,471,295,546,804,198,471,241,459,555,503,196
+L24893_s_at,0,-43,-74,-151,-43,-104,-68,-22,38,-106,-41,-76,-24,-90,-81,-90,-105,-105,2,-17,19,-22,-47,-59,-17,1,-200,-188,12,-86,-27,-59,-147,0,-17,68,-51,-63
+D10922_s_at,-26,-29,-7,-47,-19,-58,1,127,-61,-25,-28,-20,-26,25,18,0,-73,-52,-9,0,46,14,1,-46,1,-66,-21,-12,-79,-33,9,4,24,-15,-19,-24,-34,2
+L06797_s_at,9144,4090,3192,4750,7453,1897,7593,13214,2551,1983,3680,5705,13883,851,8568,5256,3574,952,10643,15357,7292,10404,2540,4516,10295,8649,4273,461,216,4451,1221,1294,6127,1842,1425,499,1833,2395
+L09230_s_at,-192,-64,-354,-202,-69,-252,-173,-194,-332,-178,-126,-202,-98,-130,-83,-47,-509,-124,7,1,-24,-142,-315,-93,-43,-43,-503,-83,-125,291,314,-237,-64,-123,30,-107,-24,473
+D11327_s_at,180,604,1111,36,67,657,134,43,1159,363,222,71,98,2004,78,108,607,152,56,-6,8,14,332,118,-7,166,140,535,358,530,376,295,387,121,440,218,201,517
+D12620_s_at,-11,45,-91,-107,130,-62,8,-79,75,76,-37,-83,49,-189,-110,32,366,112,90,183,-44,-128,-72,-21,-64,-91,209,205,-250,71,-147,147,169,-54,142,-24,-77,107
+D12775_s_at,381,329,313,395,221,172,613,191,241,149,175,333,347,454,317,210,566,244,141,124,133,51,281,486,338,218,345,205,250,358,438,245,390,158,337,236,414,486
+M19650_s_at,198,283,433,346,209,489,275,128,371,321,280,183,215,287,330,295,261,153,134,339,124,282,302,348,226,40,156,329,117,275,574,19,438,71,309,334,317,218
+S50017_s_at,496,471,571,644,342,677,655,778,612,415,522,389,324,520,630,343,539,383,374,248,162,593,552,664,339,238,769,553,423,573,526,402,657,269,257,517,556,692
+M15465_s_at,285,299,752,-53,181,519,33,470,400,307,220,194,237,360,256,320,566,219,337,436,8,194,573,465,554,405,408,335,-151,367,745,286,538,293,474,381,249,442
+D79206_s_at,639,635,1158,683,510,823,695,782,899,673,556,801,563,578,433,718,1257,913,571,806,539,925,642,836,571,844,1095,948,485,2394,2128,797,1045,560,2404,459,1011,1872
+HG1686-HT4572_s_at,-191,-33,-295,59,213,-124,-376,35,24,27,146,285,52,-303,131,57,40,115,160,357,459,160,0,-168,232,16,-204,-112,-384,195,406,366,1238,214,152,70,-213,281
+D13413_rna1_s_at,17139,21863,18189,18894,15341,16876,15252,17138,21607,16595,12754,19110,11793,20085,21445,20273,21779,21753,16458,16418,31453,20524,21233,16553,21381,20981,22469,20590,17171,17536,22013,22575,21599,24526,19501,10623,18228,16657
+D13631_s_at,835,492,380,655,484,449,566,251,336,182,149,587,1081,340,2066,857,2438,276,277,1183,-18,36,212,1565,199,136,386,546,798,282,149,6,239,173,257,570,348,135
+D13638_s_at,-26,-16,-75,-58,-14,19,-94,-92,-58,-37,-50,-35,-42,-21,-43,-47,-138,-68,-39,-46,-12,-48,-47,-60,-99,-47,-162,-30,-67,-11,-22,-113,-119,39,-41,-44,-82,-121
+D13666_s_at,1,27,72,-24,8,64,42,4,132,33,43,20,40,-35,23,29,63,54,39,35,3,19,-17,51,14,46,148,67,4,56,35,78,84,27,0,10,37,7
+D13705_s_at,519,701,658,1209,292,1138,1374,989,628,692,578,755,478,545,486,684,1405,369,591,766,283,872,1037,527,603,530,1453,887,824,995,1426,958,872,550,1103,708,759,1476
+D13720_s_at,312,396,434,201,125,280,258,364,288,178,207,110,137,331,118,137,307,153,125,185,62,201,391,157,107,120,136,171,242,243,143,167,127,101,129,147,101,282
+D13814_s_at,242,28,203,66,51,56,105,86,117,44,85,11,69,83,45,75,10,2,49,34,136,-10,283,126,-8,-11,-126,221,-12,-101,22,40,87,29,-1,20,63,19
+HG1400-HT1400_s_at,447,344,427,364,627,183,221,263,827,95,188,132,994,500,714,802,1115,191,211,1259,294,81,106,619,191,305,140,81,163,286,135,111,73,201,191,94,112,244
+HG2348-HT2444_s_at,339,-241,469,147,8,257,45,223,-146,105,243,-12,-53,150,142,241,-425,16,27,156,-143,-243,-123,85,224,301,-158,-167,233,-347,-251,477,177,263,-205,-2,-438,707
+HG3362-HT3539_s_at,263,325,47,310,128,60,369,406,338,224,276,182,65,280,46,55,562,136,179,193,-39,183,117,105,275,22,156,23,93,257,298,253,254,69,267,-10,350,305
+HG1699-HT1704_s_at,-94,-25,-23,39,33,96,26,-107,2,-79,6,-2,-32,24,47,-28,-32,5,-15,-15,-46,-149,-43,11,6,10,-42,-63,-76,-5,-32,-14,-36,-1,10,-26,-12,-24
+U41766_s_at,-23,39,-58,-57,13,12,8,-32,12,60,138,1,83,-21,0,-23,-25,23,40,55,164,17,13,5,17,-27,-6,81,-26,178,111,111,99,79,150,23,32,203
+D14826_s_at,49,252,55,95,57,129,63,67,111,62,76,63,140,0,72,53,154,102,68,115,147,-44,64,92,93,98,106,43,-26,172,73,105,229,63,80,51,134,1391
+S68271_s_at,1,308,233,-13,62,46,90,70,146,79,202,102,77,86,56,84,36,180,59,56,119,26,94,90,65,46,-45,76,-7,122,120,105,200,53,67,13,94,975
+HG2075-HT2137_s_at,-50,-75,0,-111,5,-33,-50,-101,-56,-25,3,-44,-38,0,-15,-43,-106,-41,-51,-10,-74,-49,47,-79,-33,-59,-189,-80,81,-13,-65,-102,-43,-21,-67,-17,-31,-51
+X52213_s_at,-321,-313,-555,-152,185,-360,-378,-53,-386,-357,-68,-215,-64,-250,-163,116,-329,-198,-182,-618,-182,-15,-132,344,1,-198,-677,839,-242,-385,-97,45,-317,118,46,-545,-366,227
+Z49835_s_at,922,1230,838,710,1436,585,576,433,1686,852,1441,791,985,419,1125,448,2249,258,541,1430,197,1132,488,1169,739,190,325,1045,757,2298,1848,1292,885,1086,3374,1614,1074,1104
+HG4541-HT4946_s_at,2215,2320,3009,2013,1963,2094,2144,3566,3927,2200,2588,1056,2085,2105,2211,2263,5671,1395,1448,4020,1515,1740,2306,1972,1784,1793,1858,2222,1986,4092,4557,2892,2600,2883,3450,2813,3458,3838
+D16611_s_at,154,62,132,-11,116,72,136,74,124,119,28,15,112,252,12,136,201,169,15,114,-29,75,49,81,23,43,167,8,120,13,187,118,90,99,63,64,7,270
+D16688_s_at,-139,320,-115,-1,0,14,-26,-112,48,-12,-80,-56,-65,17,10,42,-24,3,-100,-20,-7,45,70,-115,-103,-79,45,-53,-81,-101,-29,67,27,53,-81,-27,105,-7
+D16827_s_at,-319,-141,-643,-365,-83,-426,-361,-376,-27,-181,-318,-336,-239,3,-147,-191,-574,-294,-48,-528,-103,71,-334,-257,18,-195,-176,-402,-110,-21,-347,-471,-503,-66,-382,-640,-370,-675
+D17408_s_at,-26,-53,-118,-123,3,-32,-73,-160,11,-91,-19,-22,6,-36,-63,-67,-17,-36,-20,13,62,20,-51,1,-53,-26,9,3,-69,-65,-98,-47,-52,-89,-108,-81,-87,-83
+X83929_s_at,4,-64,-63,-66,-45,-8,-94,-53,-56,-80,-81,27,-15,-11,0,27,-55,-27,-27,-12,-18,-36,-28,-55,8,-22,-42,-57,-38,-10,-45,-68,-7,-43,-1,-47,-62,-95
+U00802_s_at,109,-483,-145,-878,-71,-218,-783,-274,73,-28,-248,-442,506,-122,-398,352,-635,-167,186,1823,-226,-137,-182,-463,-442,47,-192,-585,-622,-686,-647,-722,-625,-190,-793,-401,-532,-739
+Z11685_s_at,108,175,25,67,104,24,82,128,133,149,97,57,76,98,143,54,82,67,-25,258,98,187,43,144,153,5,137,219,38,5,242,264,205,142,179,39,82,143
+S69231_s_at,-171,-242,-345,-236,-5,-328,-134,-526,-303,-217,-103,-158,-544,-41,-273,-488,-774,-396,-114,-444,-353,-439,-402,-561,-124,-256,-890,-724,-637,-391,-144,-204,-201,-119,-119,-413,-625,-332
+D17570_s_at,-209,-171,-195,-191,-34,-46,-295,-281,-150,-54,-171,-80,-79,-16,-40,3,-105,-95,-46,13,-64,-146,-123,-48,-61,-25,-115,-112,-286,-305,-216,-67,-82,-69,-125,-151,-140,-193
+X91653_s_at,240,76,250,76,104,78,134,169,92,43,98,7,97,151,81,175,207,122,88,148,91,155,132,58,65,124,239,68,31,45,68,180,192,79,-91,23,167,239
+D21241_xpt1_s_at,212,57,175,57,32,-104,164,151,187,190,56,81,103,89,52,220,259,72,149,127,-88,154,5,105,113,130,251,102,60,177,-78,68,140,73,33,-34,119,189
+U23850_s_at,409,147,189,172,98,-39,164,295,213,31,143,61,140,219,250,176,460,172,124,136,134,43,146,140,198,167,101,210,132,65,221,171,142,9,140,121,206,94
+D26155_s_at,72,138,-52,191,288,-35,247,-38,64,21,-24,-33,86,78,198,67,227,137,102,237,37,-64,-125,392,36,125,103,134,26,41,34,48,41,29,62,61,160,-70
+D26156_s_at,1595,822,1452,654,1011,1584,578,1024,1297,971,1913,329,1593,1011,1763,2065,1778,764,1448,2191,768,1323,1992,1210,738,2143,1245,302,201,667,697,721,893,624,388,432,706,736
+U62293_rna1_s_at,-158,59,-25,-216,196,-192,-176,38,91,54,83,-107,100,92,208,172,110,314,-185,149,158,-7,-163,346,49,133,25,-240,-146,-301,-271,76,40,113,152,-197,-279,52
+X77922_s_at,105,53,85,71,33,46,28,94,43,59,10,43,20,99,81,42,20,13,-7,8,7,-35,94,7,58,-5,-18,0,50,45,89,86,48,35,72,51,20,55
+D87716_s_at,66,144,45,234,217,-7,82,71,135,-10,165,5,132,227,109,125,455,30,120,717,1,74,53,72,27,2,65,12,-38,99,-19,58,119,109,42,24,116,87
+D26535_s_at,725,282,412,525,627,291,594,283,642,198,294,284,572,224,426,555,429,388,362,792,259,294,482,719,326,432,234,613,370,542,328,705,619,378,339,351,528,688
+L15326_s_at,-145,-170,-103,-21,-91,-5,53,-11,-120,-6,12,-17,-43,-16,-54,-129,-61,-10,-86,-61,87,-78,24,-9,-69,-27,-59,-98,4,549,146,-64,620,-15,-62,34,296,535
+D28235_s_at,17,10,21,-22,14,-10,21,52,-5,7,-9,-27,-16,-32,6,-38,8,24,-9,-21,43,-20,-24,-11,17,25,-25,-23,21,1014,233,-5,1244,-15,21,27,274,1129
+D28473_s_at,469,249,538,688,1084,222,856,338,484,248,298,122,600,499,1040,436,1677,283,505,2048,908,155,229,1143,196,329,489,304,334,239,305,227,418,190,241,236,362,190
+D28539_s_at,-61,-22,-123,-103,-46,-110,-45,-124,-34,-85,-157,-81,-74,-104,-75,-59,-311,-95,-51,-138,-128,-99,-9,-151,-94,-33,-150,-62,-28,-25,-78,-3,-64,-33,-100,-62,-62,-144
+X59842_rna1_s_at,8,324,-115,328,19,257,-509,250,160,696,-152,140,-6,-49,373,464,985,399,240,727,249,-66,292,-36,14,-56,715,351,642,-71,560,-32,-6,33,446,663,294,-567
+S78467_s_at,19,117,123,84,67,28,-5,58,77,70,112,0,65,60,43,106,-110,-17,3,119,6,41,87,117,40,64,181,39,74,70,-21,198,129,59,111,26,156,208
+D29640_s_at,462,307,323,588,636,163,309,235,550,93,242,178,191,227,625,259,414,110,160,343,158,103,151,342,105,200,265,66,115,234,110,16,201,73,541,274,267,215
+D29675_at,-152,-164,-59,-27,-140,-83,283,71,78,99,-102,175,-161,-11,-254,-88,-125,17,-51,51,86,-255,-45,-188,-255,-92,-61,-151,117,-346,93,-36,-64,-181,-56,223,-83,-269
+D29675_s_at,796,815,1058,955,480,672,895,773,1164,1295,894,225,427,695,542,465,1057,532,436,1214,316,602,894,455,561,443,882,933,834,432,723,980,919,400,857,882,915,1491
+U34380_rna1_s_at,383,356,554,374,256,243,334,608,390,230,328,160,332,251,259,240,877,273,153,194,73,239,153,394,277,286,211,294,351,531,187,356,413,26,347,315,614,658
+U10473_s_at,-23,50,65,46,12,-7,-13,11,104,30,68,33,10,-17,35,27,17,57,18,36,14,172,51,-8,25,28,93,-33,9,-101,11,-40,-5,-19,49,7,-24,41
+X14085_s_at,1337,1001,1681,1238,901,965,952,1142,980,1094,856,527,1209,929,946,1123,1675,984,1248,1756,413,1262,854,1022,800,1012,1497,978,947,1558,1171,1282,1159,741,1102,994,1633,1865
+L00190_s_at,140,39,187,266,70,0,100,76,172,25,33,-17,92,84,2,86,154,96,129,117,-98,62,20,125,140,78,89,0,60,-33,127,93,193,-6,64,31,205,244
+L27624_s_at,-15,-13,-12,33,-32,-14,-31,5,7,-13,21,-68,-46,2,-46,-29,-12,-42,-77,-43,-79,-61,5,-58,-28,-61,34,-46,-9,-39,-47,9,-64,-9,11,-7,5,-37
+D30715_xpt5_s_at,456,147,554,422,333,357,507,559,370,16,49,171,115,160,100,139,219,125,-69,416,132,253,324,109,187,166,184,164,293,352,424,330,89,163,162,453,334,548
+D31628_s_at,1,2,-183,-240,-52,0,85,31,-94,-117,-160,74,-84,-114,-23,22,-243,1,25,-139,-122,18,-112,-113,-76,-90,-92,-41,-173,-76,-65,-50,-20,-86,-148,-7,-147,-202
+X68688_rna1_s_at,303,1,273,425,272,369,-257,-145,-148,529,96,242,321,150,260,748,585,115,474,277,1173,362,568,470,477,299,-261,1078,1228,844,390,568,452,620,-79,578,544,588
+D31833_s_at,-260,-178,-217,-334,-113,-165,-124,-266,-197,-70,-77,-120,-141,-215,-232,-29,-503,-24,18,-201,124,-196,-93,-231,-185,-15,-159,-63,-60,-58,-263,-255,-126,-153,-145,-150,-402,-118
+L10377_s_at,-244,-46,153,-230,-4,-225,-168,-439,-225,-50,-312,-465,4,-217,-277,89,-321,3,-41,343,-327,-111,-355,-383,-39,117,-491,-520,-286,-55,6,-156,-295,-213,-437,-631,-166,84
+D31840_s_at,491,334,439,261,231,16,282,764,355,39,359,239,283,223,203,-21,806,290,368,504,134,275,140,199,304,247,585,493,343,407,390,633,545,173,442,87,425,616
+S79862_s_at,-11,0,12,-15,0,-26,0,-22,3,-7,-26,-20,-3,47,1,-17,-2,-19,-6,28,-43,9,-22,50,-2,-10,-54,-40,0,-26,-5,82,0,-2,32,35,2,1
+X82279_s_at,132,23,141,-132,-53,-19,-99,8,111,-67,-49,-5,-59,104,-76,-40,63,61,-21,-108,62,-71,-140,2,-73,-6,178,52,16,164,-152,3,-18,-114,56,23,-94,134
+D32002_s_at,-423,-407,-469,-168,-64,-423,-376,-1112,-506,-508,-378,-132,-195,-91,-47,-245,-588,-254,-129,-217,-244,-194,-191,-276,-219,-266,-1004,-497,-533,-330,-336,-218,-103,-95,-626,-234,-303,-515
+HG4312-HT4582_s_at,3049,11476,5420,2558,2733,2272,1834,3362,4463,2413,2744,2134,2505,3341,2533,3926,11694,989,2346,4730,3170,1212,3758,2914,3814,2860,2559,2492,2664,2450,1349,3143,2880,1268,2779,3056,2221,2210
+D37781_s_at,24,65,-25,22,1,-30,5,-62,-49,21,-6,30,-22,-6,5,16,-6,-38,-36,-85,-21,15,20,-2,-5,-47,-39,-46,-67,4,11,-64,-5,2,73,-17,-29,-37
+HG4169-HT4439_s_at,-4,5,-95,-37,21,-87,-26,-7,-31,21,-32,14,-20,-22,-26,24,-229,-10,49,32,27,-5,64,-18,-10,-33,-89,-1,-2,-17,156,217,-33,86,-60,-41,-37,18
+D37984_s_at,31,46,152,105,159,56,70,44,111,20,82,0,79,103,110,121,180,39,29,92,4,-24,98,109,40,60,82,20,64,56,58,40,3,42,39,-9,-6,28
+X62153_s_at,1242,895,1808,1039,1132,1659,692,535,2223,642,965,547,1532,1060,1412,606,1848,795,605,766,112,338,1010,1424,703,547,658,558,391,342,570,405,1098,293,232,640,650,382
+U27325_s_at,1194,848,1798,1885,927,1138,1147,472,1714,1266,1222,636,597,1069,642,1584,1534,1030,960,1153,356,342,1221,871,942,890,1671,1335,1541,1540,-183,1252,1236,663,707,1519,1035,1366
+U11821_s_at,23,20,2,-5,-11,51,48,62,9,-39,-1,25,7,69,0,25,188,22,42,2,21,69,34,85,50,36,-51,-12,86,28,-72,-10,12,29,34,-35,-27,-28
+D38163_s_at,-103,-117,2,45,-292,-177,-240,235,-86,-72,-110,-224,-47,-278,-46,-207,-372,-210,-121,-457,-191,-58,-138,-66,-73,-276,-438,293,-137,-339,-365,-434,-440,-202,-370,6,-542,-527
+D38251_s_at,567,913,913,449,1197,419,567,-82,1816,994,990,201,608,654,965,873,820,928,664,1628,662,171,524,622,739,808,439,188,117,1160,546,274,543,468,1289,557,566,375
+S68874_s_at,555,688,452,912,531,473,453,433,598,614,391,477,506,290,516,654,1136,470,288,876,489,341,277,373,675,418,397,369,358,505,578,346,351,362,687,323,607,657
+D38496_s_at,197,300,370,68,382,135,152,25,212,56,121,68,44,248,107,318,503,34,139,390,63,142,117,176,194,226,168,169,76,143,-148,-8,101,33,238,31,122,56
+U38964_s_at,968,309,531,765,538,529,613,446,551,525,172,178,506,489,747,591,1668,289,81,995,557,455,531,909,271,337,173,553,278,687,58,98,175,162,73,503,1037,349
+D38537_s_at,9,-117,-46,-184,-47,-193,-178,-689,-144,-79,-54,-222,150,8,-17,11,90,13,184,137,-64,-145,-15,22,18,64,-93,36,-43,-122,277,-66,-21,133,30,-85,-144,-234
+S78771_s_at,1557,2653,1796,1329,1134,1347,1134,1430,1312,1240,1648,629,1291,1770,1505,1106,661,800,649,1905,1191,1272,1236,1245,1571,1485,981,1325,1067,1957,1669,2627,1816,772,1789,1022,1885,1945
+D42040_s_at,698,1736,142,6,743,547,500,61,1055,609,1154,51,463,533,815,105,280,148,352,2065,-181,910,587,428,819,455,-408,290,57,741,288,1599,775,530,1126,209,288,53
+Z84497_s_at,1162,1803,1547,1039,644,1363,1144,1239,1443,1265,1442,566,900,1310,841,819,1544,501,712,1627,287,1051,1005,998,1007,629,777,1153,983,1368,1266,2014,1580,503,1552,1083,1591,1953
+D43682_s_at,1524,1980,2311,2408,1671,2562,2387,1271,3298,2396,1589,1122,1947,1641,1525,1551,2602,1397,1536,2503,755,680,1922,1418,1429,1142,1297,3984,2219,4460,2493,2401,2627,1113,4732,3463,3559,3069
+X90976_s_at,-867,-464,-510,-655,-227,-384,-1026,-1130,-827,-374,-243,-491,-470,-665,-589,-757,-766,-187,-573,-828,-328,-605,-797,-379,-550,-386,-1060,-407,-557,-1151,-972,-455,-389,-322,-872,-762,-933,-623
+X89109_s_at,1329,3045,3946,1539,1698,3001,786,13,2949,1682,796,2113,723,5644,2860,2500,2345,2177,220,494,-1,231,780,1019,865,1967,819,1838,899,2765,36,-255,412,949,2332,3111,4149,569
+U23736_s_at,-83,-127,-84,-60,16,-3,-30,-139,-33,4,-63,10,-33,-54,-31,-69,-98,-51,-42,-85,-29,11,-292,-126,-129,-90,-59,-126,-81,-98,-155,-102,29,-19,-46,-87,46,-170
+M19311_at,-175,-23,-96,-45,-19,-53,57,-100,-141,-97,-21,-38,-16,-32,-1,-84,-156,-45,-38,16,52,45,-1,-139,-56,-5,-111,-130,-165,-19,-34,-79,-109,22,-3,-6,-49,-52
+M19311_s_at,6616,6774,9452,5419,6729,6165,4961,6009,7828,3450,3843,2302,8616,5725,10439,8612,15177,3332,4264,14660,3208,1749,3932,7170,2641,2846,2990,1922,2459,3742,2807,3025,4183,5330,3835,2315,3701,2829
+D45917_s_at,68,144,88,-35,29,81,52,122,123,80,14,162,31,36,57,122,74,15,125,35,119,9,157,187,119,-9,100,-6,129,-33,167,24,72,73,23,35,37,-13
+D49354_s_at,202,101,179,157,87,99,99,133,64,100,89,99,151,118,383,26,214,39,68,202,31,92,112,194,110,60,170,61,137,46,126,166,132,42,41,30,180,235
+D49372_s_at,285,71,298,147,46,151,107,280,141,25,106,83,84,81,175,72,113,125,80,154,56,65,227,112,99,75,176,164,108,82,182,141,221,99,124,98,173,248
+D49487_s_at,503,229,583,445,299,215,258,392,490,202,352,156,178,206,188,443,389,185,240,311,121,248,412,524,174,282,622,525,355,534,88,235,394,163,512,207,361,389
+D49824_at,-1317,-1374,-1601,-1538,-530,-1370,-1550,-1997,-1674,-904,-1202,-1060,-567,-1225,-686,-917,-1974,-837,-815,-817,-454,-1122,-1362,-815,-1294,-876,-1057,-1165,-973,-1728,-2090,-1747,-1443,-741,-1207,-1284,-1691,-2112
+D49824_s_at,31086,29288,14835,25421,29543,8097,21002,40065,16292,10073,9073,25346,30797,28519,23338,14990,27238,32645,31031,19084,2006,39558,4082,21307,32785,31614,16507,18125,15057,37164,32204,28295,29833,23862,25055,19277,21177,32946
+L38593_s_at,62,198,74,56,60,0,196,-11,459,25,43,-15,69,86,44,129,3,-199,55,-3,116,71,-26,39,-31,65,-255,127,226,753,357,-14,169,-19,76,247,231,-85
+U50079_s_at,1621,1542,2082,1061,1512,992,1587,977,2888,937,1428,400,1077,2123,2065,1186,2406,819,822,1516,699,567,911,1769,841,990,1473,383,678,1063,1260,884,1764,570,1247,1670,2109,1530
+D50477_s_at,-100,159,-152,-68,-32,-24,243,-179,29,26,-93,15,-33,-111,0,-25,-232,-17,51,-56,-49,-65,41,25,-7,-97,-156,5,-52,-104,7,159,-118,39,179,187,54,-141
+X86371_s_at,539,305,566,529,299,300,441,79,473,248,387,94,242,257,135,374,360,212,269,378,318,224,444,454,374,298,222,569,391,203,-164,257,541,299,332,290,369,272
+Z75190_s_at,159,0,212,-6,166,92,8,5,178,97,23,87,98,196,209,106,103,61,6,-46,7,57,-7,188,76,-44,128,131,-16,192,20,80,6,-7,241,159,145,-20
+D50855_s_at,131,57,360,142,124,62,-136,574,15,39,79,117,41,28,337,113,-16,10,7,48,17,209,241,250,65,-35,589,130,9,-137,131,-47,105,89,98,273,83,-30
+U58046_s_at,281,405,252,338,401,192,216,103,455,148,646,117,292,350,369,222,1076,200,134,555,292,119,155,287,109,143,107,184,144,159,201,73,278,82,268,153,164,239
+D55643_s_at,151,62,180,86,38,-16,245,140,27,158,18,84,52,64,55,100,330,9,69,78,98,44,-55,66,19,161,90,-7,55,152,82,172,15,45,62,62,79,238
+D63479_s_at,947,813,371,2176,1432,261,1424,458,333,155,318,531,1166,991,1545,754,1605,711,480,798,1526,2393,478,2058,370,905,424,429,351,931,481,525,172,412,808,344,222,546
+D63861_s_at,138,181,250,130,477,144,211,40,370,137,154,21,177,218,250,182,414,105,55,392,52,9,169,341,98,59,139,118,16,142,94,87,126,51,64,70,144,100
+D63882_s_at,-14,-87,-63,40,-11,-56,-63,-103,-6,-30,18,-47,-34,-14,9,-115,-1,-14,-13,-44,-24,-11,-58,-82,-35,-30,-14,-72,-105,-111,-27,-50,-43,-93,-60,-52,-81,-85
+D63940_s_at,-145,-41,70,5,-47,39,18,259,44,-30,-97,18,57,8,-139,159,240,-19,-6,229,126,2,77,-38,-27,-10,-15,-49,40,136,377,531,-20,117,20,214,35,414
+S82447_s_at,109,380,597,127,557,497,-28,-86,730,716,365,304,494,559,1044,463,123,150,219,761,-56,-71,279,495,212,554,-78,128,91,1461,658,384,178,717,811,495,258,73
+M96954_s_at,606,591,817,548,576,485,457,347,834,588,761,159,698,704,1067,510,668,412,331,936,1050,417,672,746,388,425,599,830,565,495,615,981,386,554,758,449,690,602
+Z79693_s_at,30,39,19,103,14,-44,6,50,69,74,56,73,59,33,34,110,180,33,65,72,134,-26,-15,51,13,110,153,61,55,61,14,51,109,-25,69,41,55,4
+Y10807_s_at,3143,3567,4649,2713,3475,3060,2597,3800,4348,3866,2926,2011,2890,3317,3760,2386,3621,1406,2157,6299,583,1055,2298,2454,1590,1754,2176,1566,2060,2541,2068,1615,2679,1798,2790,2945,3027,1716
+D78132_s_at,518,952,627,445,828,318,265,379,759,901,1033,231,609,721,931,488,1041,237,445,967,1069,385,647,963,344,203,309,614,312,1269,498,687,763,502,1090,423,677,821
+D78577_s_at,4256,2627,2039,1533,2481,1122,1643,1527,3476,4389,3530,2359,3568,3811,2446,2089,4052,1178,1679,3101,3568,945,1143,2014,1439,1765,1013,1023,747,2253,1192,1279,1944,1337,2470,1107,2607,2566
+D79984_s_at,342,401,313,393,121,344,460,32,554,291,861,290,586,263,230,202,716,127,395,485,-156,379,241,766,13,163,258,613,466,-136,565,274,1068,368,379,465,533,242
+S78271_s_at,230,247,406,397,408,565,418,361,802,323,368,208,962,411,652,211,807,207,276,365,151,173,300,666,243,220,261,309,134,408,415,297,463,246,197,243,315,310
+U50822_rna1_s_at,-80,-116,-142,68,-41,5,-8,-151,-100,19,-38,-30,-77,0,-70,-68,-136,-104,10,-6,41,-91,-201,-28,-191,-127,-281,-145,0,-117,-49,-11,-161,-138,39,31,-162,-70
+D83017_s_at,96,63,183,161,73,21,-89,-130,-14,18,-70,-71,21,-26,18,193,-65,49,-53,9,-56,-98,125,145,16,194,159,24,-55,-23,59,-39,-31,-55,-69,-34,64,-18
+D83260_s_at,855,380,336,303,213,195,258,305,308,158,205,564,672,279,465,244,167,358,133,528,112,176,248,290,282,835,170,294,141,346,332,294,221,121,586,253,559,248
+D85131_s_at,129,1244,660,763,427,1271,594,620,1277,491,1844,153,213,1362,759,349,1137,8,214,295,-201,262,685,1112,13,110,-222,174,105,771,862,1040,268,390,542,188,534,570
+D85425_s_at,-65,-323,-634,148,-18,-471,-166,-175,-344,-30,-342,-146,-20,-207,168,-57,-354,-179,-282,-27,178,-164,-395,385,-312,53,-261,-398,-370,-226,-510,-628,-427,-63,-370,-205,-373,-495
+D85759_s_at,-343,-94,-107,-108,-227,-183,-324,-254,-348,-36,-115,-66,-180,-76,-23,-257,-193,-123,-56,-221,-108,-187,-252,-2,-348,-199,-68,-94,-9,-228,-273,-160,-85,-114,-75,-49,-144,-157
+U52373_s_at,69,-67,-101,-38,-22,-90,-43,-400,-33,-42,-186,-1,-194,-59,0,-55,-439,-147,-31,-44,-127,-189,-36,-288,-140,-240,42,-185,-180,77,43,-248,-160,91,-153,-10,-105,225
+D86043_s_at,36,54,117,-588,-343,-193,-97,656,-96,37,-12,-113,39,-58,-68,-482,409,115,-417,-3,-287,164,-148,-308,-111,-280,754,334,115,76,-359,74,-369,-311,220,-463,-365,-198
+Y10375_s_at,68,81,207,743,74,273,623,589,758,437,104,136,13,174,189,127,-178,119,215,-146,-48,251,585,145,215,225,588,930,163,1068,433,40,319,-27,349,558,442,1125
+D86062_s_at,-380,-103,-512,-213,413,-304,-228,-461,-226,-235,-285,-297,48,19,44,67,-153,-115,-145,150,-174,-252,-321,-203,-361,-130,-372,-227,-331,-328,-315,-432,-271,-143,-240,-245,-328,-540
+D86096_cds1_s_at,164,43,126,173,85,168,15,113,-47,13,92,119,103,123,83,125,197,169,32,112,96,64,127,53,87,202,187,177,26,198,89,63,167,89,141,17,-39,63
+HG3238-HT4861_s_at,74,-110,-28,-85,-18,-37,-120,-316,-2,-21,-43,-116,-4,-18,16,29,-20,16,-830,-334,-81,-124,-7,25,-257,-95,-103,-105,-492,-74,-281,-361,-94,-293,-153,-39,-167,-372
+X83857_s_at,42,-86,33,-119,23,-33,-127,-253,35,-1,-21,-1,25,-21,-11,-45,-82,2,-374,-172,-53,-92,60,-61,-175,-57,-1,-8,-113,-64,-163,-259,-58,-179,-65,-44,-123,-284
+D86331_s_at,186,230,-136,-44,232,-142,-225,-22,97,44,78,251,170,108,151,128,-311,-23,-34,151,106,51,535,5,84,218,-353,43,-21,45,-195,-45,109,78,-244,88,39,-120
+U19713_s_at,1418,2683,440,460,479,1385,537,208,1412,1259,1015,794,758,1782,697,499,3555,428,138,296,293,235,752,912,743,588,649,1575,1692,2458,1240,500,2460,2665,2240,2274,3056,1227
+Z35085_s_at,644,647,702,395,466,293,415,680,571,356,1012,229,649,534,513,488,1365,252,251,1281,422,435,330,590,206,382,381,698,240,663,576,775,364,390,900,201,493,1048
+U65533_s_at,-215,-429,-502,-483,-258,-261,-460,-872,-579,-160,-358,-354,-313,-166,-183,-323,-808,-191,-395,-360,-212,-291,-359,-365,-356,96,-513,-521,-630,-570,-536,-466,-391,-306,-459,-483,-561,-763
+X51755_cds5_s_at,-359,-312,136,-187,-195,1,-65,-320,-150,-334,-337,-182,-239,-127,-337,-213,-493,-11,-275,-461,-31,-303,-450,-429,-187,-219,-500,-236,-569,-268,-132,-230,-177,-75,-591,-91,-452,-817
+U52191_s_at,573,15,700,624,42,601,-94,154,651,186,530,-28,12,685,-48,440,1946,244,401,788,187,171,455,432,463,122,142,204,72,329,23,842,74,69,279,146,527,37
+L33930_s_at,5191,9,11,1834,1178,28,84,4084,76,50,50,94,4640,142,4512,4178,74,52,5757,10506,2702,1265,-79,878,349,4745,1211,-37,-16,87,47,-16,51,-21,42,17,50,37
+Y08682_rna1_s_at,29,309,217,-92,110,174,-5,-11,240,102,39,54,392,165,221,234,328,-21,55,198,147,-23,-41,-17,300,343,51,228,163,207,-26,116,115,-45,241,-68,414,54
+D88155_s_at,-6,23,195,-82,53,90,-115,547,-93,32,31,218,147,116,-24,37,165,67,36,65,212,-74,237,-6,-5,99,411,36,519,152,-49,-183,4,-22,45,-119,92,431
+D89377_at,314,276,244,226,243,247,268,388,334,172,243,264,132,381,196,252,234,210,260,271,33,234,224,269,339,126,234,267,276,304,292,363,224,131,250,292,354,435
+D89377_s_at,31,55,59,44,-2,32,131,26,24,32,10,106,-17,22,60,-13,149,14,68,-23,9,39,155,93,13,78,62,126,274,40,148,-21,-16,42,40,20,13,87
+Z74792_s_at,338,82,209,172,180,234,277,10,247,-19,220,112,436,341,287,253,544,71,110,559,-112,-91,170,424,5,290,78,-5,88,62,303,-284,259,291,177,-147,-89,101
+X17059_s_at,148,128,92,189,125,238,152,44,90,83,161,66,35,229,166,80,254,95,56,171,189,105,30,164,44,86,131,20,-16,178,136,212,57,82,80,73,121,252
+D90070_s_at,474,434,55,-24,245,-39,15,316,103,282,474,209,757,-8,147,217,121,247,274,2581,416,22,292,91,780,406,54,95,-91,815,149,507,471,105,-9,5,92,134
+J03260_s_at,199,178,323,371,314,21,215,605,214,135,244,152,206,200,332,682,350,161,22,109,74,215,182,309,175,153,139,302,406,291,-34,149,358,77,121,171,267,451
+HG1728-HT1734_at,-165,-131,-172,-140,-99,-92,-141,-140,-172,-91,-121,-5,-132,-50,17,-224,-144,14,-83,-110,-23,-202,-140,-132,-283,-177,-48,-125,-115,-240,-147,-91,-25,-111,-176,-163,-136,-192
+HG1728-HT1734_s_at,1455,2094,2586,2440,924,2820,2737,3709,1681,686,1909,1671,1380,1358,1718,1109,3594,1439,1592,1681,794,1630,1424,1579,2254,1399,3590,2286,2149,3308,2694,2278,3159,975,2323,1563,1790,3108
+D90279_s_at,-11,-65,-78,-128,-72,-176,-169,134,-6,-83,-187,-71,186,-56,69,-96,-112,-86,-114,-76,-173,519,-51,-189,41,-186,-173,57,300,-131,59,-4,-51,-74,-335,-183,-62,-333
+M64710_s_at,-577,-123,-1038,-284,-134,-478,-628,-1362,-258,-130,-198,-215,-301,-306,-46,-415,-720,-362,-458,-571,-478,-375,-368,-439,-269,-623,-995,-611,-815,-745,-353,-734,-596,-163,-449,-729,-259,-967
+HG2271-HT2367_at,-320,-283,-327,-465,-259,-560,-421,-370,-279,-121,-336,-261,-236,-360,-133,-318,-377,-218,-98,-189,-304,-112,-621,-139,-233,-59,-373,-203,-14,-366,-554,-328,-227,-186,-373,-404,-493,-165
+HG2271-HT2367_s_at,-545,-252,-394,-429,-119,-554,-475,-436,-786,-356,-154,-202,-319,-301,-83,-506,-465,-381,-265,52,-159,-311,-543,-361,-378,-270,-433,-258,-331,-457,-408,-726,-342,-82,-316,-643,-293,-497
+X55448_cds1_s_at,1696,1517,1220,763,828,1162,838,1107,1457,793,734,995,1290,2015,701,1478,4448,792,821,929,508,610,752,1163,965,829,663,1384,1094,2231,1088,992,1178,608,1355,1557,2052,1152
+HG110-HT110_s_at,1861,999,2348,1603,2460,2500,1487,1526,4388,1775,2219,939,3283,2447,3241,2241,6753,1131,2495,4821,1130,228,1899,2705,1273,2331,1179,2258,1844,2341,1944,1225,2370,587,1146,1723,1333,1466
+HG1140-HT4817_s_at,171,302,713,80,397,449,75,44,172,414,174,113,212,674,232,178,387,187,190,125,267,192,288,183,384,99,233,286,464,524,461,258,429,82,423,201,340,394
+HG1227-HT1227_s_at,-342,-139,-350,-241,-125,-129,-320,-251,-266,-241,-219,-195,-87,-254,-142,-325,-118,-169,-178,-52,32,-154,-264,-134,-253,-194,-388,-164,-161,-267,-133,-171,-201,-43,-202,-327,-433,-416
+M19828_s_at,-796,-356,-839,-963,-297,-560,-858,-1178,-765,-322,-446,-352,-247,-487,-378,-401,-977,-444,-371,-486,-262,-506,-476,-537,-546,-390,-987,-793,-704,-909,-609,-509,-773,-387,-552,-595,-670,-1046
+HG1322-HT5143_s_at,4557,5356,5517,3559,5988,3561,3342,2955,8528,4885,4495,1990,4926,3479,5677,4997,9632,2597,2617,8403,4092,1715,4128,5026,3488,3073,1785,2800,2058,4306,3047,2803,4598,1718,5085,2503,2571,4030
+HG1327-HT1327_s_at,-74,15,6,62,3,-8,21,166,-49,39,-7,53,24,33,16,-43,-12,-15,66,8,37,9,-32,-21,66,-26,-32,9,165,-38,-16,32,16,31,39,-6,41,17
+M25079_s_at,17602,9868,28056,23812,3553,7809,41911,3991,978,6153,19085,13625,13604,22650,1291,12223,21882,247,4837,0,10266,28402,9976,7295,3492,26941,19460,21622,61228,18541,4,0,13489,7617,13741,20785,16866,246
+HG1428-HT1428_s_at,17962,16964,23436,22240,5472,7418,33041,25832,1671,8419,17592,10660,16215,20080,1886,15549,21917,62,18793,9395,25245,25589,11674,11243,17746,19660,20863,19478,39079,15884,15693,16072,18200,23010,17747,14399,21063,15803
+HG1437-HT1437_s_at,-544,-411,-564,-717,-186,-405,-542,-313,-197,-386,-367,-388,-288,354,-367,-229,-758,-258,-312,-210,87,-82,-416,-383,-109,-99,-322,-271,-226,-395,-321,-42,52,-65,-173,-406,-566,212
+HG1471-HT3923_s_at,485,523,256,716,482,403,633,406,619,504,640,247,230,469,670,262,365,238,479,911,57,253,575,396,458,339,776,632,497,235,647,481,567,476,710,507,869,944
+HG1496-HT1496_s_at,57,117,96,95,66,23,119,67,39,21,64,28,34,66,31,6,-189,-105,30,106,-206,-48,56,-64,84,-26,-184,-203,-48,-93,97,90,2004,57,75,-31,4,61
+X57351_at,2476,6070,1203,1944,3120,524,2864,2604,1047,481,266,4618,2384,6169,5718,2051,6780,261,1937,4359,1925,302,623,2987,4256,2384,2943,1158,1789,3122,388,153,3705,695,1781,2680,6044,4868
+X57351_s_at,16489,22665,7562,10996,12769,4834,16433,18892,7918,2779,2638,16858,14353,23424,16638,9782,25301,1182,17322,20702,26510,4249,3816,19806,22580,17114,13044,5545,11270,14398,4954,4674,18379,3690,10463,12016,20609,24906
+HG1595-HT4788_s_at,1780,1711,1879,1505,2510,2356,1416,1003,4218,2004,1432,659,2582,2092,2872,1539,3534,608,1477,3694,492,234,1951,2034,749,1341,132,1247,839,2551,1255,1441,1848,1687,852,2013,1135,1019
+M76125_s_at,-106,-105,-192,-171,-38,-167,-204,-146,-36,-35,-79,-10,-42,-159,2,-131,-153,-55,-3,-80,-98,-48,34,-53,-93,-110,-48,-237,-151,-259,-189,-225,-177,6,-67,-224,-12,-48
+HG167-HT167_s_at,-678,-616,-748,-969,-287,-353,-867,-1037,-584,-766,-442,54,-374,-562,-279,-773,-230,-312,-308,-499,-57,-455,-108,-420,-109,-543,-247,-394,-440,-765,29,-484,-38,21,-595,-1005,-1273,-680
+HG1747-HT1764_s_at,307,183,459,332,222,138,354,248,274,221,149,-4,124,289,74,249,590,213,208,154,103,217,281,216,227,221,316,215,346,442,364,197,429,162,213,330,233,578
+HG1751-HT1768_at,539,329,821,575,168,611,705,593,498,332,230,365,71,451,169,163,203,186,117,335,441,464,402,283,294,243,538,359,555,464,345,898,316,111,308,370,439,469
+HG1751-HT1768_s_at,-321,-140,-505,-423,-110,-433,-406,-505,-370,-252,-381,-310,-85,-275,-226,-248,-300,-166,-243,-168,-124,-311,-313,-218,-126,-160,-287,-212,-317,-289,-235,-286,-139,-153,-269,-442,-328,-414
+U19247_rna1_s_at,233,477,11,236,375,67,295,334,160,264,215,202,349,185,237,228,662,339,55,273,259,215,203,359,139,91,93,207,120,1166,716,398,391,580,614,204,325,1363
+HG1761-HT1778_s_at,7,102,-31,-135,42,72,-115,-95,-109,-144,-27,-153,-48,70,69,-124,-21,-3,92,79,13,-51,-72,17,117,-16,34,-14,93,19,82,-143,112,119,-2,15,-50,-187
+HG1763-HT1780_s_at,462,8,630,473,171,387,252,595,624,333,318,162,-23,362,26,138,586,193,138,127,-12,209,421,218,289,262,-230,415,238,306,-131,63,279,15,31,28,506,430
+J03915_s_at,550,12,978,-101,50,243,1035,481,768,88,576,145,105,437,-44,109,1300,83,-74,986,439,273,568,206,1784,298,103,815,952,432,680,474,822,310,606,-30,-144,1167
+U47025_s_at,945,680,849,1183,617,704,702,934,1050,484,907,402,699,932,807,671,1144,515,583,982,457,814,592,1386,631,695,603,735,526,1170,1121,676,769,319,646,574,742,828
+M14199_s_at,16528,18688,14612,17782,18496,18939,12445,13249,19581,15785,19115,17419,13180,18291,19487,19595,16611,19532,15981,16694,12727,15065,20093,13937,20213,20252,16208,13790,13492,12751,16399,16691,17607,21515,12372,11862,17186,15192
+U43901_rna1_s_at,18573,18421,18617,17692,17491,19492,13949,19213,20296,17462,19190,18062,14291,17593,18787,19533,20529,19508,14311,18881,1161,18084,21081,16642,19590,19619,19848,16408,13388,17950,16806,18352,20581,18504,16425,13732,18539,18824
+HG1783-HT1803_s_at,144,34,119,139,44,24,36,107,105,45,85,27,49,127,60,87,206,76,47,78,36,35,-28,188,163,42,115,-1,43,56,78,140,84,69,96,74,75,130
+HG1827-HT1856_s_at,164,31,84,-57,-11,14,90,-65,75,-18,104,-35,4,33,17,57,756,60,-30,13,113,75,53,79,111,13,3,42,55,53,-44,145,96,50,-7,27,138,206
+U24183_s_at,63,-26,-114,-158,230,-80,-73,-385,158,70,4,-125,148,-201,321,-30,-458,144,212,847,-74,-54,-18,-43,-153,85,-122,-173,-64,-166,196,-122,-45,39,-281,-44,-74,-115
+M29874_s_at,220,-10,204,-34,108,12,26,34,158,70,20,56,-7,-47,46,26,407,201,-38,0,-64,54,79,194,63,-3,145,41,21,50,21,27,233,26,-91,10,129,227
+HG1877-HT1917_s_at,267,99,13,142,120,80,173,343,-10,85,96,54,144,170,173,189,252,149,110,95,-2,167,121,316,186,187,381,215,72,221,140,172,260,63,121,187,176,305
+Z26248_s_at,-254,-412,-280,-699,1350,-508,-668,-1055,-338,-159,-155,-373,-91,-443,-260,-325,-889,-179,-266,-282,-217,-121,-429,-418,-334,-201,-691,-400,-464,-400,-126,-369,869,-6,-309,-223,-524,-271
+HG2007-HT2056_s_at,2,-12,-21,-63,-3,-3,-21,16,0,41,-6,-37,-56,-31,30,-74,-2,34,-5,-25,-49,-13,-32,20,41,-1,-9,-76,2,5,25,34,53,-70,-8,-23,-9,-4
+HG2090-HT2152_s_at,268,155,250,160,159,149,199,196,171,154,158,43,141,107,105,166,498,153,102,199,89,198,155,58,170,201,168,219,173,589,190,196,305,105,359,173,270,306
+HG210-HT210_s_at,182,151,325,199,188,176,193,230,240,65,169,114,116,185,198,199,362,134,159,210,132,65,153,114,176,137,179,249,163,142,125,184,159,93,173,167,263,207
+HG2175-HT2245_s_at,132,117,197,-4,-38,302,63,125,573,217,100,40,430,226,20,36,12,485,171,306,24,26,302,91,87,107,62,-79,115,-38,226,301,63,31,-4,81,63,109
+HG2197-HT2267_s_at,182,215,374,447,176,423,275,274,431,188,266,313,264,208,225,276,229,263,193,235,173,290,328,393,277,264,503,237,327,189,377,337,216,203,379,383,540,424
+HG2238-HT2321_s_at,2097,1094,1438,2105,1460,1388,2619,2308,2079,952,1408,369,1061,1013,2667,1802,2788,980,1061,3095,138,1152,1485,2012,1004,1393,1973,1507,1425,1151,1369,1410,1268,761,1503,856,1851,1373
+HG4069-HT4339_s_at,553,406,854,498,313,553,668,727,614,452,418,373,282,410,297,399,724,374,395,427,361,307,585,457,483,407,610,537,553,965,1742,733,677,351,767,486,557,1135
+HG2259-HT2348_s_at,-16,-372,-604,-710,-95,-467,-517,-410,-728,-439,-867,-150,461,-671,-368,104,-484,738,2352,-668,-186,-281,-602,-604,20,1976,-885,-326,-281,335,-401,-450,-267,-177,88,-803,-604,-551
+HG2260-HT2349_s_at,-50,-17,-52,-155,-30,-30,-131,-214,-221,-70,1,-33,-21,-89,-37,6,73,-73,-102,-15,23,-98,-62,-81,-41,-10,-190,-159,-76,4,-109,49,-15,-85,40,1,-40,-14
+HG2261-HT2351_s_at,53,14,176,201,-31,-28,73,34,-1,65,52,73,22,173,151,99,8,28,114,82,-28,113,93,75,59,29,68,152,93,68,129,71,138,47,42,116,175,18
+M86757_s_at,-925,-353,-1058,-1019,-194,-739,-1201,-1493,-636,-713,-345,-337,-524,-752,-619,-478,-1412,-422,-514,-676,-176,-559,-693,-664,-486,-500,-1325,-834,-819,-878,-466,-669,-674,-410,-416,-784,-1049,-1082
+HG2358-HT4858_s_at,-704,-665,-226,-754,-319,39,-665,-1688,-61,-297,-363,-422,-441,-989,-384,-525,-1167,-372,-329,-765,-229,-661,-153,-565,-603,-574,-427,-335,-675,-693,-402,-807,-601,-114,-613,-256,-728,-605
+L14778_s_at,1727,300,43,1035,798,154,826,979,281,27,26,462,825,465,1325,740,754,420,742,1235,547,-188,169,791,709,694,602,664,579,476,216,286,667,150,440,478,890,516
+HG2367-HT2463_s_at,22,21,78,84,40,67,-23,148,113,43,61,8,34,59,57,-9,91,21,116,101,7,14,75,52,63,-68,54,-67,100,-52,174,50,118,117,-51,34,206,156
+HG2379-HT3996_s_at,-403,-219,-279,-367,-117,-380,-453,-665,-259,-123,-292,-297,-47,-366,-111,-270,-383,-111,-248,-303,-233,-347,-279,-315,-297,-250,-408,-410,-295,-536,-550,-540,-396,-163,-481,-499,-626,-774
+HG2379-HT3997_s_at,144,175,41,90,134,-7,139,73,182,195,106,54,132,153,175,68,146,74,81,121,3,40,-11,77,-30,37,114,60,69,188,105,153,156,134,94,49,126,149
+HG2380-HT2476_s_at,117,73,-15,-156,-66,-7,50,344,259,16,134,135,-140,-23,46,-17,75,83,80,-6,-16,176,-199,164,-212,-27,-384,154,271,177,200,6,0,17,-327,319,48,129
+HG2383-HT4824_s_at,19,43,66,14,43,-26,189,68,-33,-3,-66,-30,15,-11,7,-50,208,42,-139,45,3,35,51,-16,-190,6,225,-4,-60,-117,133,88,25,-41,45,-91,-53,-35
+HG2414-HT2510_s_at,-732,-720,-1301,-1284,-594,-1123,-870,-1643,-1296,-605,-706,-449,-592,-803,-759,-901,-1304,-719,-707,-859,-462,-791,-978,-904,-1056,-853,-852,-871,-1014,-1310,-1161,-907,-958,-548,-950,-626,-1074,-1641
+HG243-HT243_s_at,682,431,775,571,272,627,662,941,862,419,512,354,261,598,460,328,683,321,545,380,391,504,634,613,556,349,348,832,620,718,729,502,522,363,570,385,824,692
+HG2441-HT2537_s_at,270,107,297,246,218,208,174,526,264,141,158,56,130,195,268,205,306,5,93,251,76,163,170,226,232,139,137,130,36,219,39,-31,171,95,252,66,199,196
+X52611_s_at,-154,-219,-388,-303,-91,172,149,35,489,89,-408,-20,-677,-158,-140,136,-422,-156,-66,-60,-74,-187,-324,-325,-432,-479,-1,-104,62,-394,-520,-147,-362,67,-291,-107,-279,117
+U10099_s_at,168,-246,-144,-108,37,-12,11,-485,195,-80,109,-281,521,-307,301,240,299,30,36,128,52,279,-267,-259,26,327,-35,-93,-533,530,-631,155,319,22,194,-170,-40,-62
+HG2479-HT2575_at,-111,-19,-230,-118,-50,-215,-252,-115,-419,-173,-323,-120,-100,-92,-122,-56,-281,-80,-81,-121,-38,-139,-208,-399,-225,-237,-98,-371,-310,-76,-202,-195,-160,-59,-194,-188,-201,-441
+HG2479-HT2575_s_at,193,74,-28,6,103,16,43,442,-84,42,16,-107,124,-35,-29,58,271,72,63,295,-146,1999,22,89,26,14,203,-76,-81,27,3,57,-122,207,24,-52,27,90
+L08835_rna2_s_at,1240,521,1242,982,512,1171,1194,1454,1424,846,1200,475,672,721,341,1074,1392,600,548,911,578,844,1081,540,965,715,1212,1108,781,1133,270,750,953,277,712,749,925,804
+M87313_s_at,80,-301,-283,-278,14,-304,-272,-634,-392,-160,11,-346,-101,-668,-149,-43,-26,-118,-186,-180,-203,-355,-309,-340,-274,27,-120,-291,-509,-46,-295,-371,-211,-117,-438,-168,-79,-154
+S52028_s_at,25,48,127,54,19,30,42,167,181,71,2,-41,17,27,-21,96,28,77,16,36,76,18,74,2,56,18,64,28,84,75,80,96,-16,33,42,20,63,54
+L26584_s_at,36,-8,118,-256,76,-97,176,13,126,-103,-28,-61,20,13,93,-89,-246,96,59,-25,-156,20,-191,-3,104,62,-90,-20,-170,347,-86,-156,169,238,-118,44,104,290
+X06182_s_at,74,-4,114,-15,12,33,42,122,53,55,41,-45,62,24,-11,38,2165,-2,48,48,58,-10,53,9,56,-4,26,208,673,124,-8,158,567,651,-52,125,6,134
+HG2562-HT2658_s_at,8,38,79,-21,61,17,5,5,-43,-8,8,0,12,0,58,72,49,111,-12,130,107,13,-3,42,117,137,-98,22,-168,1,-77,-49,-98,-74,-18,-11,-3,69
+X13451_s_at,-175,-60,-143,-228,2,-321,-149,-310,-214,-55,-84,-186,-12,-157,-55,14,-92,-47,-76,-94,-138,-232,-123,-125,32,-6,-197,-106,-363,178,-154,-232,-2,25,-89,-141,9,138
+HG2564-HT2660_s_at,-62,9,35,-62,-13,-55,-5,-97,-3,-21,13,-35,-1,-14,2,11,10,-3,-57,-23,-19,-56,-55,-20,-25,-25,23,-90,60,-25,-86,-21,-34,-9,11,2,-25,19
+X16666_s_at,-396,-282,-257,-638,-220,-387,-623,-518,-278,-442,-340,-478,-270,-729,-241,-260,-602,-187,-352,-795,-620,-366,-552,-359,-425,-284,-594,-192,-642,-443,-517,-475,-363,-471,-362,-413,-412,-509
+X52009_s_at,141,-20,92,8,-69,-147,139,125,120,33,64,40,73,84,22,168,-95,71,3,-4,-16,31,180,107,-5,119,17,74,12,16,93,-98,79,-9,-23,73,178,141
+HG2591-HT2687_s_at,-836,-775,-996,-306,-452,-1276,-1428,-1042,-963,-472,-496,-788,243,-359,29,-352,-1825,-269,-363,541,-99,-533,-771,-618,-443,-59,-1502,-891,-973,-1161,-1608,-356,-1062,-438,-1213,-1204,-246,-695
+U22376_cds2_s_at,3105,1118,4543,5467,3469,3309,3936,4745,4081,1658,2853,551,4746,1534,5311,4326,7155,1178,3427,6870,9177,4836,3085,5815,1872,3265,2877,1126,880,473,186,680,794,1312,485,408,1047,335
+M29037_s_at,64,51,104,104,55,120,78,155,118,84,56,8,62,116,-35,69,101,32,92,-28,37,40,-28,209,61,-9,48,125,204,53,35,108,129,45,43,121,179,187
+X55019_s_at,721,454,826,673,359,643,794,436,745,445,671,445,395,521,282,644,782,364,348,440,211,443,826,381,356,394,536,519,389,754,384,543,471,278,322,714,745,805
+HG2639-HT2735_s_at,683,702,821,369,329,321,309,407,780,362,443,196,166,560,334,327,540,142,147,389,348,149,136,590,252,113,220,456,415,832,660,563,377,270,723,400,722,955
+HG2649-HT2745_s_at,150,180,-77,55,-32,-51,50,-41,-83,88,-123,-11,-40,44,47,130,-118,-83,-24,-59,13,-34,-7,-130,-17,-89,-140,-15,76,125,116,205,28,-62,110,-81,242,-104
+U48705_rna1_s_at,309,-185,-477,-335,-234,403,-255,-14,-231,-373,301,247,311,166,-121,-196,-896,-271,325,365,-107,-48,-368,209,-222,72,-722,43,-305,-335,-347,-286,-128,-142,-479,130,-397,-652
+M90391_s_at,2,55,-36,-138,50,-12,-47,13,-68,20,-38,-96,66,498,186,126,247,267,235,103,-69,258,-36,119,235,184,-26,-94,60,-21,-10,41,-66,-49,18,-75,113,-58
+HG2705-HT2801_s_at,1327,808,1376,1309,688,1173,1376,1613,1292,799,900,876,786,906,805,897,1368,243,951,905,108,876,847,872,805,905,1161,1177,642,649,1292,1050,1143,515,576,1107,902,1729
+HG273-HT273_at,-288,-465,-302,-187,-453,-154,21,-130,-380,-192,-293,-422,-125,-357,-173,-202,-171,-172,-239,-303,-68,-274,-157,-424,-336,-291,-264,-242,-55,-26,-51,-551,-246,-259,-274,-198,-225,-282
+HG273-HT273_s_at,539,456,455,465,504,440,383,496,678,243,460,339,359,518,247,402,651,305,327,671,386,279,355,704,187,248,550,525,365,400,450,434,637,323,655,327,538,532
+HG2730-HT2827_s_at,192,67,19,149,31,158,42,128,250,49,162,76,47,91,-29,18,145,-61,38,-29,124,168,87,188,69,35,59,172,240,197,-31,71,80,-57,73,28,101,150
+HG2730-HT2828_s_at,-49,174,-35,-86,-32,-76,-8,-23,-52,2,-54,-20,-68,38,-16,-114,365,-24,-112,-38,141,-54,-121,48,-25,-64,71,-106,-28,-225,-3,24,-11,-5,75,-18,29,-38
+M58569_s_at,-107,-47,-55,-187,-32,-85,-105,-121,-111,-41,-99,-67,-40,-47,-62,-74,-149,-68,-39,-59,41,-94,-108,-11,-52,-39,-156,-117,-115,-101,-1,-83,-62,-66,-29,-49,-96,-141
+X16609_s_at,-62,-33,-1,-147,1,-330,-131,-137,-160,-47,-20,-86,156,-70,-84,40,-42,14,31,212,-47,-47,-64,63,25,101,-54,-117,28,-119,62,-8,11,163,-65,-125,-66,88
+HG274-HT274_s_at,395,357,-1,334,104,211,265,-187,241,486,13,304,162,196,170,455,1137,236,506,114,237,-184,305,122,71,136,381,667,536,785,456,191,112,261,951,448,444,181
+HG2743-HT2846_s_at,140,8,-5,-66,-32,-24,-26,-56,37,7,-14,-57,-16,-30,-49,67,-103,-36,-31,51,102,111,-100,2,-49,7,-51,-75,-16,-153,9,-122,-32,-22,-32,-37,-12,-62
+HG2743-HT3926_s_at,-21,-90,-72,-54,-21,-28,-90,-61,1,-55,-40,-31,-32,5,-35,37,-63,-19,-59,-2,3,-5,-13,-69,-77,-22,-7,-89,-12,-95,-26,2,-47,5,-42,-24,3,-63
+M83216_s_at,-112,-91,-214,-10,-74,-104,-33,-112,-129,-18,-94,-20,-41,-60,-12,48,-30,-64,-12,-44,-84,-7,11,-29,-100,-49,18,-130,-55,-33,-33,-81,-73,-25,-31,-26,-94,-95
+HG2797-HT2906_s_at,-32,83,-139,127,360,384,332,-721,181,287,118,204,392,96,933,346,5,-80,103,11,-373,-14,83,0,-139,461,-384,144,-331,912,-172,-43,291,134,289,162,390,-443
+HG2797-HT2905_at,-603,-534,-505,-611,-336,-433,-446,-808,-491,-400,-544,-369,-297,-439,-301,-476,-750,-331,-361,-458,-48,-364,-431,-345,-552,-394,-619,-433,-375,-446,-532,-741,-597,-342,-545,-290,-693,-690
+HG2797-HT2905_s_at,-85,-126,-95,-77,-42,-128,-80,-89,-105,-83,-121,-30,-116,-93,-92,-117,-160,-66,-73,-93,-72,-86,-121,-95,-42,-92,-71,-129,-165,-119,-154,-70,-135,-113,-147,-83,-72,-189
+M91556_s_at,18,62,25,45,-43,23,162,55,-35,19,53,-10,-7,72,11,-7,107,-13,2,42,18,17,34,34,-6,20,123,-15,-21,-50,13,40,32,-17,71,36,18,8
+M13452_s_at,509,393,837,345,500,730,608,518,907,973,478,238,124,370,259,640,460,1096,431,343,62,396,509,306,385,-66,660,539,442,2690,2050,919,1573,392,5446,1805,1141,1703
+HG2809-HT2920_s_at,721,386,729,961,553,535,596,635,519,382,575,389,367,478,536,574,1438,302,431,797,267,332,423,295,426,447,732,365,495,566,738,537,435,386,666,517,706,867
+X04654_s_at,3726,2769,3639,2459,3489,3003,3326,4031,4597,2719,3495,1030,3284,2649,4147,5657,7049,1917,3134,7186,1504,1336,3381,3766,2340,3158,1766,3364,2469,3332,1698,3018,2578,1072,1687,2366,3036,2597
+HG2815-HT2931_at,10557,11742,14175,4773,8029,8869,4108,7136,14994,7934,9148,6596,8542,8075,8443,12224,8991,4415,4929,15461,13192,6321,6471,8577,6287,11428,2938,5404,5552,12088,9059,8115,5490,7263,7436,6928,7506,4654
+HG2815-HT2931_s_at,2089,2324,2612,1116,2778,1675,645,1073,2815,1837,1733,1740,2285,1448,3220,3679,1739,971,1533,4159,157,1069,1217,1901,1314,2077,542,758,466,1556,1723,1225,994,2951,1502,1361,2030,683
+HG2815-HT4023_s_at,13706,14719,16661,7177,9445,9305,6699,10507,17678,11779,10500,7458,11793,10129,10758,16011,17077,5343,7500,17611,17420,6780,6716,9241,8927,14332,5553,8942,7966,16133,10818,10660,8913,8936,13885,8815,10756,8805
+M58509_cds1_s_at,-1136,-622,-517,-785,-668,-979,-1161,-311,-972,-533,-605,-530,-469,-866,-659,-438,-893,-385,-392,-770,-123,-316,-955,-362,-496,-390,-1114,-574,240,-408,-1000,-28,-394,-523,-1141,-885,-927,-1038
+HG2841-HT2969_s_at,58,39,17,-22,-28,-39,-58,34,0,-44,-72,-70,-38,-5,3,7,-65,5,-37,26,9,17,-22,-60,-55,-90,9,-86,-16,-33,-35,64,-9,-113,6,-6,47,35
+U22961_s_at,197,-5,200,130,159,112,100,238,50,113,137,83,96,76,46,128,82,86,67,68,88,61,123,39,0,152,107,101,247,67,85,98,113,19,28,52,163,367
+HG2841-HT2968_s_at,163,168,297,158,91,110,181,107,278,82,118,50,60,140,44,212,365,127,132,286,149,158,146,219,153,246,350,181,129,244,136,204,212,51,170,54,278,360
+J00139_s_at,96,21,99,147,143,51,168,263,271,120,79,51,123,244,158,-56,37,125,66,178,71,68,161,119,80,8,89,-108,223,2,151,105,127,77,144,256,254,106
+HG2850-HT4814_s_at,38,100,-159,5,-90,-56,122,35,-177,102,95,-91,-48,135,-23,-71,412,77,-89,-39,32,95,-134,31,-58,-134,225,-131,-2,-11,34,-11,-86,10,-107,-108,463,145
+HG2868-HT3012_s_at,1060,404,929,833,780,659,1134,1034,1050,409,472,603,726,862,674,799,958,657,530,1084,462,940,780,611,594,724,1007,958,743,997,569,716,1035,451,519,953,1524,1142
+M89914_s_at,-330,-201,-394,-300,-224,-117,-423,-557,-332,-150,-246,-300,-231,-152,-163,-219,-381,-222,-187,-272,31,-168,-123,-362,-184,-254,-345,-357,-382,-313,-434,-502,-322,-58,-221,-58,-457,-718
+HG2981-HT3127_s_at,31,7,151,173,36,80,77,101,182,68,-6,135,103,39,43,36,345,74,47,37,76,363,89,169,81,37,125,83,218,1884,2576,275,510,69,2498,264,1407,1293
+HG2981-HT3938_s_at,-373,-122,-126,-433,-110,-346,-480,-242,-181,-289,-147,-224,-83,-119,-105,-196,-262,-60,-304,-243,-192,9,-273,-319,-180,-186,-411,-698,-242,269,477,-8,-306,-173,361,-241,33,-9
+HG2981-HT3125_s_at,-16,152,-22,695,717,16,957,-19,395,50,113,408,93,138,464,-7,1125,1111,84,61,21,487,100,1290,246,13,45,334,146,1017,1219,523,547,584,1517,439,1480,1427
+HG2987-HT3136_s_at,270,54,298,316,160,176,278,-77,294,117,152,100,78,173,28,246,376,127,115,75,23,61,267,205,-2,216,477,259,100,186,90,133,258,67,231,138,213,27
+HG2994-HT4850_s_at,1495,356,1831,591,212,517,1723,706,552,208,338,265,175,264,162,322,1471,902,267,273,783,282,588,282,408,199,225,592,1399,706,646,425,610,93,122,478,505,1001
+X52896_s_at,127,-201,0,499,-103,149,346,146,178,-10,-243,248,-41,140,98,126,78,-100,4,48,-41,173,265,32,-21,-77,208,124,464,228,-163,104,-106,-38,5,333,127,-17
+U77846_rna1_at,256,144,100,395,145,360,317,607,312,186,222,113,177,287,70,115,386,193,161,162,46,289,218,220,204,195,270,308,339,288,296,267,210,65,123,340,301,367
+U77846_rna1_s_at,629,309,474,613,196,631,725,553,630,163,386,403,206,281,200,292,83,147,141,150,392,500,398,410,439,172,377,364,555,658,570,639,545,177,419,439,234,782
+HG2999-HT4756_s_at,211,242,125,63,46,48,156,101,209,141,322,2,62,114,20,213,556,8,117,189,4,43,296,83,3,92,6,106,-43,234,179,199,84,-61,21,19,55,179
+L07807_s_at,-243,716,-326,-9,122,97,114,130,-234,-160,304,306,-37,-114,115,183,-204,256,384,-250,62,-292,167,35,529,38,273,-111,803,-33,636,418,844,54,385,-261,747,283
+HG3044-HT3742_s_at,-125,-141,-203,-83,-49,-81,-117,-254,-168,-42,-6,-119,-73,-78,-61,-46,-309,-62,-102,-63,-17,-2,-81,-103,-64,-36,-361,-202,-158,-321,-101,2,-129,-74,-104,-70,-30,-82
+X02761_s_at,-212,-309,-435,-346,-159,-190,-248,-301,-199,-149,-145,-103,-221,-154,-142,-211,-628,-197,-208,-286,-82,-261,-269,-265,-195,-199,-524,-297,-259,-280,-113,-181,-108,-109,30,-211,-247,-324
+HG3075-HT3236_s_at,324,91,140,277,149,17,220,226,161,101,114,64,285,108,330,165,281,89,121,106,3,175,-28,203,128,153,142,153,62,81,119,134,179,74,381,82,218,195
+HG3076-HT3238_s_at,4094,4069,5096,2621,4087,2429,1863,4252,4844,1853,5780,1244,2966,2751,3530,3217,5768,1351,2366,7286,5034,2641,3022,4645,2319,2155,1786,3523,1875,4523,2909,3405,4276,2165,4043,2137,3937,3463
+HG3085-HT3254_s_at,82,87,132,72,30,10,45,76,63,73,39,31,34,32,-6,86,83,108,28,35,-23,24,22,114,8,52,76,52,36,22,90,142,178,75,51,36,77,385
+X75755_rna1_s_at,588,840,627,439,925,280,446,655,1082,242,593,215,731,628,585,546,1019,266,410,1796,349,264,355,1273,539,459,259,510,290,471,265,372,471,238,353,333,505,322
+HG3105-HT3281_s_at,71,106,86,41,37,35,21,61,140,105,-22,-2,33,-26,9,54,124,91,44,184,93,19,-13,52,-17,43,126,-42,168,110,-37,71,193,14,159,-64,-31,175
+HG3107-HT3283_s_at,497,570,586,531,264,464,257,460,621,245,175,142,277,75,158,268,507,280,274,396,42,209,338,513,83,192,367,364,201,595,93,304,333,225,445,443,637,488
+HG3125-HT3301_s_at,157,58,140,274,80,110,199,128,300,159,110,103,71,20,68,120,481,198,116,-31,44,116,208,66,116,41,320,359,266,45,279,143,184,41,181,251,296,200
+HG3148-HT3324_s_at,11,87,453,19,251,-14,-21,571,167,42,443,34,528,55,499,425,200,213,198,920,312,213,-277,187,390,413,-40,144,-233,543,-54,448,416,432,146,20,105,-41
+HG3187-HT3366_s_at,-222,-150,-393,-146,-55,-186,-379,-361,-222,-111,3,-209,-79,-99,-40,-72,-324,-218,-28,-133,56,-126,-199,-187,-76,-124,-413,-2,-84,-378,-190,-137,-161,-57,131,-78,-287,-373
+M31520_rna1_at,266,330,228,329,457,165,26,110,17,159,264,360,328,299,570,283,210,172,240,518,73,132,302,394,365,180,158,230,153,104,346,153,315,636,26,183,337,167
+M31520_rna1_s_at,8818,9644,8105,9380,8300,6280,4333,5877,9248,6389,9298,5471,5870,9578,10147,8812,12257,6202,7904,15044,16056,7361,6778,10600,8225,9812,5905,9590,6826,5460,7605,7392,9136,8638,6609,5366,9068,7747
+HG3242-HT4231_s_at,-128,83,-100,31,-22,-90,-68,-368,-156,-1,-205,-169,-2,-116,-14,2,-105,-68,-139,158,543,-137,-7,91,-13,165,208,-48,-175,-376,-78,-72,-28,-91,-63,-44,-170,-141
+HG3242-HT3419_s_at,282,3,221,219,25,144,-11,215,-5,39,138,150,-116,-61,68,47,-19,54,-56,-23,171,156,279,98,149,20,-17,134,129,116,234,155,190,67,261,115,190,185
+U05572_s_at,-471,162,-375,-542,24,-216,-362,-70,-445,-490,-145,-235,-58,-405,106,-266,-203,-38,-129,55,-32,-351,-454,-122,-279,5,-890,387,-175,1191,544,-255,-635,406,1756,519,-296,-478
+HG3319-HT3496_s_at,596,508,693,537,491,540,497,518,864,469,642,303,486,505,548,631,920,463,530,850,361,428,444,575,377,428,583,504,459,624,531,540,510,325,454,520,712,830
+HG3327-HT3504_s_at,-1198,-897,-1319,-1322,-561,-1026,-1327,-1577,-1265,-1015,-933,-892,-756,-1040,-670,-994,-1558,-640,-719,-834,-598,-932,-1176,-885,-716,-553,-1627,-1080,-1445,-1114,-1303,-974,-1174,-402,-1200,-1229,-1525,-1570
+HG3342-HT3519_s_at,392,520,468,316,282,352,275,262,574,2726,245,239,413,392,159,249,558,294,272,409,219,295,398,556,308,338,316,344,343,335,382,434,1020,133,605,307,550,1035
+M97016_s_at,-385,-432,-570,-67,-203,-408,-509,-556,-425,-314,-359,-280,-292,-319,-280,-357,-568,-289,-310,-417,-166,-290,-284,-394,-254,-156,-713,-704,-500,-657,-625,-515,-560,-239,-399,-388,-532,-733
+HG3395-HT3573_s_at,74,260,567,182,218,440,-124,425,58,343,449,229,113,223,171,146,-68,260,264,543,201,362,284,424,498,694,458,262,293,44,-149,543,63,81,-108,-91,174,-70
+X68505_s_at,151,35,-31,118,142,1,184,110,10,27,117,50,103,48,192,132,12,36,47,240,51,86,36,288,-31,65,14,-18,-21,-63,34,62,31,-2,4,37,111,9
+HG3412-HT3593_s_at,251,-100,110,65,76,142,189,269,348,95,236,35,204,205,-33,154,171,39,138,306,63,34,37,158,15,64,165,223,16,173,353,59,160,81,97,44,246,161
+HG3417-HT3600_s_at,183,195,196,-45,79,152,193,214,170,80,126,171,-1,153,31,-324,395,29,19,-35,11,105,5,140,137,8,377,14,86,331,654,273,68,93,485,163,74,456
+HG3426-HT3610_s_at,259,166,179,271,104,135,211,413,162,71,110,73,173,269,117,203,420,112,71,342,257,215,151,265,138,114,250,117,52,-25,268,175,223,94,98,185,196,283
+HG3431-HT3616_s_at,2,17,49,-33,-12,42,-10,5,0,-21,-8,1,-17,11,0,-24,-44,-15,-48,-19,43,-17,0,32,26,6,71,-23,81,-58,34,16,27,-18,46,-28,-23,-42
+HG3432-HT3620_s_at,139,144,159,163,80,216,272,313,160,131,91,176,101,177,48,131,232,60,60,137,28,147,360,128,173,53,303,164,187,68,225,237,175,109,62,154,173,225
+HG3437-HT3628_s_at,276,218,307,542,157,181,275,164,284,254,247,319,210,231,386,415,955,300,250,272,74,401,241,242,264,565,505,418,408,282,169,313,260,283,113,193,363,321
+HG3484-HT3678_s_at,588,2427,222,282,454,193,712,1122,588,493,1445,477,630,513,592,799,1089,112,593,4343,2141,1000,676,786,1616,583,322,1168,271,525,369,1454,1190,311,731,222,654,889
+HG3523-HT4899_s_at,893,1175,924,2817,2246,967,1473,1421,720,864,769,625,497,2646,1007,701,3135,17,447,1409,480,848,1054,1064,918,497,1297,660,730,1279,1133,865,702,636,1064,583,949,1285
+M13929_s_at,253,223,108,3259,2277,277,502,161,354,275,97,100,361,2978,760,245,3005,154,179,279,-41,111,302,1139,237,74,854,106,168,274,171,340,206,54,30,26,253,551
+J03242_s_at,683,313,482,623,322,273,393,1015,557,236,311,275,312,481,249,471,589,258,369,1956,351,262,360,532,451,389,430,504,711,467,420,468,425,265,358,381,678,492
+M17863_s_at,286,195,304,93,196,305,178,452,244,136,218,169,125,136,-23,191,259,123,371,318,164,107,288,406,121,356,231,193,156,240,237,399,252,21,108,160,234,333
+HG36-HT4101_s_at,266,219,485,353,221,257,184,175,389,148,342,275,448,269,167,276,543,155,134,380,211,329,467,245,234,90,81,229,185,325,231,210,271,351,159,103,208,563
+HG3638-HT3849_s_at,441,22,108,175,158,14,151,197,77,38,113,35,348,36,103,216,878,99,250,1568,143,85,184,81,-3,98,283,169,247,87,17,68,214,-19,100,57,580,390
+HG3638-HT3993_s_at,264,-26,-39,77,71,99,13,103,72,24,182,83,178,80,58,196,464,24,50,373,-48,132,-186,177,47,213,21,201,132,-212,-41,105,-74,21,11,75,98,-71
+HG3703-HT3915_s_at,-7,-87,-131,61,8,-167,-92,-236,58,12,-51,-71,-12,7,-51,-27,-190,-48,-32,-34,26,69,-37,-112,-93,-32,-98,1,60,-87,-70,-81,-103,-86,-88,-53,-8,-92
+J04093_s_at,49,-11,25,40,16,-44,-10,-28,49,-25,4,31,52,31,-19,-35,37,2,14,5,48,-10,-47,55,36,33,-32,35,7,-1,27,20,64,6,28,-20,27,53
+HG371-HT1063_s_at,-13,-29,-70,-69,-23,-92,-97,-157,-151,-51,-79,-22,-20,-89,-40,-52,-134,-34,-93,-47,-41,-5,-81,-7,-8,-77,-131,-98,-4,-50,-100,-5,-35,-38,-28,-85,-155,-44
+HG371-HT26388_at,-2817,-3297,-3286,-2768,-2181,-2656,-2759,-3914,-2634,-2425,-2234,-1609,-2504,-2192,-3050,-2247,-2628,-1929,-1939,-2364,-1064,-1605,-2152,-2391,-2175,-2099,-4850,-2617,-2354,-4017,-3513,-2846,-2153,-1238,-3877,-2621,-3660,-2401
+HG371-HT26388_s_at,406,239,676,517,190,307,290,161,435,485,320,264,402,221,133,351,446,333,190,321,414,422,378,497,217,76,233,515,507,279,547,953,512,297,452,86,465,801
+HG3725-HT3981_s_at,413,279,640,471,378,254,337,319,623,137,328,284,293,215,213,394,397,237,291,56,176,400,408,302,195,323,372,988,430,434,323,434,511,388,707,387,519,771
+HG3730-HT4000_s_at,1237,-354,-208,235,685,296,142,610,-336,-205,-236,-160,162,-326,637,358,253,143,-2,1025,-142,-43,-229,557,-211,508,42,417,250,1512,130,-266,-161,-98,271,290,911,315
+S80267_s_at,854,112,82,358,661,202,181,481,194,47,85,37,167,106,700,340,270,87,55,721,-56,78,17,500,7,227,81,187,151,844,192,60,138,119,561,353,1208,279
+U10687_s_at,315,158,358,316,130,188,248,283,188,188,146,127,24,128,95,-52,341,146,121,102,143,185,142,54,17,132,334,76,293,172,204,212,282,15,233,248,308,175
+HG3914-HT4184_s_at,-822,-697,-760,44,-321,145,99,-1010,-693,-292,-618,-74,-348,-483,-693,-246,-293,73,-403,-150,-173,-885,108,-190,-451,-296,-830,-238,-341,-1015,-1101,-866,-554,-392,-657,160,-1303,-1049
+HG3920-HT4521_s_at,569,462,621,358,292,451,628,689,595,682,415,198,111,401,95,375,865,324,316,947,261,400,414,315,317,389,819,387,630,504,451,606,725,229,988,613,879,914
+HG3925-HT4195_at,96,-27,75,177,-18,113,63,-23,74,18,35,57,32,0,58,49,-28,-85,57,40,-8,-61,41,98,26,-14,78,-668,175,5,-26,-96,99,78,15,222,110,63
+HG3925-HT4195_s_at,-128,10,583,-625,263,-522,-673,436,632,-358,381,-27,307,381,54,253,-604,-258,-30,-419,-107,222,32,276,442,193,-541,570,-4,412,-543,684,455,-34,-439,-442,-790,-37
+HG3928-HT4198_at,210,-428,312,-440,-760,506,194,80,20,-524,-58,-392,-936,-392,-746,-317,-930,-819,-824,-1530,-47,-374,-222,-146,-484,-822,-480,229,91,-208,-1238,-1058,-479,-817,-774,285,-578,-494
+HG3928-HT4198_s_at,-789,-511,-984,-922,-433,-1050,-546,-1104,-904,-688,-446,-524,-479,-648,-512,-542,-790,-536,-618,-656,-198,-362,-585,-508,-630,-346,-1204,-758,-586,-989,-927,-782,-772,-540,-879,-708,-791,-830
+HG3954-HT4224_s_at,-140,18,42,-168,-46,-48,-136,-182,-22,178,405,-125,-32,-152,-40,-47,4,157,33,-149,-6,-172,-9,82,210,245,-179,0,-197,255,-275,99,274,197,-131,-78,-83,-134
+X77588_s_at,1094,648,1048,922,1373,1122,888,592,1137,388,898,790,798,582,1118,818,359,279,393,1371,421,248,587,885,388,655,168,489,605,504,566,730,310,544,681,515,181,120
+HG4011-HT4804_s_at,1428,879,796,1192,503,1091,693,1382,1533,410,1169,648,653,886,851,1249,1547,724,662,894,376,1044,1094,890,928,973,1328,985,1195,766,277,904,1385,335,493,571,1256,1980
+HG4020-HT4290_s_at,2394,1048,2945,1593,913,1353,1821,2118,2524,1032,1666,961,975,1051,953,1088,2499,858,929,1457,682,1199,1301,1685,1862,1080,1907,2472,2017,1718,1552,1423,2364,1164,3291,1908,1523,2358
+M74509_s_at,904,1083,315,1544,419,1456,1851,-74,801,884,1070,510,662,809,875,969,1996,482,971,388,173,835,849,779,1257,951,943,632,1197,705,1229,1455,966,618,1165,1344,1728,1568
+HG4063-HT4333_s_at,144,45,226,93,35,64,198,179,163,60,103,33,69,146,65,113,136,108,158,79,93,86,53,8,134,168,217,250,187,142,53,221,151,15,48,87,91,229
+HG4094-HT4364_s_at,107,154,276,226,170,204,203,167,171,50,44,60,180,181,266,137,453,90,91,287,32,19,199,194,85,131,170,176,165,154,125,18,102,83,54,173,212,77
+HG4099-HT4369_s_at,-435,-550,-757,-536,-252,-570,-552,-893,-608,-295,-465,-311,-306,-563,-291,-281,-1013,-307,-194,-432,-251,-255,-317,-420,-299,-352,-201,-638,-490,-748,-500,-682,-417,-237,-806,-578,-523,-609
+M13150_s_at,62,-57,125,92,62,26,43,185,90,85,-86,-8,-1,107,23,-62,-289,-91,51,-158,102,113,32,145,134,-77,-10,-54,103,20,71,-11,-50,17,-154,48,50,-109
+HG4116-HT4386_s_at,-147,-141,-247,-114,-95,-74,-119,-440,-321,-97,-195,-112,-83,-89,-48,-159,-582,-108,-119,37,-12,-45,-68,0,-95,-235,-364,-323,-327,-335,88,-245,-273,-213,-116,-133,-150,-410
+HG4113-HT4383_s_at,519,617,640,429,372,439,497,269,531,247,300,271,182,220,186,282,493,363,255,779,168,398,347,407,391,432,613,597,401,525,372,364,420,41,-9,309,516,601
+HG4120-HT4392_s_at,211,137,197,199,108,263,95,59,-37,105,416,206,179,66,273,87,541,-3,178,418,-44,236,220,134,161,27,-71,17,0,76,430,451,134,23,147,-7,37,153
+HG4155-HT4425_s_at,-110,-100,-222,-138,-65,-163,-80,-176,-154,-51,-9,-50,-93,-173,-91,-102,-50,-58,-65,-117,-67,-81,-155,-220,-54,-69,-79,-70,-40,-140,-50,-78,-89,-37,-79,-60,-39,-158
+HG417-HT417_s_at,356,790,-99,459,1651,144,744,149,70,70,-104,195,1140,359,1866,124,787,270,553,1316,769,351,197,691,298,393,9,434,240,4876,3972,625,284,1453,5062,807,1499,2829
+L13266_s_at,169,121,-104,132,95,-46,208,-1,273,113,59,54,141,302,-58,132,394,98,14,197,4,120,77,460,155,-20,148,-268,-194,-273,-117,103,214,77,304,-35,-7,275
+U09937_rna1_s_at,730,1245,1369,463,682,810,1490,62,347,1269,410,557,793,274,428,930,1866,789,592,746,193,784,516,689,500,480,1509,945,-363,6401,5440,699,2088,1217,2148,1327,1389,5642
+M20867_s_at,618,974,804,541,1113,460,584,376,1605,739,766,321,990,542,1016,468,1756,338,540,1696,419,192,347,894,322,417,583,361,646,555,381,287,630,235,912,412,799,380
+HG4264-HT4534_s_at,809,629,548,310,695,341,270,275,653,398,610,400,1179,599,702,498,1331,86,471,1162,605,572,300,611,556,471,287,571,415,935,1077,767,563,669,421,447,1109,1041
+HG4318-HT4588_s_at,219,415,196,595,426,330,126,668,786,170,344,284,89,522,396,338,417,174,431,506,289,109,632,581,404,299,206,185,639,415,660,766,484,221,509,170,608,220
+HG4334-HT4604_s_at,5,311,142,193,534,81,204,73,337,136,-157,178,251,286,198,202,142,-76,266,853,91,-10,150,243,26,129,206,186,14,477,197,73,226,351,488,207,310,244
+HG4517-HT4920_s_at,29,56,43,99,155,12,-50,259,11,-33,44,-34,50,93,49,-37,-3,-49,5,41,27,-47,-34,40,-33,23,10,-45,-96,-45,68,97,64,91,103,5,108,13
+HG4535-HT4940_s_at,1449,1043,1952,1649,797,1180,1687,1989,1887,1151,973,899,885,1416,745,1066,1944,565,1470,1242,770,1014,1288,970,1214,759,1492,1919,1526,2202,3542,3267,2149,1246,1171,1249,2437,3184
+U19251_s_at,233,105,200,159,75,227,245,80,356,241,41,109,115,172,88,211,288,70,196,140,13,75,96,231,26,149,154,301,276,262,116,22,156,37,209,147,142,363
+HG4668-HT5083_s_at,293,309,116,73,213,23,263,149,61,59,321,271,311,40,90,150,815,269,31,408,44,268,197,486,242,41,-131,479,7,378,254,290,445,227,200,227,225,529
+M57464_s_at,238,162,317,207,150,170,235,253,230,155,187,122,105,202,123,53,283,117,170,157,28,119,227,205,166,150,120,278,122,167,202,259,240,101,122,138,248,375
+HG4683-HT5108_s_at,-51,-576,265,-213,-169,-72,-176,-280,-61,472,398,-56,37,-24,-35,-119,1,198,114,26,291,-27,36,115,-390,359,-483,504,379,172,-222,104,-129,313,-371,-227,60,8
+HG4755-HT5203_s_at,303,198,800,233,278,126,8,223,225,78,357,31,209,113,203,106,437,60,120,392,51,58,324,387,188,238,179,368,-38,73,-77,230,-90,5,-61,-74,25,37
+HG4757-HT5207_s_at,365,208,101,146,122,129,201,205,148,112,83,63,118,148,99,102,206,-15,370,124,186,98,176,143,-27,20,-12,919,240,134,231,178,206,119,100,77,295,146
+M79463_s_at,581,372,439,414,321,529,307,160,685,266,408,362,292,454,487,544,578,388,279,463,394,383,366,217,590,513,-62,594,608,210,1371,486,675,519,766,162,404,2031
+M82827_s_at,-92,4,-99,-55,-34,33,-109,-143,-42,-80,-53,-28,-48,-18,-53,-95,-110,-42,-69,-36,-8,-35,24,-15,0,-71,7,-123,-132,-140,-49,-71,-37,-71,-80,-69,-68,-48
+HG627-HT5097_s_at,1744,1451,1671,1933,617,1623,1907,2548,2087,791,1140,957,627,1172,831,1024,1054,844,1402,1834,524,1532,1324,904,1618,638,1728,2057,2229,2074,7770,6257,2262,3724,2185,1578,1372,2918
+HG627-HT5098_s_at,41,242,295,457,83,232,534,40,-21,48,248,28,157,97,179,151,735,150,440,552,226,68,216,197,622,67,384,206,661,396,2975,3100,806,1459,270,103,24,738
+X54867_s_at,-38,50,9,3,12,-33,-94,0,2,0,43,-2,-16,97,70,1,87,28,55,-113,13,-19,28,-16,-12,-60,103,21,4,39,19,79,-27,-22,60,19,7,63
+X57110_s_at,322,36,377,348,34,295,193,409,297,137,130,129,111,129,184,142,238,74,82,43,274,160,112,139,73,37,164,264,262,216,225,204,211,79,106,277,334,403
+L07261_s_at,287,297,429,247,339,195,415,370,302,146,200,71,136,276,281,126,482,34,75,203,-26,244,176,394,144,-10,172,81,139,159,281,210,422,111,198,121,457,360
+HG651-HT5209_s_at,451,-17,546,769,659,478,137,457,-97,-286,-8,120,403,-93,551,222,-884,-143,-304,243,18,338,351,689,-232,239,-14,119,-48,-267,-219,-216,-164,267,-359,497,204,105
+Z68280_cds2_s_at,1486,1092,1782,2212,1935,1785,2186,2313,2146,762,1649,602,564,1463,1269,801,1372,667,556,1394,650,1058,1299,2219,1299,581,943,1405,853,1831,1917,1906,2103,1276,1126,1628,2633,2691
+X07618_s_at,411,221,484,-301,162,113,104,68,394,336,221,-87,225,-185,238,426,568,148,221,17,-92,90,74,229,111,193,297,438,161,373,113,44,262,-126,148,24,118,517
+HG721-HT4828_s_at,401,345,500,766,343,234,979,403,407,169,297,192,189,150,434,580,975,375,432,678,296,292,178,543,316,532,425,541,329,487,213,326,429,326,394,230,897,619
+HG721-HT4827_s_at,364,176,269,181,41,192,305,427,249,88,248,237,192,168,155,292,538,209,48,222,213,204,136,217,222,231,345,381,276,380,267,324,350,162,40,232,307,501
+HG759-HT759_s_at,-105,-156,272,144,-59,56,-48,-112,-142,-106,37,-77,-139,70,-12,-168,-168,-92,-184,-233,71,-69,96,-112,112,-94,-56,-40,197,-83,-38,-74,-176,-86,73,-175,25,-330
+HG855-HT855_s_at,52,68,82,10,48,-67,53,107,55,39,28,-20,25,0,23,27,167,153,-46,97,13,3,-9,94,-13,27,18,134,38,33,111,26,145,35,77,-45,132,132
+HG862-HT862_s_at,-255,-276,-107,-630,-287,-567,-409,-677,-348,-295,-314,-76,-269,-209,-168,-395,-481,-96,-405,-703,-34,-35,-473,-153,-226,-19,-145,-284,-240,-456,-682,-351,-518,-173,-626,-487,-570,-106
+HG880-HT880_at,-7,-294,414,-350,-190,392,114,517,20,-91,-149,-211,-368,117,-246,147,441,255,465,-1215,176,238,-83,-97,7,-22,275,458,735,91,-44,174,-94,-258,570,-367,-22,318
+HG880-HT880_s_at,-422,-577,-521,-564,-176,103,-665,-577,-268,-243,-385,-255,-268,-334,-214,-465,-1092,-342,-144,-361,-121,-181,-387,-289,-212,-367,-638,-369,-346,-506,-454,-589,-504,-259,-338,-307,-619,-874
+HG884-HT884_s_at,284,408,155,128,302,240,94,137,207,132,403,96,213,338,417,249,350,146,79,438,323,172,134,382,129,105,142,190,96,116,287,143,157,191,132,62,339,412
+L08096_s_at,499,-26,172,7,153,71,-53,-352,-12,-74,8,70,51,204,455,262,-86,1594,-102,-24,-13,22,-37,159,18,300,-23,217,-16,592,-109,108,33,-86,71,24,-113,-301
+HG944-HT944_s_at,-950,-778,-1143,-837,-617,-974,-611,-1166,-1201,-525,-731,-699,-929,-1472,-675,-436,-1580,-621,-626,-1412,-182,-657,-765,-1125,-511,-521,-915,-1018,-1019,-1806,-872,-1769,-1671,-701,-1628,-1204,-619,-1110
+S76942_s_at,1254,433,2395,1026,504,979,621,2052,-362,-294,1106,612,810,346,793,787,1689,624,336,1519,394,801,695,195,1603,586,614,394,1183,1584,1986,1294,618,451,988,1215,1552,3361
+HG945-HT945_s_at,49,66,76,166,92,138,181,185,208,163,123,71,93,160,84,122,77,85,49,70,142,105,49,116,3,36,151,113,182,85,130,140,101,93,88,87,233,121
+X54457_s_at,-463,-206,-436,-390,-59,-412,-287,-775,-325,-353,-182,-235,-48,-288,-159,-6,-299,-137,-352,-122,-184,-262,-250,-192,-58,-78,-319,-247,-396,-391,-560,-213,-182,-161,-218,-449,-268,-214
+X77777_s_at,-545,-65,-494,-276,-253,-264,-154,-298,-217,-380,-346,-73,-276,-303,-371,-306,-670,-182,-275,-469,-216,-338,-391,-356,-52,-254,-356,-423,-281,-406,39,-413,-392,-143,-309,-166,-192,-232
+HG982-HT982_s_at,437,357,534,150,178,227,411,215,542,317,395,323,245,408,212,352,590,244,139,281,64,200,110,181,445,410,505,499,423,627,333,353,382,119,252,550,661,494
+HG998-HT998_s_at,285,631,947,537,500,378,255,236,552,95,272,122,568,1042,923,196,317,186,364,938,116,385,212,693,322,467,203,936,379,1090,3,556,-31,109,910,674,467,-8
+M10277_s_at,15216,15643,17059,14893,16597,25351,13087,16829,15246,17924,16311,14516,18132,16023,16741,16820,15370,19146,14653,13827,19267,9304,17534,15702,14125,18114,19996,15725,15192,19287,15005,10312,13913,10279,15421,17000,15893,14392
+M97935_s_at,509,286,610,294,375,341,240,437,686,225,219,97,690,1285,2600,410,989,410,364,2687,539,150,254,650,780,288,325,297,430,519,1630,465,467,225,249,95,258,3490
+X01038_rna1_s_at,-244,-290,-489,316,47,161,-421,-88,-206,51,-173,254,-234,-60,187,13,-310,76,99,48,9,99,-157,-187,18,-109,230,-160,-341,152,-255,-51,-236,-427,-336,159,-714,-44
+J00105_s_at,21909,21319,19963,18519,13909,12278,15021,24018,19279,11614,11254,16809,20133,19916,21147,15165,24360,18365,15715,22998,10654,21464,8604,16743,21907,14998,10284,16089,16293,21546,20096,12008,18352,17714,21020,12165,18075,20089
+J00116_s_at,-268,-77,-279,-188,-5,-302,-99,-407,-315,-93,-80,20,-129,-319,-35,-101,26,-157,-142,-154,-2,13,-189,-210,81,-255,-195,-186,-379,-13,-88,-71,-34,-38,-56,-143,-156,-310
+V00535_rna2_s_at,115,5,181,-59,3,72,15,-77,-3,228,20,-8,-52,142,58,208,-124,21,27,31,36,-2,229,-103,104,-37,32,-79,-28,303,83,327,-138,3,109,-23,-25,-99
+J00219_s_at,-27,-17,23,-76,-16,-119,-20,0,-17,7,-8,-24,-25,21,-3,-85,-4,14,-14,-45,54,-45,22,-10,27,-6,71,-49,-64,-37,4,-63,-37,-10,-21,3,-17,56
+L00022_s_at,-524,-110,-439,-423,-192,-417,-411,-262,-444,-91,-243,-304,-354,-241,-457,-362,-180,2884,-185,-319,-178,-235,-357,-413,-154,-116,-366,-375,-348,-582,-208,-160,-345,46,-367,-402,-380,-239
+S71043_rna1_s_at,3245,1353,770,419,693,503,334,2440,1926,361,675,255,397,1110,1193,243,5019,6669,791,696,327,150,482,250,397,1142,549,5383,1082,10500,13294,995,3138,808,931,1839,2587,1145
+M87789_s_at,3326,5768,-216,37,974,280,1080,883,-561,260,-61,-152,3384,610,896,208,3977,6102,1099,965,-162,129,-233,-274,165,619,-419,12507,1909,13804,12347,584,2408,2177,4053,2239,1064,2556
+J00268_s_at,882,40,741,1363,134,570,715,1320,-93,-287,548,554,1049,622,910,1124,800,631,570,343,201,1234,1204,405,1434,1058,1304,223,512,337,947,152,-8,370,-234,26,1621,834
+V00594_at,-2532,-1278,-2466,-3216,-634,-1872,-2873,-3550,-1849,629,-666,2102,-1301,-585,-1260,-1260,-4125,195,55,-2447,-1470,-1832,-1956,-1710,1286,-887,-4226,-1629,-1322,2340,7635,-1707,-1134,130,805,-1903,-3197,-1257
+V00594_s_at,1024,5031,2012,2168,2877,2766,2034,1811,4944,6687,2968,8918,995,3836,1840,2850,3843,9087,7168,3133,1240,1018,2110,1815,10336,1865,1883,6366,3703,10634,31781,2494,5559,2569,13588,1636,1880,6191
+V00574_s_at,-80,166,402,230,257,407,82,64,475,89,313,217,-5,373,133,106,-331,21,-3,38,-3,32,28,29,64,177,-391,171,197,79,145,404,42,251,-62,10,231,63
+M29386_s_at,192,132,245,107,117,220,305,398,144,149,137,126,94,23,153,146,94,95,98,96,88,465,81,389,55,107,104,182,302,56,215,14,117,151,159,155,245,142
+V00599_s_at,16077,7162,21278,11421,10273,21046,8265,11357,21674,22146,19740,5867,17328,7624,14960,6918,19836,15159,6595,13380,5543,7606,18187,10398,7612,6395,6681,4265,4991,17522,13055,10355,15986,10418,7901,11414,8140,11200
+J02621_s_at,2006,4549,3200,1963,2833,2432,2767,1595,5347,2820,3084,3516,4773,2403,3258,2875,7018,1881,1428,3795,6211,1561,2057,2815,8423,1838,2013,1798,1789,2800,2037,2564,1912,1966,2622,2103,3090,2655
+J02683_s_at,5765,4837,5782,3133,3919,4914,3143,2170,9462,6766,5640,4134,5435,3947,5562,3893,4434,3249,2827,7826,4771,2805,4158,3568,2880,2184,2251,799,2084,5856,3421,2463,5550,3913,3871,2987,2776,3599
+J02758_s_at,182,153,245,-14,46,199,119,112,106,64,74,45,39,84,135,122,94,152,27,113,-43,51,75,100,58,102,132,13,33,186,167,65,43,82,288,-24,153,188
+X05130_s_at,834,1630,962,657,1614,942,821,848,2729,1064,2207,958,1082,893,1214,852,2422,814,521,1304,6,568,896,1331,674,826,378,1716,755,5362,2781,1911,936,1974,6162,1832,1382,2484
+M27436_s_at,160,17,85,-56,38,108,-55,-20,-33,55,26,113,19,-33,21,10,-1,5,42,6,28,-30,-20,56,51,12,-10,-2,-21,301,21,70,20,9,90,9,-13,88
+J02871_s_at,8,-91,-38,-127,-65,-17,-157,-35,-116,-90,-132,-41,-1,-85,76,-68,-164,24,-20,-59,-119,-124,-167,80,-41,27,-159,-22,-91,-87,-100,-1,-22,94,-21,241,-170,-154
+M13232_s_at,61,58,161,245,88,108,173,94,391,260,36,63,102,106,221,174,245,138,152,118,146,79,-22,115,23,30,172,338,93,110,226,186,181,86,244,205,371,424
+M22403_s_at,-70,39,131,101,-31,160,6,86,54,155,-131,132,-2,17,-4,71,-66,-19,-2,168,154,28,252,-26,121,-124,48,86,125,-177,210,28,32,53,36,119,-127,-193
+J02947_s_at,-70,-151,387,518,2,-188,94,310,-189,-84,-209,182,-5,-25,-4,232,-33,-3,268,-143,-39,70,-159,1,218,-54,-280,176,72,105,-97,-180,98,229,-232,355,133,-113
+J02960_cds1_s_at,158,-26,-76,132,21,174,105,35,98,-51,91,14,62,27,70,-23,-184,148,38,35,93,10,55,110,9,1,-380,35,64,418,89,39,162,135,-180,147,123,141
+M29610_at,285,165,325,209,234,119,203,193,324,118,121,120,157,152,161,211,263,138,159,295,131,121,241,258,162,183,245,245,163,167,277,442,246,351,144,204,217,220
+M29610_s_at,151,47,191,169,96,195,201,523,220,27,36,57,144,181,58,159,385,77,471,863,198,125,113,64,325,126,256,171,1464,154,1159,1898,582,944,316,146,163,657
+U05255_at,-129,-127,-171,-4,-48,-14,-99,-163,133,-77,-114,-7,-2,-102,119,10,-77,-103,55,35,41,-83,-163,-29,-2,-85,-14,-127,-64,-141,8,-52,-37,199,-73,-139,1,-88
+U05255_s_at,-526,-1379,-1933,-730,-459,-876,-179,862,-753,-902,-333,-628,-379,-293,-342,-133,-1274,-96,1518,1996,-107,-461,-693,-230,893,-130,-838,-864,1750,-143,6137,8144,1108,4927,-36,-886,-728,1401
+M17446_s_at,-284,-135,-33,-263,-3,-419,-270,-491,-71,-79,-100,-201,-164,-89,-511,-458,-750,-309,13,-20,-178,-409,-630,-202,-2,-276,-284,-201,-319,-228,-102,-292,-299,-313,-58,-222,-231,-373
+Y00339_s_at,-17,-17,27,-51,-76,-12,-58,-121,-71,-56,1,-31,49,0,-96,-119,-71,-48,234,266,39,-133,-81,-91,435,-119,-162,33,1048,-29,1824,982,1353,1971,176,-14,-18,2982
+U50327_s_at,226,703,920,528,415,826,384,349,870,363,689,258,130,1055,426,296,335,344,369,803,112,193,385,489,379,389,333,164,480,1102,502,342,694,967,711,1008,608,799
+J03077_s_at,1584,6035,10435,-45,1583,10205,307,233,11375,10110,5598,639,5125,2653,1717,512,4639,119,2176,2175,814,643,2933,38,2193,2722,-4,2367,1752,17853,7839,1851,2621,2452,9349,2499,7039,8728
+J03241_s_at,363,339,583,476,207,311,371,590,434,190,266,139,246,408,354,352,316,237,98,285,77,334,573,295,225,323,95,345,396,426,253,274,443,253,192,227,227,216
+U07804_s_at,-40,-19,13,-74,58,16,-55,46,-42,-22,-14,-11,-11,0,74,55,-18,10,23,117,-47,-36,-5,61,-29,-70,0,-26,-108,35,335,205,-17,94,53,-117,17,113
+U07806_s_at,1158,651,761,926,826,556,556,1248,643,423,596,83,1141,787,1436,1721,2972,630,931,3440,765,465,520,908,651,920,646,485,553,929,1792,1616,938,566,863,126,556,1897
+J03263_s_at,323,842,326,718,552,430,507,554,738,353,583,169,451,266,577,254,1414,257,173,469,-144,217,355,901,233,283,337,313,177,1564,1105,820,838,479,1817,655,1591,1014
+Z74616_s_at,55,-88,-30,-207,-47,-39,-104,-34,-87,32,-22,7,-10,-25,47,-46,180,1,-51,-22,44,-139,-112,69,-44,14,39,-9,-43,-107,-19,-8,-68,-105,10,-64,-79,44
+X51441_at,113,203,82,-99,66,-53,62,65,85,13,78,5,-11,-17,-44,129,57,41,58,24,68,-51,125,230,156,171,23,45,62,47,22,110,25,-9,87,24,13,-5
+X51441_s_at,-567,-799,-607,-668,-307,-490,-680,-1341,-395,-299,-544,-306,-400,-420,-374,-397,-890,-187,-975,-1643,-208,-545,-480,-221,-884,-460,-633,-314,-721,-524,-1809,-2441,-659,-1858,-655,-455,-855,-1701
+L25878_s_at,-134,-35,-111,-212,-18,-192,-120,-112,-167,-4,-107,-109,17,-98,-209,-12,40,-21,-10,-42,-83,-75,-136,-66,-39,83,-40,-48,-40,53,-113,-155,-69,-25,47,-60,-92,-87
+Y00285_s_at,878,919,889,1039,609,707,929,791,1159,386,705,301,557,485,735,722,1649,572,489,907,-82,323,989,551,395,563,818,324,420,1391,519,466,490,418,651,776,637,643
+M26004_s_at,-32,19,950,39,78,631,-3,140,741,196,116,2,43,69,-14,70,196,67,30,74,32,-37,157,140,43,137,15,31,36,69,27,10,7,47,16,27,37,132
+S62696_s_at,-244,-116,239,-152,-97,101,-211,-83,-52,26,-138,-120,-131,-75,-194,-76,-297,-57,-75,-122,-114,-139,-267,-185,-119,-27,-198,-146,-125,-136,-175,-120,-144,-69,-21,-226,-249,-262
+M17183_s_at,110,0,92,27,-5,133,1,-83,8,27,0,48,28,14,19,49,-13,29,48,66,3,-52,53,71,41,-17,87,1,-48,-23,43,41,2,26,-5,11,-10,12
+M24351_cds3_s_at,111,60,109,116,-36,80,48,146,82,51,70,24,17,16,-8,60,162,109,32,52,99,35,91,146,74,31,64,42,38,77,67,156,-37,-7,27,-11,44,116
+M31551_s_at,-214,-185,-201,-528,1,-225,-241,-109,-142,-248,-127,497,-274,-117,-209,-224,-522,-175,-296,-205,-88,-307,-104,-234,-146,-222,-219,-285,-221,1170,9464,-229,179,-74,105,-35,537,838
+J03626_rna1_s_at,77,-94,131,133,214,53,62,95,18,28,-33,-7,113,234,166,132,253,79,37,317,72,-70,43,166,-29,96,4,-8,21,94,-75,-12,22,-31,-33,-54,-18,19
+X57579_s_at,177,350,232,286,336,122,240,265,419,175,375,185,65,335,237,240,573,211,283,420,77,185,229,127,311,323,181,516,105,560,720,500,772,127,413,463,356,9428
+U01691_s_at,775,389,1622,367,386,1253,336,205,2899,827,1030,31,791,968,239,337,306,345,161,97,412,258,775,448,326,227,330,393,163,3343,779,120,281,137,1929,523,865,886
+X04729_s_at,345,63,400,138,139,-78,193,172,55,344,224,-43,209,127,54,171,581,181,0,286,52,184,-7,142,567,82,201,424,129,554,182,150,316,74,229,204,480,553
+J03778_s_at,-61,-107,-115,-108,-34,-62,-5,5,-72,-51,-137,-67,-85,-104,-47,-72,-68,8,48,-149,-103,-49,-68,-90,-54,-110,-198,-94,-98,-132,36,28,-154,5,-103,-190,-80,75
+M21119_s_at,-9,253,82,285,3058,766,120,380,160,553,143,583,5,1651,60,140,147,11,65,154,34,40,212,178,69,39,54,247,216,20504,14508,176,51,571,3425,3934,4427,13140
+M24349_s_at,-20,39,-11,9,-10,40,45,176,41,43,-32,54,28,15,35,118,-12,16,32,30,151,-34,-15,75,4,-13,-15,60,79,63,73,-26,68,-14,61,47,72,78
+M26958_s_at,27,21,84,109,110,37,73,88,89,72,58,5,59,94,62,95,36,68,72,24,16,-34,119,126,8,79,81,150,76,62,118,14,47,23,-20,15,59,25
+J03805_s_at,613,332,553,460,673,408,428,452,848,759,726,172,2240,758,662,718,801,248,721,1830,703,173,357,738,357,456,344,288,286,251,301,443,194,305,355,204,568,1282
+M96233_s_at,344,724,-294,1018,172,1321,499,500,296,1501,72,383,211,-179,-83,452,570,-149,750,566,76,150,908,258,540,593,273,887,829,1230,470,960,447,-81,373,1275,934,752
+U72648_s_at,-880,-606,-1269,41,-402,-940,35,-190,-100,-444,-847,-63,-196,-807,-188,-801,-3553,-561,-623,-1109,-93,-6,169,-90,-643,-583,-1329,-174,2,-1221,54,-610,-607,106,-1162,-367,-1011,-1061
+J05253_s_at,270,204,291,229,201,232,225,247,309,181,246,196,183,186,266,375,648,261,213,559,404,287,370,295,184,291,333,375,334,368,140,289,210,243,169,36,225,303
+J03934_s_at,22,-133,-70,23,-9,-74,-102,-212,-238,68,-31,21,12,-178,6,60,158,-42,-53,16,-77,-196,28,-175,163,31,15,-169,-38,112,-108,34,24,-17,165,51,58,-203
+J04029_s_at,497,491,549,418,584,553,334,190,1089,432,810,215,644,453,925,636,799,332,205,1200,1447,559,336,385,415,471,194,201,33,651,312,343,119,310,335,176,606,25
+J04046_s_at,971,1835,929,999,569,1634,1273,1245,1148,1483,1234,1320,1824,998,1520,834,1374,979,979,1497,859,636,275,1294,315,791,1093,1159,346,2149,1897,1205,2074,1373,2368,1208,1623,478
+M69203_s_at,214,279,150,-179,57,58,132,275,180,101,180,-44,132,95,138,81,278,121,108,63,-2,147,47,63,2535,79,297,148,-182,9196,1945,265,338,-427,283,96,159,1017
+J04130_s_at,938,1080,842,215,229,446,648,1296,835,316,526,287,495,460,373,491,1193,472,361,482,323,542,334,439,5813,530,840,635,476,20466,4896,742,1085,191,706,345,793,4189
+J04152_rna1_s_at,-35,-43,-80,-24,-8,-12,-38,97,44,-10,-11,-40,-15,9,-50,6,-79,-4,-28,-26,16,-26,-75,-19,-4,3,32,-76,-48,354,-44,-9,-52,10,15,-30,-54,16
+M61827_rna1_s_at,2010,2020,1538,2377,1507,1269,3016,2280,2246,844,1131,741,1262,2165,2014,1321,4767,836,1186,3193,1015,945,786,2685,1159,1514,1987,3362,2053,2806,1694,1207,1472,2027,1954,2200,3575,2157
+X14684_s_at,1113,823,790,1110,1221,633,893,661,726,723,1040,373,1158,1137,1498,1168,2348,585,1074,2583,2604,568,780,1132,795,877,857,1078,593,806,776,1274,845,769,566,667,676,632
+J04430_s_at,256,333,150,318,178,37,178,206,60,143,57,22,144,118,87,297,1732,320,-28,245,213,23,5,130,168,175,220,95,129,-49,62,-52,147,243,147,134,145,214
+U75272_s_at,440,249,486,386,208,254,425,388,305,136,300,194,185,248,119,359,402,413,349,284,227,332,246,85,249,295,311,129,134,398,341,242,391,251,246,338,246,688
+M27968_s_at,79,-79,-103,-171,-47,101,-136,22,-172,14,-63,-94,-113,-137,-63,-117,-92,131,-48,-129,-133,-39,55,-1,56,-94,-20,-184,-88,-62,88,101,-90,-38,-40,-58,-108,-136
+X17567_s_at,3196,5953,4518,2263,3301,3362,2280,1952,6296,3070,5086,1960,3703,2984,3697,2183,6764,1841,2010,6702,5535,2024,3473,3813,3002,2789,2048,2197,2277,4427,3303,2913,3690,3509,2591,2341,1666,4198
+X52979_rna1_s_at,1962,1932,3528,1218,2349,2407,971,887,4668,2775,3488,819,2433,2281,2683,1327,2978,1423,1105,4033,694,901,2296,1976,1601,1528,988,1190,1180,2356,1865,1728,2426,2550,1542,1212,1626,2305
+S40719_s_at,1662,1431,1954,1647,1255,1262,1566,2067,1671,1223,835,704,1307,1321,933,1951,3749,1366,1188,1895,573,1048,1101,1445,1290,1505,1761,1570,1346,2049,1468,1790,2300,604,1701,1289,1772,3113
+J04617_s_at,14391,12824,17278,15147,14101,26900,25197,21687,12006,18387,14650,21135,16203,13734,12889,15277,13409,17722,18828,9490,20459,19605,29594,15189,16096,16603,23575,15590,26633,17685,14577,16836,12912,20789,12535,20128,15004,15664
+X03689_s_at,23239,22321,24556,22891,23943,25405,23781,27237,23602,23694,24755,16265,23198,22597,21212,22534,25068,22936,20962,21770,164,21747,22177,25276,20927,13198,24798,22962,21194,23678,21916,25342,22897,18498,24419,21435,23431,24536
+J04810_s_at,-80,26,61,107,107,-21,-31,53,59,19,26,43,-11,82,94,-2,-42,-8,13,4,-1,-57,-51,110,-9,22,65,40,-67,-55,73,113,-29,106,59,-20,-4,-153
+J05016_rna1_s_at,187,80,135,132,158,113,84,226,171,64,93,18,319,131,156,136,289,71,281,800,123,94,45,267,77,285,18,157,240,100,357,376,77,527,59,45,167,306
+J05036_s_at,58,146,198,70,72,113,53,119,266,137,81,63,80,148,78,91,245,110,3,134,84,137,37,52,150,65,219,46,211,124,140,721,119,211,127,73,102,215
+J05200_rna1_s_at,-202,-191,-149,-117,-83,-3,-58,-92,-89,-21,-162,-106,-116,-85,-149,-148,-375,-99,-136,-40,-169,-158,-30,-215,-144,-11,-40,-266,-163,-142,-159,-272,-162,-79,-271,-211,-224,-275
+J05252_s_at,68,-107,-66,22,-25,56,68,218,-184,-171,-78,-122,-106,-160,-86,-68,-53,-84,-49,53,36,0,-93,-64,-204,-89,-39,-146,96,-131,-171,-90,-154,-54,-240,20,-156,-189
+J05582_s_at,-131,-158,403,511,-37,135,186,221,352,196,132,191,-85,65,34,57,390,141,60,314,-67,-41,-112,121,-3,-96,-497,28,12,452,422,317,8,122,344,269,194,470
+M32304_s_at,398,908,906,763,201,620,672,1478,1184,1142,615,889,875,453,751,192,852,59,520,524,884,741,351,712,272,278,388,1118,1108,2892,1271,1887,626,717,2450,1636,1206,1835
+X53002_s_at,191,210,384,239,64,60,171,-19,242,177,-61,64,55,141,116,249,321,43,24,125,-63,129,93,42,175,66,32,-1,91,1,-8,-52,272,111,119,159,201,370
+M34996_s_at,5357,829,203,440,1029,574,450,956,463,264,76,268,3067,340,2848,488,288,6627,2728,10646,740,4592,79,656,849,2669,527,159,1555,280,802,67,492,289,1337,245,1142,2480
+K01160_s_at,81,-3,-35,42,16,-53,31,205,39,72,-33,41,0,72,203,1,115,2123,581,34,26,31,37,9,51,10,56,-20,-36,0,97,39,9,-19,104,58,670,39
+S77835_s_at,-193,-55,-272,-124,-67,17,-60,-106,-197,-41,-136,-28,-64,-76,-86,-107,-99,-60,-100,-44,-77,-141,-87,-100,-84,-97,9,-209,-139,-212,-201,-43,-141,-114,10,-74,-76,-210
+X00695_s_at,102,44,15,70,11,94,126,44,83,64,-18,132,-24,71,15,132,115,55,30,-1,41,1,3,34,27,56,190,-16,-9,19,96,96,-26,30,119,151,137,12
+X02176_s_at,-40,-28,-55,30,39,21,331,1,62,51,61,18,-16,73,123,94,-47,73,-29,198,38,-34,-47,13,-73,36,204,-109,117,39,170,135,8,133,41,198,-43,403
+K02777_s_at,285,310,58,833,393,293,248,388,1367,411,749,564,66,903,732,1056,129,321,509,82,202,258,305,203,-13,41,311,-135,182,-71,181,-180,177,139,-23,313,176,362
+M13058_s_at,360,132,468,341,178,320,216,71,320,190,177,201,153,225,154,272,247,98,235,194,216,168,281,215,134,202,352,312,257,457,205,238,318,293,144,278,344,344
+M69197_xpt2_s_at,113,249,35,86,98,-40,77,-82,-72,246,110,86,101,1,65,229,73,-30,204,367,78,31,-83,-30,110,238,-54,-110,-40,537,135,350,208,89,177,-98,22,393
+K03494_s_at,-1301,-880,-1610,-594,-490,-949,-1129,-1742,-1086,-595,-757,-373,-373,-856,-452,-679,-2131,-798,-797,-806,-480,-931,-649,-978,-1157,-693,-1469,-1069,-654,-990,-937,-945,-1355,-267,-514,-592,-622,-1437
+K03498_xpt1_s_at,469,285,58,588,324,200,324,328,322,160,293,191,283,479,234,196,292,267,303,301,229,349,469,476,234,388,-10,342,351,523,364,415,454,285,329,418,508,368
+M26901_s_at,258,40,-164,110,99,94,-154,-428,-241,136,55,-284,92,-33,-64,301,126,140,133,82,-26,-198,-284,-177,-270,151,117,298,-93,11,198,74,-104,-35,53,-207,277,-78
+M21642_at,-75,44,92,1,4,39,-63,-98,65,37,-19,-57,17,-33,6,-28,100,-48,-32,-85,54,-20,-39,152,38,13,-100,-117,-14,-63,-9,-9,23,-29,39,3,-2,117
+M21642_s_at,60,75,36,4,21,12,50,46,138,77,13,-15,50,131,6,-27,62,26,-15,39,153,-35,115,0,5,34,32,23,52,14,1,32,17,19,86,60,36,1
+X69920_s_at,206,227,302,249,178,138,273,308,345,178,234,136,110,241,146,199,377,124,74,198,267,96,129,201,222,268,297,206,266,303,211,184,196,46,253,158,311,152
+L00634_s_at,310,324,200,459,473,140,300,101,354,48,207,8,272,253,346,211,628,98,181,699,42,31,138,637,132,34,175,24,-55,70,62,63,113,9,229,64,210,100
+X66113_s_at,344,329,274,395,380,405,134,307,473,128,368,63,311,361,273,491,504,241,368,506,436,218,273,411,126,320,337,406,346,277,401,435,62,237,243,189,260,140
+L03411_s_at,-59,12,-122,-296,347,-142,-356,76,187,322,3,76,428,-25,198,344,-236,45,361,607,805,-2,9,258,55,362,32,69,40,-59,53,47,5,153,-108,-194,-78,-321
+L03840_s_at,139,297,-174,-192,224,-277,-608,-650,-257,-103,-9,-178,205,-257,298,525,-1349,136,-134,40,-144,18,-174,277,202,113,-611,147,-288,-333,-928,-241,-177,-201,-292,-219,-490,-408
+U09851_s_at,220,222,255,378,223,140,144,349,244,141,127,34,228,309,209,428,520,336,62,1081,197,146,58,263,-2,394,186,151,201,-7,52,-113,82,165,101,44,438,281
+L04483_s_at,20649,19962,22202,20642,21232,26448,22112,23194,19294,21146,22024,23781,19472,20239,17990,22371,21115,20452,22088,14410,25785,21311,28357,21394,22954,20441,23124,21022,25664,21806,20561,23794,20607,25319,18208,22697,21604,22130
+L05072_s_at,1125,649,1033,995,991,661,863,626,844,628,348,803,591,742,2344,816,1024,105,765,704,74,625,524,820,2129,459,394,500,153,2262,1349,1342,2316,187,962,890,741,1105
+L12760_s_at,44,48,-46,-31,48,48,-36,124,111,59,41,17,92,78,19,74,13,95,23,116,-56,83,51,41,21,48,42,-41,55,9,5,89,90,5,57,49,72,162
+M26665_at,-7,-31,-28,31,-17,-48,16,-34,-55,-8,-37,34,20,50,15,49,16,-28,-9,29,23,60,55,26,8,23,45,60,-31,-34,8,-17,-12,-59,-47,-73,-8,86
+M26665_s_at,455,104,631,330,295,392,665,407,472,264,235,140,149,255,148,179,487,267,143,90,58,-23,184,163,212,101,474,54,432,240,431,489,264,25,260,273,660,495
+L05624_s_at,-98,-96,206,664,333,16,156,-88,129,4,93,-339,-46,125,142,172,118,86,57,78,-8,151,201,59,-153,9,-655,-620,-545,222,289,253,361,-57,127,-91,165,283
+L05628_s_at,156,372,-721,-55,41,156,-255,155,-874,-574,-270,-191,89,241,-81,149,-497,33,165,103,-34,-51,36,-513,195,44,-289,-335,-829,210,-44,-598,360,-5,13,359,-778,-875
+Z94753_s_at,168,70,141,102,123,152,82,209,74,12,54,60,131,125,70,112,275,99,119,182,61,60,58,92,119,44,145,52,209,16,113,124,201,-18,128,90,192,189
+U50360_s_at,2,151,-5,-51,-45,184,-21,-38,60,-41,51,33,-15,7,12,13,98,-55,-109,151,28,-6,-113,-25,88,-45,-40,-72,199,-118,-88,-35,60,-53,-30,112,217,-103
+Z31560_s_at,381,205,245,247,212,183,300,142,215,212,175,150,148,228,369,289,453,199,145,295,341,153,237,491,190,395,409,321,307,464,208,505,284,183,262,180,426,624
+M88461_s_at,21,59,13,471,12,341,159,62,-44,33,114,76,-56,0,475,142,236,59,-75,-39,229,122,307,103,110,59,-134,122,312,-13,113,17,79,233,96,134,242,81
+U06643_s_at,-62,-473,-282,-350,-129,-304,-320,-425,-587,-207,25,-265,8,-81,-222,49,-966,-42,-191,-158,-123,-107,-178,-250,-221,-245,-488,-427,-396,-170,-196,-500,-85,-243,-548,-528,-131,-109
+U51003_s_at,-814,-490,-571,-541,-359,-453,-500,-1331,-1044,-323,-663,-231,-414,-899,-444,-392,-1279,-524,-312,-756,-177,-298,-303,-233,-737,-458,-849,-308,428,-1164,-695,-824,-785,-547,-1027,-351,-667,-466
+L08044_s_at,-128,258,399,345,188,270,203,-34,149,210,221,-1,46,118,240,176,82,33,174,215,-126,-39,96,-32,-26,67,255,126,209,365,395,-26,26,229,-135,277,64,-327
+S57212_s_at,3198,392,946,2266,953,586,1082,1262,929,442,616,681,1356,359,2457,1104,1659,1153,992,821,197,1408,541,1650,942,1381,890,746,666,887,591,526,760,368,546,500,1636,1191
+L09209_s_at,1284,540,236,786,968,368,344,-196,310,260,210,146,825,513,440,94,3755,173,265,897,347,258,311,593,104,741,-15,1192,1243,5814,2930,1060,1355,2219,4607,1017,2212,4198
+L10333_s_at,192,110,228,181,97,165,210,287,333,109,158,126,123,159,161,170,440,115,163,150,61,196,159,104,248,101,100,137,141,47,131,188,133,77,210,160,181,303
+L10338_s_at,715,484,899,883,460,554,742,919,678,367,454,662,827,649,478,731,822,331,565,456,434,810,552,675,794,612,671,783,786,527,454,627,648,277,546,427,628,786
+X70940_s_at,1480,1098,1717,172,158,716,991,1124,1381,878,355,242,605,432,488,623,2035,296,2,490,-219,700,199,371,229,282,1840,215,-141,1420,832,-357,-304,234,1767,538,688,1717
+M30607_s_at,56,119,-3,327,12,42,-43,-62,54,44,63,21,59,-50,0,-133,49,-8,97,48,58,-14,106,206,-8,-78,3,34,33,297,56,228,-20,38,23,34,174,26
+X13766_s_at,-98,-508,-646,-301,-286,-128,-201,-386,-657,137,-224,-265,-159,-468,-388,-575,-837,-74,-308,-164,-2,-194,-661,-46,-540,-52,-995,-496,-375,71,-700,-143,-677,-41,-437,-209,-325,-867
+L10615_s_at,2033,887,1936,1850,1009,1372,1814,1418,1443,1125,1356,918,958,1026,977,1417,1983,995,1067,1339,502,920,1352,1183,982,1008,2096,1915,1575,2062,1522,1329,1697,747,1622,1710,1937,1260
+L10955_cds1_s_at,-170,20,-159,-511,-5,-160,-509,-125,-357,-84,-118,-165,-105,-5,-49,-138,45,-65,-3,-149,-222,103,66,-90,35,-12,-610,-234,-262,44,-23,145,189,-58,-12,-253,-295,219
+U89922_s_at,10628,5003,2689,-724,-4,1264,-1204,-1054,8979,484,1879,208,323,6109,1469,997,3471,353,447,21,-194,-279,161,-790,801,10253,-1092,-580,-1026,-1395,-923,-633,-379,-555,-767,112,966,-1105
+L15189_s_at,562,548,546,346,559,311,362,365,765,474,1054,307,431,634,581,506,651,304,671,624,402,345,547,549,426,367,513,755,413,631,763,585,1004,535,663,457,405,851
+L11238_s_at,106,64,76,23,95,26,65,140,141,73,-11,2,24,85,50,44,216,110,28,109,39,171,104,66,56,65,186,42,38,22,28,51,82,-34,82,22,79,96
+L11244_s_at,16,-230,-184,-242,-91,-154,-203,-338,-185,-170,-110,-99,-111,-84,-29,-105,-446,-95,-129,-160,-94,-77,-151,-68,-55,-135,-456,-238,-278,-226,-228,-51,-224,-138,-321,-188,-227,-264
+L11701_s_at,187,72,109,-9,123,92,193,215,-11,111,156,15,197,158,15,59,471,117,40,112,103,-34,248,236,240,135,-70,232,276,22,65,184,138,-9,198,107,126,51
+U40002_s_at,-1274,-1165,-1576,-1259,-1116,-1335,-1655,-2286,-1533,-1036,-977,-1039,-1165,-1287,-1414,-1211,-2018,-928,-1189,-993,-266,-1493,-1160,-1521,-898,-1102,-1331,-1568,-1281,-2025,-1873,-1533,-1176,-805,-1675,-1349,-1550,-3369
+U37055_rna1_s_at,94,-130,118,-7,28,-208,-52,-178,82,205,-121,68,80,89,132,209,337,-99,-134,351,-207,-134,-429,-164,147,173,92,-301,-745,-456,-449,-472,-285,-343,-383,-232,13,100
+U67932_s_at,213,382,476,153,285,368,194,200,158,129,78,22,150,295,297,31,592,262,117,92,-1,48,121,217,59,62,256,109,192,137,65,193,92,39,202,214,268,416
+L12060_s_at,119,78,27,-138,56,49,174,-188,-131,242,41,89,144,136,39,126,188,174,-12,114,64,92,146,72,146,135,265,161,48,208,17,312,212,10,155,71,132,202
+L12711_s_at,1893,2157,1321,964,2281,1509,325,1179,3426,3245,3306,1464,1275,1838,1397,2746,3453,1524,2332,6472,-128,878,759,1905,1014,3287,863,920,805,5967,1811,1051,2241,2541,4895,1972,2717,3372
+U03397_s_at,105,137,200,116,130,192,210,176,241,64,5,45,116,313,161,177,248,142,58,140,133,126,87,227,198,74,78,174,50,267,526,171,211,46,108,64,106,119
+X65727_cds2_s_at,41,129,222,-12,50,252,97,-124,116,60,126,126,-4,181,40,32,161,-26,-13,16,-57,90,20,-75,97,32,168,-74,-110,-11,263,129,136,38,191,23,158,182
+L13939_s_at,1869,1225,1357,894,1115,1216,1544,2917,1434,756,985,1618,1360,1554,1565,1126,2254,763,2654,6559,344,1373,412,1207,1778,1950,935,885,574,2431,2350,1464,1702,614,1815,1413,2371,2593
+X68285_s_at,-85,3,-74,-112,-23,-33,-149,0,-81,-73,-13,-27,-39,-39,-15,-62,-63,-48,-48,-39,51,-73,-49,-84,-54,-33,-53,-72,-43,-55,-22,-99,-73,-1,-58,-28,-154,15
+X69886_s_at,-76,-88,-187,-268,-11,-17,-203,-301,-226,-101,-48,-125,60,-102,0,-35,-1,58,-1,13,-77,-62,-178,-54,-49,29,-259,-40,-206,-63,-209,-81,-24,-26,-120,-86,-136,41
+L14848_s_at,-13,0,-147,-134,105,-62,60,-155,-219,97,61,-142,40,-2,139,-11,-236,-128,-107,-160,103,-48,89,33,-6,-43,-280,-122,-144,-324,-384,-116,-191,-47,-248,-295,-161,-451
+L15296_s_at,-58,209,-138,147,37,215,144,112,-148,-54,83,86,-92,211,182,6,362,-19,16,12,18,-74,121,-157,5,-158,309,125,76,-39,171,-90,219,-165,274,187,55,-42
+U58837_s_at,-198,-189,-37,-23,-77,-126,-235,-148,-131,-102,-69,-109,17,45,-80,-116,-193,46,-16,44,33,19,-256,145,-24,8,-248,32,-134,-149,24,-89,-119,-83,-167,-51,1,-145
+X67235_s_at,771,315,71,231,414,10,208,296,-28,43,-6,160,485,151,767,410,1362,211,225,2283,236,252,43,507,1326,791,176,570,358,309,231,389,318,547,240,245,367,299
+L17075_s_at,-74,57,34,-28,-20,-58,-94,-115,-70,-74,-49,-156,4,-63,-36,-163,27,-45,-18,105,-1,26,-9,-27,5,-13,159,34,26,-87,-20,95,-36,74,-33,-74,-75,113
+L17418_cds2_s_at,-170,-12,95,-45,-2,40,-21,-176,-68,-111,-13,25,-80,18,74,-64,-17,-84,-58,-119,-193,14,-98,-10,-49,-84,-140,-10,45,-63,-71,21,-27,-103,-14,1,-25,-38
+U33838_at,-1,47,-10,23,0,-5,38,-125,119,3,-110,80,8,87,-36,-17,-57,-14,68,42,71,238,-7,-27,-98,17,-15,14,96,-46,89,9,-31,-13,29,-36,111,76
+U33838_s_at,312,239,133,270,420,149,119,32,293,76,314,173,368,201,518,121,411,210,185,432,188,334,106,334,59,242,150,367,88,240,432,509,528,249,277,258,495,645
+Z22951_rna1_s_at,1074,1332,1139,1842,640,586,892,1073,1086,437,794,698,1340,762,1285,1212,1958,948,729,1676,343,1094,552,1135,1295,919,981,732,553,1872,1536,1363,1739,675,1365,672,1842,2543
+U23430_s_at,259,242,184,274,174,-26,52,-109,228,55,212,80,272,187,261,281,428,143,254,493,540,139,364,303,246,390,162,380,7,264,121,318,318,50,214,176,385,327
+M67468_s_at,145,72,70,-42,169,-62,68,-28,9,89,43,-63,506,91,185,-118,301,39,77,326,154,52,51,160,7,53,-21,87,12,40,154,33,-12,-7,59,-64,-34,74
+L19493_s_at,639,409,570,407,238,327,430,304,446,266,249,182,494,356,470,521,1001,249,333,775,327,160,385,259,222,165,453,407,298,394,357,352,302,195,326,232,374,566
+U11875_s_at,310,140,110,140,165,85,97,152,159,120,73,146,170,174,188,128,614,235,63,113,64,188,254,224,311,217,283,334,228,117,241,119,204,58,293,175,224,300
+X64624_s_at,730,131,91,49,0,103,57,683,225,48,78,28,1542,65,-31,-17,260,149,1253,347,102,24,70,26,141,1072,328,17,894,14,31,82,82,-71,82,61,-20,26
+L20469_s_at,96,-287,46,10,-131,-192,-218,-362,17,91,-248,-79,-4,-194,-148,195,19,-54,-134,-3,36,-18,-260,-131,83,41,-197,260,165,7,-222,-230,177,182,-324,-141,-285,36
+U59632_s_at,293,381,372,244,406,24,134,53,263,241,315,140,233,321,390,527,660,276,199,475,87,172,303,416,392,338,228,824,370,361,556,652,578,301,454,215,344,322
+S75213_s_at,946,956,1482,1049,667,1068,910,1439,1350,619,900,758,621,725,460,771,1303,663,528,588,635,872,951,920,1088,804,1148,1216,858,1395,1470,1181,1287,640,1179,1101,1043,1874
+U18088_s_at,-127,-66,-106,-188,-55,-78,-231,-214,-176,-95,-63,-70,-119,-150,-53,-134,-339,-67,-130,-190,-51,-99,53,-117,14,-102,-424,-106,-218,-91,-38,-47,-108,-23,-95,-272,-196,-71
+X63575_s_at,82,28,27,28,45,131,52,22,128,67,5,63,75,50,20,90,302,47,64,57,87,34,26,-10,26,81,71,133,84,46,39,128,82,53,64,1,83,134
+U24389_s_at,-146,-153,131,-93,-89,60,72,76,-182,-56,-44,70,-29,-12,-118,-34,-32,13,53,30,-97,75,131,-130,55,-54,-92,-96,-62,-15,-77,12,-36,65,136,-193,24,-3
+U02683_s_at,112,126,-7,-34,101,-32,53,-7,142,68,133,12,133,37,131,86,40,83,-92,-26,14,68,22,76,190,89,179,170,105,196,180,-57,207,69,-14,9,91,414
+U18383_s_at,-95,-80,-123,-118,-10,-92,-137,-134,-10,-160,109,-116,15,-81,41,-102,-178,-70,-101,27,-37,-19,-45,33,-83,-72,-98,-88,-185,-123,-28,-93,-101,10,-78,-74,-179,-174
+L22524_s_at,-59,21,90,28,50,-14,84,-49,61,90,24,22,16,22,37,17,89,34,19,61,44,1,-15,8,18,61,9,90,52,-23,-10,82,88,81,50,18,-26,17
+L23333_s_at,776,837,645,322,767,131,1063,428,1724,417,1085,411,692,1490,511,435,639,745,1141,494,-261,499,630,944,830,662,167,724,1146,1491,548,1760,1135,267,912,593,797,1347
+M27394_s_at,245,-23,-180,-196,-60,-108,-11,-119,-60,-33,-52,-109,104,-119,115,2309,47,1326,3349,-76,-39,-61,-41,-107,13,451,-46,-100,-153,-134,-148,-79,-70,5,26,-102,-220,18
+M60974_s_at,441,1161,203,220,209,264,141,487,585,300,348,169,103,320,246,197,504,179,669,1837,757,283,174,116,327,482,168,213,334,352,1285,1008,1240,396,344,401,263,801
+L24774_s_at,242,234,327,441,415,257,564,-7,337,282,285,40,212,210,784,108,337,514,294,220,494,23,296,-60,88,219,233,62,161,458,408,361,589,202,381,504,654,353
+L25286_s_at,38,6,26,56,1,14,16,76,-9,44,-10,50,-10,-1,10,5,87,39,23,7,67,32,-24,-16,38,26,70,-14,-28,-14,39,57,0,-47,16,-64,22,28
+M89470_s_at,295,-105,323,218,130,188,68,263,157,-30,83,97,17,117,-338,158,195,-237,202,-155,247,241,94,200,235,67,-14,385,322,311,19,141,237,59,104,58,131,90
+U45255_s_at,-127,-392,-245,-172,-117,-135,-144,-361,5,-143,-148,-182,-203,-283,-337,-314,-357,-55,-73,-343,-272,-211,-433,-284,-154,-133,-567,-217,-283,-507,-441,-350,-240,-227,-434,-166,-144,-235
+L25931_s_at,1005,535,881,822,581,449,699,853,1563,549,1040,135,1697,1357,960,1028,3508,553,860,1672,458,602,583,555,293,523,308,216,194,255,278,561,421,427,202,116,228,544
+U35005_s_at,357,303,501,400,34,179,310,467,233,173,167,136,301,229,274,131,382,231,154,365,207,404,347,163,293,197,430,301,331,287,498,527,383,198,204,270,260,399
+S69265_s_at,852,436,928,657,338,533,631,434,363,535,232,181,448,122,476,758,1616,496,352,572,242,504,351,545,400,575,796,898,567,240,535,792,775,202,339,498,703,1210
+L27213_s_at,-1256,-784,-1245,-1336,-552,-1054,-838,-1398,-1216,-525,-1063,-741,-621,-898,-852,-991,-1717,-909,-712,-704,-650,-686,-1062,-999,-499,-835,-1093,-1074,-1082,-1057,-1432,-1081,-844,-490,-1289,-711,-1459,-1215
+M62782_s_at,-524,-329,-558,-603,-146,-499,-655,-913,-645,-141,-348,-317,-74,-463,-237,-229,-553,-146,-204,-214,-191,-368,-227,-490,-255,-173,-536,-357,-358,-449,-563,-381,-367,-122,-412,-453,-416,-478
+L27559_s_at,-8,-17,-30,-18,-19,23,36,49,9,-65,20,10,16,-25,-49,-67,-86,-10,-41,-34,17,-1,7,48,24,5,37,-48,-12,-29,34,13,32,-25,-13,-66,-48,29
+L27584_s_at,-944,-728,-923,-982,-682,-921,-967,-2398,-889,-880,-881,-928,-536,-1047,-521,-778,-1888,-435,-827,-943,-503,-697,-632,-588,-867,-486,-1851,-1145,-601,-1839,-1299,-1491,-1532,-178,-1114,-1109,-1462,-2023
+X69962_s_at,110,40,50,-26,58,83,15,5,43,49,53,18,170,69,79,86,87,27,20,216,127,10,66,95,-3,55,40,117,48,-2,23,17,21,3,2,-11,4,20
+L29306_s_at,12,11,67,-8,43,32,105,74,-18,1,33,8,42,12,41,30,-36,53,37,83,16,45,9,7,55,31,61,192,4,65,58,56,27,-47,-7,20,40,12
+M96995_s_at,1187,1197,1202,1567,1271,1282,1312,1018,1589,519,1001,734,1108,1070,1914,1688,2268,1251,567,1594,503,588,718,1429,760,1124,-3,1219,1036,2494,1345,1137,1398,964,497,2086,1475,1851
+S77893_s_at,-227,-257,-205,-228,-98,-369,-80,-37,-230,114,21,-192,-2,-290,-88,-35,-375,-70,-94,154,-91,-61,-362,-258,261,4,-463,-196,521,-158,2111,1373,-193,2461,253,-207,-384,93
+L32831_s_at,1250,1261,1427,1306,435,713,1209,2473,1298,467,905,362,476,810,414,946,1755,798,1536,868,257,793,1005,679,589,981,1148,828,1945,1159,1387,1772,1473,1269,999,648,1443,1625
+S75578_s_at,434,272,485,321,126,96,507,667,479,233,360,56,101,206,215,234,418,206,181,167,281,40,417,406,390,300,424,406,377,456,93,523,356,-81,282,71,382,511
+U80226_s_at,571,227,417,563,147,330,752,559,662,484,128,296,144,235,135,243,470,239,167,140,198,413,414,270,257,220,491,404,533,743,632,414,309,165,304,493,434,841
+L33262_s_at,-169,-46,-36,-86,41,-108,-65,-139,-136,1,-37,-37,-64,-24,16,-10,38,-41,-60,44,-72,-52,-127,-53,1,-111,-64,-48,-52,-63,-95,-51,-65,-41,-41,-53,-18,-195
+L34363_s_at,9,-6,-167,-39,0,-74,-63,-176,-72,-53,-61,-41,-89,-39,-68,-70,-63,-83,-15,-34,-53,-56,-79,-38,-14,-78,-95,-46,-100,-100,-1,-116,-68,-65,-43,6,-44,-138
+L35249_s_at,295,320,440,187,471,124,297,137,726,225,497,79,248,602,353,278,1368,251,190,696,143,270,256,510,145,148,159,355,139,699,1021,982,417,183,848,236,285,1072
+L35253_s_at,300,86,98,189,204,464,379,254,324,60,111,247,14,189,144,90,172,109,45,117,-83,170,170,231,75,69,23,196,216,322,358,228,181,111,22,197,127,221
+L46720_s_at,563,203,469,424,201,286,430,451,420,129,321,169,293,241,155,221,430,42,171,233,144,158,400,197,287,438,433,372,283,148,432,333,305,1,743,281,444,123
+U19495_s_at,48,-25,-68,-11,34,26,8,16,39,18,5,14,-12,-7,19,-1,31,9,18,22,4,-27,58,-5,18,-10,-9,53,52,28,65,3,99,-5,110,44,-8,38
+X95097_rna1_s_at,83,64,238,2,148,184,-26,-173,68,340,133,-64,50,20,163,313,316,70,107,318,-147,256,313,39,162,114,652,64,125,134,34,-47,115,227,141,-56,124,172
+X95425_s_at,-80,-87,-58,-108,-66,-35,-85,-46,-92,-62,-31,-68,-26,-33,-41,-31,-134,-85,-68,-74,-37,-68,-117,-70,-69,-54,-54,-79,-36,-101,-77,3,-81,3,-98,-60,-52,-86
+U17743_s_at,132,83,130,56,78,122,97,137,109,-7,99,12,64,145,181,133,77,156,72,140,82,87,-15,69,65,52,17,83,62,75,155,99,21,66,79,-22,198,232
+L37036_s_at,167,65,180,247,102,156,-6,259,82,35,80,86,162,145,160,63,224,112,146,136,42,99,85,225,107,120,150,120,110,64,194,150,84,90,90,133,139,334
+X94628_rna1_s_at,-304,-494,-360,-639,-75,-302,-399,-457,-447,-352,-262,-201,-123,-95,-169,-225,-837,-309,-196,-354,-76,-210,-24,-399,-240,-272,-328,-317,-360,-59,-97,-226,-401,-138,-434,-385,-299,-223
+L37360_s_at,442,569,461,686,97,510,709,446,465,-173,323,326,273,143,435,111,-57,91,-57,109,109,659,469,375,89,280,409,138,153,664,516,72,193,-106,342,385,306,131
+M34458_rna1_s_at,329,106,360,534,537,325,314,80,755,271,296,48,792,371,919,255,671,214,383,660,143,69,338,596,176,181,220,103,129,200,229,75,176,177,110,113,37,321
+L37868_s_at,-302,-305,-241,-412,-174,-222,-401,-554,-539,309,-190,-198,-136,-353,-170,-136,-194,182,-206,-148,-67,-347,-433,-149,502,-193,311,-235,-317,-328,-993,93,-320,-175,164,-255,-224,-257
+L38490_s_at,537,520,607,577,358,654,588,1217,606,346,337,327,203,305,380,356,1279,275,196,859,399,576,450,575,407,449,519,564,408,820,561,656,611,66,657,517,511,694
+U15637_s_at,582,504,752,500,407,805,631,802,842,396,360,314,357,531,412,521,1258,787,447,646,336,622,509,448,526,407,589,383,274,930,436,742,730,263,473,570,497,1084
+U32986_s_at,1389,586,1406,1271,961,1417,1162,1500,2574,886,1822,204,1516,1336,1539,1315,3088,818,1004,2884,441,806,1278,1506,753,1095,929,965,1175,1149,1293,1482,1136,849,317,623,1133,1011
+L40384_s_at,-205,-204,-187,-262,-50,-227,-179,-223,-202,-93,-109,-264,-134,-91,-68,-199,-340,-214,-172,-195,-77,-177,-292,-201,-138,-160,-325,-192,-257,-244,-263,-275,-179,-131,-145,-167,-320,-241
+L40386_s_at,-59,1342,1677,-31,110,1749,-156,-239,771,573,323,-14,-220,-63,-11,148,278,209,-33,144,208,51,3292,-41,145,9,-364,23,-24,-142,586,1131,294,1000,-18,196,175,169
+U61734_s_at,671,1041,1305,379,785,1031,542,761,1692,859,1932,353,528,519,901,716,1871,292,415,782,178,485,961,736,533,346,456,481,514,1911,1478,949,1087,1433,1899,1141,1465,1825
+U43185_s_at,398,594,2592,424,287,1184,267,481,1813,717,1093,278,501,2654,815,725,2496,722,652,903,412,294,338,468,887,1077,-67,1376,858,1025,589,1055,1731,1249,308,425,924,1021
+M97347_s_at,-4,87,88,33,118,-14,45,100,86,28,23,15,30,-6,245,21,394,4,16,721,123,6,-62,39,44,12,43,-57,-26,31,-26,-37,-16,123,179,9,8,40
+L49209_s_at,175,76,250,221,227,165,117,163,197,37,88,37,139,58,180,36,267,89,41,188,9,75,28,167,100,93,61,64,100,14,71,21,105,67,61,81,180,61
+L42374_s_at,212,271,506,-8,256,-78,-289,446,-98,150,87,-96,24,-81,482,227,1,201,169,343,-177,-52,132,-21,107,198,317,445,201,189,82,437,-29,245,-109,-151,188,638
+L43575_s_at,615,549,431,255,374,245,322,487,356,213,320,163,374,447,486,271,580,399,213,629,22,238,281,419,344,408,327,407,391,443,384,784,610,307,419,146,409,580
+L43579_at,313,242,257,214,243,28,250,362,483,93,187,45,264,243,245,92,402,229,92,191,69,209,98,268,80,282,197,187,175,247,190,294,242,129,255,98,177,298
+L43579_s_at,932,710,488,346,428,476,892,779,432,516,537,303,553,479,573,489,869,451,226,607,53,465,389,400,397,305,456,651,642,939,869,957,881,512,1015,349,786,1245
+L44140_cds4_s_at,-3,-342,-244,-320,-14,-51,-20,-331,-327,-132,-126,-189,34,-136,71,-35,-709,-2,23,-259,118,-138,-34,56,-326,25,-475,284,764,304,-256,-329,-404,-30,-456,-122,-88,-555
+U28749_s_at,27,24,79,34,243,33,62,62,57,4,19,53,12,91,25,1,87,39,1,-12,-7,22,108,104,9,-11,62,-88,-55,28,-18,31,47,-2,-9,-6,124,-60
+X92518_s_at,1204,1013,1629,1211,705,1061,1406,1446,1235,838,957,724,729,899,742,851,1595,707,825,980,652,976,830,887,791,857,1458,1158,1094,1158,1051,1136,923,490,970,961,1416,1485
+L47125_s_at,175,106,68,-39,79,0,-16,-82,39,12,-11,232,176,-71,-166,139,161,27,159,149,-14,-91,-43,-182,16,129,314,-148,-33,209,-66,228,174,29,159,-22,-51,-133
+Z37987_s_at,-43,0,155,-12,-10,106,-68,-52,226,10,86,-53,25,25,74,-24,50,0,-4,-17,-7,-26,-1,92,-31,-30,-46,44,16,16,-19,-8,85,-27,38,0,-1,-36
+L47276_s_at,740,69,626,784,679,652,572,127,906,258,423,-35,1944,761,886,299,911,814,244,435,192,73,708,466,111,93,397,110,187,609,330,583,478,170,-4,215,2,209
+Y08765_s_at,571,1131,784,873,546,846,699,1070,629,537,1724,356,473,1044,705,550,919,328,477,722,33,749,775,661,568,342,503,1643,317,1100,764,991,1286,491,1037,664,1758,1078
+Y08766_s_at,290,972,937,560,423,769,1008,790,519,529,1258,655,911,770,956,508,1057,109,361,594,17,1027,872,941,502,376,64,1282,230,951,691,1194,996,651,400,575,1642,820
+U37546_s_at,-51,79,57,49,23,-88,-10,13,63,15,32,-44,16,209,53,-12,12,478,-4,-1,3,-27,-47,-38,-3,13,104,32,-7,215,80,-6,40,34,61,-35,8,27
+U45878_s_at,672,700,1108,812,476,730,885,443,540,777,781,541,566,804,865,513,642,1207,400,612,920,453,853,1072,715,789,472,1196,822,790,698,685,327,275,407,447,798,574
+L76528_s_at,-285,60,-749,40,-228,-80,33,-278,-462,-194,-660,-96,-189,-349,51,-66,-231,-480,-147,-259,-272,-32,-83,-443,-276,-349,-542,-405,-341,-656,-432,-365,-517,-73,124,-96,-184,-726
+U48436_s_at,24,32,-63,-59,23,-58,-47,-134,39,21,-26,45,-32,49,27,-85,245,29,4,37,23,-11,77,76,-15,-21,-4,-80,-60,-76,26,99,37,15,11,-37,15,19
+X95463_s_at,-173,-87,-301,-687,-42,-188,-388,-643,-71,-140,-261,-270,-140,16,-236,-321,-413,-274,-172,-229,-374,-302,-440,-395,-10,-75,-391,-559,-680,-177,-149,-8,-305,-384,-226,-354,-385,-440
+U31215_s_at,-82,-171,2,-181,-81,-99,-63,-175,1,-14,-154,-87,-30,-59,-105,-75,-287,-157,-74,-32,-181,-224,-75,-158,-187,-99,-178,-35,-149,-282,-154,-16,-135,-113,-196,22,-123,-242
+U31216_s_at,-157,-320,-461,-417,-129,-389,-373,-751,-338,-216,-230,-136,-218,-238,-166,-242,-691,-200,-126,-294,-99,-406,-417,-241,-150,-209,-772,-287,-327,-304,-529,-127,-391,-97,-499,-410,-376,-536
+L77567_s_at,-346,-670,-873,-396,-318,-229,-593,-347,-444,-175,-193,-247,-112,-558,-359,-375,-1454,-286,-330,-62,-334,-383,-402,-651,-462,-237,-913,-353,-408,-202,-611,-1080,-786,-86,-491,-136,-657,-951
+U64315_s_at,636,296,773,452,239,505,672,770,757,370,482,199,305,190,195,456,825,396,284,220,176,302,566,276,363,370,754,501,432,384,416,425,240,319,327,387,638,649
+U64805_s_at,23,60,22,215,88,32,253,199,50,-21,-27,50,60,39,72,-23,52,3,-2,41,97,31,62,-64,101,48,71,-73,153,-103,114,52,63,42,163,94,-2,218
+U72882_s_at,364,171,305,127,228,-46,169,-155,128,80,-9,-2,228,333,362,195,-22,121,174,570,-44,30,18,313,300,474,-20,148,50,311,79,132,146,13,116,69,145,33
+V00565_s_at,-141,-86,-310,14,-218,19,-262,-139,29,44,12,-27,-25,-89,-220,-235,126,-30,-139,-326,53,-270,155,-228,-157,-63,-247,-162,-197,-198,-421,-577,-434,-178,-34,-53,-419,-404
+M10051_s_at,10,-25,7,109,22,92,260,28,273,74,43,38,-16,-29,390,158,304,62,260,12,74,57,-81,17,70,62,228,182,-76,235,51,132,172,25,-70,104,122,258
+M10321_s_at,-141,-110,49,-175,-238,-128,-63,-176,-111,-62,53,-280,-187,-103,-110,-124,-235,-65,-156,-101,-41,-48,-41,-166,-119,-221,-12,-67,62,-135,-20,10,-121,95,-270,-43,-15,-106
+M11025_s_at,204,155,189,130,60,33,231,112,365,144,35,-21,122,188,125,188,293,111,130,65,13,27,157,158,94,179,233,265,168,337,3,102,209,79,272,143,70,186
+X62891_s_at,-804,6747,-1303,-844,-576,-839,-136,-1397,-1379,-246,-444,-767,-311,-593,-343,-565,-1223,-454,-808,-672,-527,-513,-872,-545,-742,-484,-896,-1003,-767,-884,-884,-1031,-891,-322,-845,-762,-985,-896
+M11313_s_at,184,4,274,144,25,168,20,194,91,19,23,-64,56,108,14,-56,204,15,55,82,116,85,7,218,-31,165,31,41,9,299,129,-41,-2,9,266,105,30,97
+X05855_at,-2735,-3177,-2399,-2993,-1429,-2297,-3313,-3487,-3028,-2289,-1591,-1644,-1588,-2131,-1597,-1933,-6464,-2208,-2127,-3670,-465,-1837,-2317,-1453,-2510,-1616,-5155,-2720,-1914,-2733,-3834,-3675,-3444,-1374,-4329,-2583,-3775,-5073
+X05855_s_at,2583,2590,3008,1991,2527,1541,1465,2812,2953,948,3158,931,2014,2853,2826,2787,6403,643,1284,7729,2158,1170,1388,3235,1241,1198,1472,1667,1094,1835,1139,1220,2062,1573,1455,1045,2236,1462
+X07438_s_at,245,80,263,37,129,120,184,236,200,120,73,91,256,144,59,122,578,264,62,418,33,145,22,271,155,165,118,330,117,497,229,268,512,102,527,189,465,913
+X03363_s_at,-135,-3,163,83,129,195,282,109,229,0,36,-18,-173,126,-89,409,-77,48,310,-171,72,-120,125,46,52,18,-20,-31,4,-35,-190,-153,-182,-9,-32,65,-18,32
+X02875_s_at,266,171,378,201,139,231,467,68,262,183,229,156,194,321,154,171,207,362,-69,742,198,-45,222,138,578,182,250,260,319,535,-52,-86,-17,-14,195,226,296,941
+M12963_s_at,59,-161,-270,-231,-71,-277,-63,-311,-122,-65,-138,-93,414,-199,-34,4,367,300,298,303,77,-48,-96,-33,-49,-127,-35,-108,-209,34,-288,-225,29,-10,270,-158,-112,-116
+X83705_s_at,753,810,1005,864,265,766,682,1055,900,333,631,507,542,639,612,678,624,238,581,391,389,608,744,656,681,608,439,869,723,646,956,860,726,446,777,854,967,643
+M12959_s_at,1372,1585,747,2358,1985,887,478,1061,5668,1763,2685,1638,822,4194,3420,7430,1300,1331,2022,1409,928,464,1320,2071,339,1444,898,819,399,645,556,653,569,241,600,286,737,565
+M13560_s_at,15446,6169,-662,11734,9260,1106,8433,11169,437,1671,-321,8832,16757,2992,14404,9567,4144,16550,18100,16217,6256,13627,-1,10989,13136,14115,7640,6694,12013,16580,13065,488,11858,6918,15856,16264,12220,13854
+M13690_s_at,313,276,112,244,93,245,411,601,-160,118,99,227,121,28,61,173,261,147,156,607,143,-189,210,214,453,140,452,1134,389,293,378,392,1162,171,428,344,1084,564
+M13686_s_at,250,128,193,448,96,202,488,151,248,149,128,148,138,116,269,171,199,273,57,290,0,108,113,81,105,246,294,270,139,154,340,28,189,41,166,209,310,294
+M13829_s_at,1491,1213,1560,1360,616,860,693,1659,544,1187,1242,586,1253,1278,477,666,954,591,1071,810,102,953,587,1243,1002,475,1272,1146,834,1437,840,1166,870,644,1256,878,1261,1013
+M34353_s_at,439,273,459,177,169,229,72,403,298,248,268,76,214,281,18,219,614,61,194,269,169,49,167,401,156,158,428,277,529,316,148,495,65,-9,228,-99,253,372
+M13928_s_at,-24,-171,61,144,33,94,236,433,141,57,-20,0,106,-168,-46,147,-112,125,241,90,-97,151,155,368,225,161,-101,411,199,401,329,298,21,157,-274,107,161,481
+X04445_rna1_s_at,-555,-541,-867,-621,23,-739,-814,-1478,-113,-54,5,-571,-95,-224,-449,-21,-602,-351,-179,144,1,-438,-535,16,-204,195,-1691,-401,-334,-627,-489,-769,-404,-162,-837,-868,-1105,-1059
+X81851_s_at,-326,-65,41,-380,56,-215,-225,-422,-234,-97,121,-219,-35,-198,-105,-204,-336,-230,-169,-137,-84,-160,-66,-93,-8,-82,-356,-313,-86,-313,-7,-62,-276,-15,-207,-210,-267,-356
+M13994_s_at,146,175,318,65,46,245,574,263,87,305,99,380,46,68,58,16,39,364,54,2,394,190,376,141,210,89,436,966,86,826,57,422,228,11,72,311,509,329
+M60891_s_at,-407,-253,-586,-987,245,-391,-1036,-988,-33,-100,-340,-416,-175,-464,-256,-148,-189,-425,-130,-67,-572,-717,-533,-493,-27,-349,-1682,-702,-550,-512,2377,1378,68,875,-268,-351,-399,-397
+U59058_s_at,207,251,338,78,56,172,161,148,123,102,34,189,59,63,153,84,534,150,57,-32,219,266,254,208,92,106,140,236,235,138,154,422,346,258,353,81,94,133
+M14328_s_at,2700,6638,6981,6276,9739,5263,4456,3323,12128,9205,7933,6038,7080,7850,10803,7186,13412,14766,7182,10188,2394,1082,4785,8574,3911,9240,5017,11454,4898,16239,7714,2974,14128,7116,13913,10970,17211,12688
+M16336_s_at,62,2066,3663,41,-131,3232,63,676,4303,1252,1969,152,-180,-108,-9,-105,2109,-205,-86,3594,13,27,794,-142,-28,-186,139,-346,-88,-270,-38,76,-112,-55,-143,-227,-30,12
+M14483_rna1_s_at,18443,21084,22167,21771,19363,26169,15327,17348,20388,17569,13372,15269,9946,15571,21908,11203,10470,10736,6474,15867,9913,26896,25996,13709,15687,21004,12142,11871,7860,14886,14927,13107,16503,8957,13303,12122,14207,11468
+X04602_s_at,-7,111,-22,-11,-5,-40,50,172,-12,19,11,-18,8,0,35,-16,6,136,-4,-29,31,-22,60,-6,17,29,28,-12,4,5667,1417,34,-29,-19,88,-39,7,1446
+Y00081_s_at,6,41,-28,112,19,-69,65,-160,-64,73,-3,-2,22,14,23,47,17,91,-29,-9,-97,-28,30,-68,19,36,-56,11,-170,5419,1053,-171,-3,-18,85,9,46,1214
+M26708_s_at,13394,13249,15733,14004,13899,17474,17668,16114,12878,14366,12942,11361,13410,12669,12420,13995,13288,13732,13384,12925,14896,12684,17961,15580,13794,13763,15354,13285,11845,14691,11290,12795,12534,10212,12007,10562,12421,12004
+X64072_s_at,196,2120,967,173,802,1984,221,130,1709,414,272,-99,660,2327,983,248,4348,549,-12,17,26,37,319,288,-28,209,-433,2506,1221,7884,4401,140,1316,1964,7616,4036,3776,2892
+M15517_cds3_s_at,414,242,262,240,117,168,89,188,287,111,117,181,141,94,106,234,451,229,159,350,84,122,406,149,198,214,588,385,288,251,300,172,353,-13,21,236,247,561
+M27396_s_at,92,109,116,-56,33,90,25,79,54,24,119,-10,43,149,3,220,52,223,60,386,232,-17,24,69,119,-11,-9,237,36,33,53,157,167,-63,-31,183,111,-69
+M16364_s_at,-805,-277,-890,-967,-426,-876,-984,-938,-938,-318,-676,-229,-255,-713,-559,-678,-1649,-228,-267,-760,-12,-589,-754,-576,-566,-579,-1481,-1125,-613,-896,-530,-1000,-625,-127,-639,-790,-1127,-1590
+M16474_s_at,69,15,53,-14,15,-5,18,-34,35,15,1,15,-6,28,-13,37,17,-2,-5,44,-42,-39,-13,14,-24,-4,12,-61,4,-56,48,44,8,-7,27,7,10,58
+M36429_s_at,1016,491,911,588,874,942,905,526,1098,471,661,613,792,648,914,767,885,431,228,757,127,375,598,791,360,621,291,379,182,651,711,367,567,333,818,788,1268,597
+M16591_s_at,454,56,-14,187,222,37,146,-5,-36,3,-26,-34,-4,79,118,-40,247,29,-65,-15,-43,-48,-172,232,-64,-83,-3,-87,60,649,71,57,-49,89,365,187,101,438
+M16652_at,1672,2134,2676,1974,1523,2709,1796,1494,2799,2344,1770,1329,1170,1675,1237,1565,3098,1563,1258,1828,442,1128,1795,1332,1143,1031,1835,1841,1072,2738,2449,1291,2224,1133,2194,2850,3743,2998
+M16652_s_at,-166,-122,-95,-124,-36,33,-134,-41,-151,-103,-134,-112,-87,-96,-100,-141,-211,-23,-64,-144,-52,-138,-106,-128,-135,-142,-25,-176,-247,-165,-130,-75,-224,-26,-139,-113,-150,-245
+M16707_rna1_at,-562,-631,-574,-606,-495,-640,-673,-943,-740,-235,-635,-540,-322,-499,-462,-286,-978,-311,-416,-528,-76,-544,-655,-441,-759,-379,-771,-519,-329,-1003,-1280,-1054,-830,428,-844,-680,-869,-1308
+M16707_rna1_s_at,317,-26,221,650,262,142,648,154,358,570,23,150,505,85,237,495,260,-65,288,675,288,139,83,499,317,91,148,491,0,4,-99,156,211,1304,55,168,311,25
+M16750_s_at,723,2916,234,304,387,7,421,325,335,-44,-167,605,570,356,355,110,3244,301,573,212,249,385,208,72,756,196,231,133,329,4856,2952,2717,1678,2072,1982,410,1053,1950
+M16938_s_at,501,384,629,510,264,565,431,812,379,248,364,41,225,450,201,328,820,248,345,300,76,325,471,527,371,367,147,472,353,640,384,247,511,55,467,520,470,592
+M31423_s_at,-53,19,37,115,25,17,63,106,-20,-4,10,1,26,30,36,32,-21,11,-6,-7,4,-31,58,79,-8,-7,79,-13,31,-14,105,47,62,6,18,7,-10,33
+U08006_s_at,41,-25,131,128,34,92,110,118,89,200,87,-22,26,79,66,84,41,78,156,84,187,-35,36,134,86,59,61,133,103,131,58,125,83,91,78,282,145,141
+M28130_rna1_s_at,292,2062,-25,-2,138,23,107,-19,104,-35,189,1855,3,9,91,73,17,41,16,242,184,155,148,-146,4271,29,-233,3693,-45,11517,12979,5072,10476,1653,2971,688,7108,13176
+Y00787_s_at,333,5345,301,241,93,215,159,455,445,522,1278,3684,116,94,29,38,282,136,-53,119,118,206,146,185,9270,183,150,8054,216,17022,19361,10043,15202,3104,6506,2096,12715,21147
+M17236_at,-195,132,54,-80,-223,115,191,211,-371,-36,-316,-63,11,-182,-127,-154,755,1,-51,-436,54,-244,-5,55,-12,182,658,184,177,267,-197,-134,-472,-275,593,-371,-188,3
+M17236_s_at,-152,-57,-205,-399,5,-264,-272,-620,-160,-237,50,-287,-12,-336,-267,-303,-913,-128,224,-63,-29,-211,-340,-156,39,-140,-674,-315,-413,-295,-455,12,-160,-3,-282,-154,-350,-233
+M26856_s_at,-540,-607,-672,-1509,-233,-785,-1645,-1397,-620,-199,-398,-554,-201,-618,-291,-341,-869,-364,-422,-295,-183,-625,-511,-404,-266,-252,-907,-641,-798,-668,-685,-604,-626,-334,-663,-719,-527,-868
+M17254_s_at,443,-81,-171,425,52,64,-68,865,-155,-161,-32,285,303,-300,129,-359,63,-351,172,88,-343,-88,-378,-4,260,-278,-355,-126,-452,-317,-49,-267,-87,2,-152,77,470,-87
+Y00414_s_at,474,527,883,749,103,686,831,1218,875,456,639,337,467,666,556,657,998,428,660,832,254,266,330,532,515,480,724,760,831,1141,786,1182,772,502,628,612,920,1333
+M18255_cds2_s_at,1486,743,788,302,267,465,255,797,778,179,265,257,297,723,657,583,1825,242,360,1249,229,66,366,259,394,590,195,172,336,649,154,134,255,85,295,181,876,168
+M18391_s_at,52,126,290,281,38,129,112,326,128,129,68,74,28,373,65,134,155,67,184,229,69,170,275,89,247,113,233,205,317,216,81,90,159,130,247,231,360,397
+Z19554_s_at,15009,13566,18957,16547,18660,14522,9147,17979,20595,22332,24051,4539,15822,15133,14432,17264,16172,9642,3752,16311,18407,12690,9256,16543,3771,10429,7338,23297,11145,25528,20254,7075,18421,18508,21857,20540,20758,20927
+Y00083_s_at,14,-36,30,-15,-1,-23,3,-17,42,30,6,-30,-16,20,-47,49,38,-34,6,-6,122,26,39,-29,127,-14,65,-32,45,2,-20,2,-44,34,81,-15,-2,3
+X54667_at,-37,-143,-147,-93,13,-174,-162,-175,-168,-171,-129,-79,-6,-52,21,-33,-122,-29,-108,-48,-177,-122,-188,-155,-127,8,-122,-221,-158,-158,-13,-97,-135,-35,-29,-54,-101,-60
+X54667_s_at,1371,1107,1539,1195,557,1018,1140,1265,1486,901,953,661,709,806,651,1066,1638,422,593,958,528,619,1043,1442,1005,972,1365,1674,1000,1441,916,850,1587,512,1180,1161,1411,1906
+M19267_s_at,22,44,13,25,-17,92,-62,-20,83,-4,-40,-5,12,14,-11,8,-17,-15,7,36,74,-60,85,6,39,-7,-71,-63,-50,-14,170,195,2,122,92,-68,84,28
+M19309_s_at,49,-36,-195,-220,47,-26,-131,-247,-231,-19,-101,0,-30,-50,-30,131,-199,49,65,-4,14,-122,-113,42,15,0,-122,51,-74,125,-33,167,275,107,90,-68,-119,84
+M19508_xpt3_s_at,795,833,1391,996,678,851,1033,914,802,829,761,617,518,557,444,1410,1894,510,767,1032,143,632,689,944,949,602,1026,1555,2053,1575,1184,1732,1493,711,679,2650,1031,4068
+M19878_at,-63,161,85,312,88,-78,-42,-128,91,9,-65,34,-11,-12,103,109,337,91,228,92,0,-32,119,30,33,-70,158,251,305,58,205,91,68,61,321,57,50,168
+M19878_s_at,-197,42,-171,84,-74,83,-317,13,41,-44,-17,66,-64,27,-33,-94,-105,-49,-32,41,86,23,30,-91,-18,25,39,-124,-33,-130,18,-80,18,-9,-57,54,-86,-229
+M27783_s_at,-26,-166,79,171,315,-104,-250,-110,118,344,14,22,20,26,-16,174,149,179,-20,232,156,137,28,26,1,75,154,1749,216,371,1586,727,303,10778,2236,1084,375,4226
+M20203_s_at,-351,-432,-329,-300,-325,-364,-341,-649,-395,161,-335,-47,-86,-348,-350,22,-847,-153,-38,-508,-38,-176,-197,-127,-534,-270,-530,921,-336,-135,1149,634,-383,8059,1556,425,-189,4577
+X58298_s_at,-1,-121,-356,-419,44,-179,-478,-392,-336,-240,-381,-199,-177,-135,-69,-198,21,-214,-2,-406,-79,62,13,-226,-161,-96,-156,-334,-274,0,-51,-255,-90,-138,-46,-128,249,-9
+M20642_s_at,17,-9,21,35,40,-46,-8,14,62,25,26,4,22,56,-21,11,10,-49,-13,4,96,22,-24,26,4,11,-75,-59,-81,-97,-24,8,-32,-2,15,10,-97,-60
+M20747_s_at,670,441,831,448,337,380,628,706,771,417,502,306,349,501,233,380,738,407,412,470,304,394,269,452,389,400,898,577,639,788,727,592,608,245,581,329,900,896
+M20778_s_at,111,87,107,-99,60,58,1,-10,102,43,-21,-24,-1,-35,-23,64,-57,66,57,97,4,47,153,66,-12,70,92,-7,7,104,1,22,-59,11,-13,-87,17,13
+M26311_s_at,-113,4452,775,157,2175,1612,109,44,1219,902,112,2979,-105,2675,64,157,41,-26,-23,202,21,184,497,5,-19,76,-117,334,-120,20611,6869,-44,585,374,11456,1331,1827,12678
+M84371_rna1_s_at,2911,575,905,2038,1871,634,2364,1409,644,358,500,1119,1473,408,2239,1981,409,1046,3210,4072,1069,1878,685,1967,2537,3495,1768,469,548,763,466,838,443,225,251,595,863,678
+M21142_cds2_s_at,11359,9343,10405,8754,7882,11846,9596,10838,11295,11290,12537,5923,7673,9228,11598,10160,10102,4095,6093,12537,8800,9229,8840,6908,7808,4816,7843,6294,4535,7925,10874,10702,9504,9863,10414,13325,12176,8980
+M54914_s_at,10,38,-1,-30,-29,-21,-95,-55,125,33,-14,-45,13,0,-57,-31,76,-96,-38,-33,-71,-129,1,-72,-54,4,112,-63,-76,-33,-106,86,28,-53,26,-19,4,-18
+M26692_s_at,63,286,725,-143,29,615,-94,-200,700,274,656,-71,-39,115,-88,-33,85,10,-124,-9,-39,15,106,52,-42,-45,109,-203,115,41,105,-51,-79,-74,-76,-156,-65,-141
+Z20656_rna1_s_at,44,-31,-66,-103,-79,-108,-50,-68,-61,-88,-31,-77,-22,-30,-92,-7,-70,11,-71,-86,72,-119,28,-108,-55,-36,-87,5,31,-74,-12,-55,3,-85,-126,-7,-67,31
+M21665_s_at,15,36,-242,207,1,-106,-149,182,-210,-142,-149,116,64,-214,42,39,75,34,41,52,69,183,11,5,14,-123,35,64,151,235,-99,-10,-256,71,86,-23,24,12
+M35851_s_at,-7,-20,18,11,-15,37,35,65,85,94,-150,80,-7,91,-31,-31,-257,-68,-65,-42,-56,-32,-96,-40,14,-16,-341,-62,-50,-17,-11,51,-16,22,57,77,39,-17
+M33772_s_at,17,-70,-210,-191,127,76,166,-122,1,27,-32,-110,-47,39,-22,-73,-86,71,38,-85,241,132,68,-48,52,31,-90,-48,14,-53,187,132,199,210,-137,-40,139,89
+M26730_s_at,1675,2077,1415,1664,1790,1306,904,713,2145,2221,2345,1293,2412,1736,2484,1866,2921,1492,1126,4714,6874,1471,1457,1521,1908,1734,740,2267,1471,1716,1361,1398,2461,2561,2414,892,1837,2478
+M22348_s_at,525,557,732,524,284,280,433,637,566,425,415,214,509,422,330,416,1161,444,281,888,404,476,260,460,429,408,801,492,490,527,395,611,594,382,542,316,323,707
+M23234_s_at,8,-48,-117,92,5,-104,-38,83,-74,-27,-43,0,48,-11,-41,-97,-42,-32,120,182,-29,-7,43,-77,-25,33,32,-254,-45,-265,-85,-16,-142,-34,51,39,-89,-151
+M23323_s_at,2117,7691,6290,1554,977,4303,2115,3532,9226,5263,6051,1043,1219,5388,937,1599,3423,1371,1320,1772,753,1787,3410,1602,1091,1454,2356,2051,1815,2232,1794,2319,2132,1094,2146,1459,2011,2945
+Z68228_s_at,6315,1399,69,1662,1993,757,954,2802,682,566,249,758,4796,1174,2470,2968,4838,572,2988,5107,2,3606,85,1500,2128,4809,2705,1283,613,782,551,1515,2338,769,891,1242,3087,2187
+M23892_s_at,115,92,-92,149,14,192,58,95,-110,42,58,74,8,104,128,86,-136,-45,29,114,21,-9,121,76,109,42,43,-94,173,-138,136,133,1,23,19,-7,18,133
+X95325_s_at,4383,2163,1169,2678,1763,947,2950,4093,1794,654,1325,1819,2023,756,2706,2034,2034,432,2481,6035,173,290,1046,2231,4310,2359,904,1886,637,1400,3706,2306,2850,1423,915,2381,1784,3247
+M24122_s_at,-62,-534,-112,-168,59,-49,-366,-1046,356,-6,-16,-8,-47,-231,-31,42,-767,4,-275,-392,252,-466,-15,-29,-457,-110,-367,-182,-471,-464,-271,-522,-297,-230,-533,-179,-432,-966
+M55024_s_at,-174,-18,-96,-38,7,-56,-28,-131,19,-84,-25,12,23,58,-39,-50,-185,-2,-38,-38,-62,35,-98,-104,17,-68,14,-162,-137,27,-53,-70,-40,-89,72,-34,-13,-39
+M24485_s_at,2657,3766,4741,2754,3113,3134,3113,2563,8374,4453,3467,2368,2939,2284,5187,2916,8074,4273,1838,3255,795,1404,2184,3018,1327,2171,1414,4012,2034,7011,4023,1462,5453,5212,7209,9663,11501,4126
+M24486_s_at,163,-89,-74,164,141,0,-43,-95,-271,-44,-20,-150,470,-9,195,110,130,112,226,491,172,15,-355,-45,141,92,-217,126,-16,75,-27,-85,-79,-82,114,-126,-31,-62
+M24736_s_at,48,83,33,72,65,96,45,46,140,1,29,53,26,43,21,92,101,62,50,51,38,-24,81,68,53,53,161,121,76,128,19,65,89,-31,102,62,103,77
+M24748_cds2_s_at,40,-87,-143,-28,-8,-147,-174,-274,-118,-9,-118,10,-91,-20,-111,-80,-161,-114,-147,-147,-64,-74,-127,-107,-172,-108,-50,2,-175,-140,-252,-139,-167,-119,71,-102,-167,-223
+M24766_s_at,-699,-773,-448,-1047,-391,-510,-628,-821,-1038,-190,-647,-491,-451,-782,-533,-282,-933,-370,-221,-556,-2,-258,-360,-609,-398,-64,-639,-287,-235,-1078,-1374,-671,-719,-544,-229,-604,-713,-666
+M54915_s_at,1975,5636,407,822,1118,887,1041,1418,1284,1065,622,1406,1245,548,1040,801,7542,915,1519,1614,817,857,708,994,2025,1257,849,385,1267,9712,7372,6659,4301,2818,3932,1285,3073,5624
+X12876_s_at,-205,8,-200,-190,-87,-280,-334,-305,-330,-103,-172,41,1,-161,-186,49,-150,34,-66,110,-74,-5,-81,96,-61,132,-276,71,-7,-316,-83,490,399,-87,79,-62,-356,-293
+X72632_s_at,501,269,855,564,459,570,428,560,614,374,367,333,409,437,370,416,856,412,425,863,288,677,484,512,352,531,538,683,394,787,392,540,487,297,669,542,700,867
+U16799_s_at,-162,650,-78,-22,-53,28,-110,-652,160,219,-51,-4,-112,90,-55,-47,1388,20,-85,-155,-38,-86,5,-61,-137,-298,-184,-63,14,-91,-131,99,343,82,-51,107,4,-62
+M31776_s_at,36,210,516,126,334,375,45,-134,375,344,212,313,207,185,435,246,305,371,290,482,-84,129,214,158,428,438,722,-15,2,76,117,233,130,221,31,236,332,427
+S66541_s_at,-646,-382,-780,-384,-330,-291,-320,-335,-217,-294,-203,-172,-365,-207,-382,-483,-683,-577,-272,-555,-177,-188,-421,-317,-185,-500,-378,-453,-262,-364,-358,-661,-171,-274,-856,-298,-308,-337
+M26041_s_at,1514,958,1774,1361,462,1171,1502,1565,1137,719,802,655,791,974,1083,795,1939,4478,2488,1258,383,835,613,804,895,796,1398,1403,743,1678,1330,1324,1441,358,1209,1391,3078,2165
+Z80345_rna1_s_at,-31,-33,128,-336,-9,-167,-146,290,173,-47,140,-314,-149,-367,-334,-168,644,72,117,-305,-97,215,-91,282,-242,81,352,627,-168,-28,12,122,113,63,-108,-23,-144,77
+M26657_s_at,-504,-1070,-910,-861,-59,-769,-628,-866,-817,-727,-504,-547,-791,-737,-823,-843,-1127,-634,-820,-645,-43,-262,-490,56,-727,-503,-915,-666,-593,-1055,-1199,-1421,-774,-522,-1035,-697,-910,-1249
+M27093_s_at,7,7,176,53,17,-5,10,65,87,-15,68,-11,-5,-12,-13,-43,55,-3,-9,-4,1,2,26,79,-16,-48,81,-51,60,-43,70,-21,13,-10,11,17,34,97
+M27504_s_at,635,165,140,380,366,160,255,584,227,57,121,81,232,116,582,227,245,4,225,402,-32,78,39,474,177,45,259,-14,-62,-94,137,20,67,47,226,143,99,101
+M27533_s_at,2,-128,-185,-27,-31,101,-137,119,-107,-91,-81,-71,22,-196,-140,-127,-704,256,-44,6,4,-65,30,-85,23,-21,231,48,40,-113,139,-80,-38,23,-173,14,-222,55
+X60003_s_at,784,598,760,768,434,659,591,835,503,307,380,186,393,547,1080,529,1246,458,480,550,162,540,433,756,322,325,510,668,519,530,365,243,530,282,441,379,865,565
+M28213_s_at,264,315,68,439,215,190,40,85,225,71,384,224,281,156,489,175,435,193,56,532,143,204,237,204,151,133,120,300,57,557,367,241,213,348,491,309,254,372
+S72493_s_at,325,-489,539,910,229,158,-62,962,1124,651,337,353,309,435,704,390,472,1024,859,550,864,559,638,1454,111,1289,722,1273,1416,1170,930,1491,424,821,390,635,-487,1722
+M29277_at,1022,1279,1080,1626,560,1386,1145,1229,934,684,893,903,425,808,743,759,1756,695,680,1092,324,1004,927,366,1109,589,1866,922,682,684,1913,1248,1229,795,1571,1208,1292,1804
+M29277_s_at,-240,359,-258,-134,17,-286,-403,403,-231,-259,-171,-44,-57,-149,-117,-67,-393,-33,200,813,-27,300,17,-53,-25,6,-449,-179,-67,-341,-33,24,325,-133,-390,-136,-189,-5
+M28882_s_at,221,1391,676,529,271,496,510,1691,690,427,356,533,91,416,198,170,695,166,493,2017,427,868,522,393,341,178,627,199,930,192,709,553,1790,114,642,466,417,340
+U20734_s_at,436,3426,270,88,892,199,578,1539,591,489,183,1733,781,215,726,433,340,2050,1367,2348,158,778,11,437,1275,3593,469,1537,127,8688,3947,2299,8752,588,3008,439,4115,3232
+M29335_at,-606,-640,-725,-735,-456,-519,-1145,-550,-1175,-205,-1026,-399,-375,-387,-472,-431,-1052,-292,-89,-583,-133,-472,-461,-160,-418,-370,-1187,124,108,-371,-1007,-631,-670,-379,-311,-503,-767,-595
+M29335_s_at,56,-137,-30,-55,-15,-96,-48,-113,-146,-97,-171,-30,-37,-9,27,-108,-225,-98,-47,-38,-72,-92,-68,-32,-90,-24,-237,-98,-69,-159,-150,-175,-88,-75,-250,-41,-181,-79
+Z47055_s_at,868,962,1812,767,708,1040,598,643,3552,844,1953,459,610,989,1116,686,1088,988,348,1055,374,231,797,689,362,571,436,616,543,736,444,389,537,383,472,609,510,276
+M29932_s_at,1154,794,1303,1245,556,734,811,886,1280,893,967,403,827,764,531,1185,1000,730,802,750,361,672,961,1203,738,681,539,1291,863,1777,1024,969,1433,464,720,732,1215,1892
+M29994_s_at,513,279,440,292,105,254,446,386,417,129,219,206,198,275,195,244,532,204,134,243,264,279,199,237,358,234,486,323,269,437,462,551,472,186,111,307,292,752
+M33493_s_at,176,-47,234,209,261,147,20,452,23,240,109,125,76,91,196,-17,352,102,24,139,144,151,74,201,84,162,654,139,96,-31,3443,776,3118,996,105,39,352,1980
+M31516_s_at,45,107,44,77,106,-7,94,53,0,77,81,61,115,120,81,-1,226,55,65,91,52,60,58,-5,74,153,139,75,7,255,58,27,23,53,93,-3,62,596
+M30257_s_at,60,45,119,73,53,58,100,116,181,76,173,80,118,105,88,48,197,100,53,87,62,77,123,141,63,73,145,160,105,152,143,96,177,1,207,164,122,117
+M30448_s_at,2705,4017,2939,2992,3438,3465,2209,2380,5820,3914,3507,2231,3211,3965,3497,3067,7700,2346,2367,7312,1948,1211,3400,3099,2937,2790,1713,3675,2582,3024,3645,3594,5098,3168,3057,2585,4388,3335
+X57152_rna1_s_at,2464,2200,1619,2099,1885,2533,2197,1346,3456,2174,2106,1294,2476,2049,2932,1864,2239,1733,922,2864,1445,946,1996,2720,1604,2151,1486,1651,1211,2168,2312,1301,2154,1919,2261,1730,2180,1253
+M30625_s_at,-258,-177,-148,-234,-170,-202,-11,-644,40,-130,-163,-143,-166,-53,-175,-142,-290,-85,-1,-136,-29,-49,-125,-242,-9,-196,-447,-278,-24,-252,121,-292,-23,10,-344,-154,-213,14
+M30703_s_at,-1,-47,-88,13,-2,87,70,70,14,38,41,-15,-19,-6,80,4,53,-14,-36,214,111,-61,24,-40,29,-25,81,-49,351,37,7813,1231,5264,753,103,-78,-6,9470
+M74587_rna1_s_at,284,138,261,127,144,10,189,221,287,154,115,145,158,179,104,174,613,123,93,230,104,129,106,167,167,181,438,180,185,120,196,248,202,42,201,124,150,190
+X97748_s_at,48,191,38,-44,24,76,-181,-853,3,78,110,45,47,45,70,74,5,9,161,-84,216,-77,132,-214,198,-11,-50,121,-432,4277,1540,646,594,49,1108,141,164,1360
+M31169_s_at,189,442,258,163,297,149,236,295,486,611,171,181,245,430,366,187,370,225,198,1074,7,78,222,195,183,102,-4,177,204,98,602,563,387,323,404,353,255,264
+M31211_s_at,601,435,547,472,661,337,309,263,978,752,897,334,668,265,898,666,374,516,473,1487,688,143,376,531,481,647,145,153,19,88,139,75,300,237,100,192,339,59
+M31241_s_at,20,49,44,77,9,56,132,-1,97,90,67,43,1,27,23,8,33,43,14,95,61,68,20,11,59,12,137,22,-7,71,55,109,25,23,37,27,45,88
+M65214_s_at,1853,1126,1555,1674,1161,1321,1560,1841,1108,1262,1065,661,1291,758,1634,1598,1124,1449,517,1731,1218,944,1253,1381,1457,1099,1408,982,807,821,805,1094,974,484,735,749,1255,1010
+M33684_s_at,316,286,699,399,342,311,488,299,436,393,367,291,288,406,342,341,523,306,372,415,173,247,324,381,380,281,377,455,365,718,820,389,603,249,587,476,678,853
+U05681_s_at,1300,1923,1653,2116,617,1929,1947,2229,1779,1409,1240,1521,789,1659,514,510,2197,510,1117,1373,964,1519,1153,806,1059,816,2365,1342,1324,4391,3018,2464,2914,1466,1919,2261,2229,4039
+M31774_s_at,98,196,348,62,69,168,183,127,123,118,71,5,58,60,-71,-29,147,21,5,19,89,-243,32,126,47,15,328,34,110,109,182,88,-213,-9,13,56,222,189
+X68090_s_at,-124,-89,-139,-143,31,-110,-225,-167,-72,-138,-57,-27,20,-76,-31,-21,-83,-85,32,90,-62,-64,-113,61,38,-133,-394,126,43,246,40,13,-14,69,-81,7,-179,-19
+X51435_s_at,441,389,383,542,140,440,440,521,419,235,250,306,277,332,270,317,569,381,228,477,281,394,374,284,235,146,544,367,403,317,489,546,470,218,339,397,507,550
+X54199_s_at,9,-3,-23,-39,100,30,-45,-140,69,-95,-143,79,62,89,179,23,-162,-15,-2,25,19,-128,-1,170,157,-39,-129,-100,-36,-285,-256,-158,-127,13,-132,-113,-27,-245
+M65292_s_at,56,31,12,-98,20,-99,-15,-43,32,-37,-22,-1,-1,61,38,-43,37,83,-38,-7,31,48,66,-30,27,-42,-61,98,-48,-89,7,-2,29,27,138,103,48,-66
+M32879_at,845,-881,450,-464,-64,-85,272,-1299,1408,-73,753,-472,-220,222,-17,-303,-614,22,-135,-293,256,317,182,281,423,67,-1882,126,-247,-551,-592,-91,103,-278,-1843,-497,-159,1074
+M32879_s_at,87,102,536,-143,85,12,-63,493,538,204,-68,113,83,225,255,223,684,368,116,149,56,239,303,-29,4,77,420,103,55,-148,507,282,322,42,126,-121,362,-245
+M58286_s_at,-64,-179,-934,-555,280,-702,-369,-1151,-552,-450,-598,-350,492,267,45,75,2156,-795,129,-248,-352,-448,-773,-112,-386,-254,-1816,-118,-656,-311,-433,-533,-126,-65,-124,-503,-516,-299
+M86873_s_at,-141,-58,34,-77,-16,28,-99,-101,24,-65,-77,-31,-23,-81,130,-156,86,-35,-73,4,-13,-32,-83,23,-88,-45,-84,-74,-117,-109,-189,-129,-148,-91,-42,-95,-117,-105
+M34338_s_at,856,716,1447,1493,1349,1612,925,1206,1686,681,950,928,913,1427,1731,647,1978,172,368,2954,126,172,780,1732,737,813,683,689,870,1373,823,279,1240,920,1235,1684,1268,509
+U22178_s_at,126,111,84,71,36,218,115,245,128,101,122,22,57,151,140,58,182,66,266,382,-4,130,-7,130,156,139,12,103,88,75,369,479,55,66,90,58,167,326
+M34376_s_at,-164,-112,-78,-14,-66,14,94,-127,-94,30,-100,54,50,32,0,-121,96,-67,-20,-79,7,-28,-108,-153,-58,-112,-159,78,62,-70,-72,-162,21,47,-23,6,18,-49
+M35093_s_at,-1420,-1571,-1998,-1370,-1017,-1070,-1492,-1896,-2122,-838,-1160,-799,-943,-1058,-787,-1307,-3129,-881,-1037,-1017,-528,-632,-1329,-1033,-1206,-1000,-1522,-1353,-1050,-2284,-1159,-1461,-1283,-614,-1242,-1220,-1354,-2217
+S37730_s_at,235,381,83,136,-20,398,-362,-485,1327,309,148,-160,-146,-77,-143,-282,-889,-156,-273,1779,23,-272,-9,-204,-266,-209,-704,69,-283,-409,-531,-375,86,560,-495,60,-604,-334
+U50648_s_at,1532,1659,1886,1468,660,1447,1340,1440,1927,768,1457,649,1580,1410,1677,1358,2850,811,868,6339,4062,761,1481,737,2505,1310,1078,2058,1661,1989,4637,1695,1752,544,1003,981,1928,5786
+M36118_s_at,88,72,150,36,17,65,126,233,57,51,-33,18,132,20,213,73,-120,105,4,150,-23,15,85,105,-1,108,14,382,168,94,37,51,68,46,15,162,45,278
+X13955_s_at,13,-43,3,-123,-10,39,-42,19,-152,-33,-44,-22,-21,-144,-6,-57,-21,-16,-3,128,-2,64,-98,-53,81,-15,-17,75,69,-8,996,83,19,897,18,-68,20,-62
+M36284_s_at,522,346,574,524,389,467,569,1287,1785,327,1347,1419,430,1310,460,2134,3753,699,2368,1173,652,706,1409,469,905,1647,319,597,2308,542,3147,3498,1838,2746,242,183,2604,4759
+M36542_s_at,995,828,1068,1175,943,1408,426,-775,682,-336,-363,909,-277,1621,-264,-341,574,-377,-330,486,149,167,-621,-185,-404,-107,-672,-171,-185,1342,998,1235,1017,-149,1045,1182,1082,977
+X13810_s_at,553,167,643,650,458,679,914,619,420,-298,441,724,204,356,193,320,-1230,220,-39,-302,304,325,811,415,16,281,178,377,591,721,370,257,625,570,419,676,790,650
+M36653_s_at,-220,-380,-180,-137,41,-78,-36,-385,-123,210,-137,-237,59,-246,50,101,36,123,-116,134,64,17,49,-741,29,98,-100,-443,-363,113,-158,-494,-124,130,-371,-130,20,-340
+Z38133_s_at,118,62,112,70,34,131,255,151,152,77,37,41,13,7,62,31,66,-21,54,36,74,58,94,-38,43,79,-62,59,28,55,125,126,-31,135,107,60,150,93
+M57731_s_at,-181,350,-46,-119,-65,-32,-30,-32,112,36,84,53,88,16,42,-17,-159,79,-46,191,-21,74,-22,54,1032,150,139,1022,60,5932,5036,471,4205,53,1066,150,767,9913
+X53800_s_at,93,100,85,92,15,81,151,121,168,1,67,57,50,110,66,32,75,65,73,114,-29,35,-36,17,166,106,226,90,120,615,257,81,591,55,184,81,140,1794
+M37238_s_at,1104,420,716,926,1494,433,940,688,592,522,503,559,565,344,1246,611,941,1252,573,550,122,236,587,854,556,589,363,508,476,925,554,600,725,247,269,485,633,909
+M37457_at,1521,1612,2039,1561,884,1555,1811,1929,1928,1247,1629,1047,881,1422,903,2314,2445,1021,935,2114,4556,779,1168,2191,914,1052,2467,1374,567,1736,1355,1743,1626,835,1343,1268,2254,2487
+M37457_s_at,-413,183,-215,-1125,-157,-407,-393,-494,-474,-618,147,-398,194,-284,109,-75,-371,-117,-300,225,-474,-374,-678,-105,208,-42,-940,-893,-1204,-329,-507,196,-352,78,-340,-511,-451,277
+M86383_s_at,-78,-10,31,-127,-80,227,-75,-277,-51,74,129,-84,-94,-84,-56,-113,-170,-33,-57,-35,4,-117,-102,-122,-43,-73,-39,-130,-204,-45,-112,-91,-78,-54,-102,-126,-139,-207
+M38449_s_at,716,1073,295,1446,1175,978,939,92,1093,1270,631,936,751,2671,714,445,3317,454,598,344,2,251,634,699,785,1309,168,2533,1324,2177,1502,211,1651,729,2958,3378,3984,856
+M55409_s_at,11154,8499,6976,13764,10718,8231,8710,8851,16435,14383,15618,12236,12625,13614,16357,12717,18358,12150,12522,19388,5330,6539,8217,15151,12091,14012,12383,12087,8709,12512,12602,13933,15730,13230,11456,11445,13634,12893
+M86933_at,-25,-37,-116,-68,-5,-37,-8,-2,-76,-74,-12,-27,-44,-70,10,-45,-51,-16,42,-5,-14,-36,-113,-19,-39,13,-89,-44,-19,20,-56,-81,-11,-53,13,22,-22,13
+M86933_s_at,376,321,-66,-384,20,108,136,776,339,130,-175,-159,132,357,267,310,305,271,159,119,266,-194,260,201,218,247,356,500,829,5,182,345,138,210,126,103,130,115
+M55513_s_at,363,147,166,331,161,136,351,370,153,224,167,145,509,65,301,253,287,122,670,328,166,130,246,209,74,952,434,174,170,229,195,264,171,157,16,205,211,154
+M60450_s_at,-89,-65,-124,-55,20,39,28,206,-106,74,55,-7,-32,-112,24,-117,-59,-8,13,79,51,34,37,-31,-90,2,32,13,-40,-103,54,1,-153,19,-106,10,25,-225
+X54993_s_at,288,18,190,151,169,16,218,509,307,149,18,-45,239,271,316,224,488,80,74,541,151,68,127,281,44,238,417,5,110,384,40,136,19,57,104,255,181,21
+M55682_s_at,-23,-418,-144,-481,-412,-444,-452,-526,-377,-519,-580,66,-180,82,-592,-516,-586,-422,-418,-608,-233,-234,-324,-455,-282,-448,-564,-665,-298,-415,-395,-821,-899,-490,62,-265,252,-483
+M55998_s_at,444,309,480,415,250,215,430,476,489,364,313,191,345,322,441,401,748,615,316,361,654,410,286,389,334,348,461,541,415,559,343,482,519,157,445,336,460,591
+M57466_s_at,5204,467,-788,968,1972,-250,391,2344,-607,-283,-698,1747,6767,-102,5738,829,-1234,10433,3551,7895,184,6438,-347,729,1468,3950,-162,-278,3323,682,520,-371,3019,1724,2154,1948,2083,1412
+U16720_rna1_s_at,203,246,435,148,5,131,374,271,261,216,163,120,103,203,23,339,562,190,217,264,171,294,115,151,263,157,372,276,192,519,194,76,381,26,203,129,382,687
+M57703_s_at,142,87,102,39,36,56,152,161,57,4,107,70,7,192,91,107,39,38,24,68,118,60,18,117,124,-4,34,-1,144,-23,50,86,107,63,79,68,15,49
+M65134_s_at,87,31,110,91,73,40,30,200,102,72,33,25,55,-8,55,-63,159,77,5,82,-8,20,30,102,93,60,90,-39,9,68,59,86,46,38,117,2,78,46
+X13461_s_at,1032,497,1029,507,357,513,680,773,1197,489,794,215,736,567,339,612,798,578,434,687,247,481,560,834,825,725,508,966,769,858,633,838,980,380,215,605,818,1275
+M58525_s_at,488,1157,364,790,1088,346,1354,577,834,254,234,672,1007,769,1389,1080,2816,267,467,1742,0,-3,397,1735,767,660,397,1322,658,1213,695,20,855,483,1572,1583,1279,273
+M59216_s_at,25,129,28,54,9,193,97,151,76,82,24,57,-8,29,30,70,146,58,72,-28,68,-18,94,137,36,157,237,26,358,69,38,42,39,-1,84,96,39,5
+X52282_s_at,12,18,71,29,24,78,89,59,108,-8,88,-89,19,36,-10,59,612,21,21,134,22,-32,-18,123,75,111,-97,45,19,86,7,54,226,151,30,71,669,36
+M60284_s_at,1324,1338,1115,786,307,453,939,1337,1113,257,644,366,700,924,371,440,1731,789,671,929,328,473,989,779,404,659,943,1074,983,585,717,1307,848,307,593,612,490,1160
+M60483_rna1_s_at,390,108,158,258,452,302,393,169,629,222,698,294,393,485,862,553,306,213,816,765,328,209,471,296,221,383,90,245,84,291,497,226,212,364,75,113,145,552
+X69950_s_at,-441,275,-271,381,138,304,759,377,-66,178,207,162,98,165,127,10,-759,-230,167,220,-178,112,288,76,190,-163,-860,203,-43,95,49,338,91,235,-139,294,-13,140
+M60784_s_at,1025,1144,1175,1129,1221,1868,1233,500,2755,1751,1464,344,948,1108,1475,1134,1882,902,923,1661,603,379,1402,1212,596,1041,522,762,728,1491,579,596,1104,506,1251,1127,1019,602
+S81661_s_at,28,58,60,47,41,48,87,35,38,15,31,-27,13,66,15,1,62,1,28,32,33,6,-9,-15,73,39,71,21,79,65,-7,113,-18,22,27,61,87,29
+M61826_s_at,470,60,21,106,57,32,142,416,209,84,41,67,302,64,47,163,242,144,290,1273,73,164,24,122,303,320,79,86,423,51,1466,1204,253,439,167,51,204,350
+M61832_s_at,934,774,833,1319,1914,618,818,557,2116,934,1000,686,867,902,1307,1007,1973,954,1155,2410,455,251,763,1260,630,934,464,999,884,1326,1247,756,1633,788,1419,1542,504,856
+X65962_s_at,797,472,1075,647,436,606,828,1179,856,570,540,278,425,574,300,619,1211,643,517,742,338,482,607,611,511,574,921,873,747,1012,707,913,804,302,595,652,902,1273
+S82362_s_at,-24,-82,-44,19,9,-80,201,68,-68,-100,-80,-40,-20,-36,-66,-72,50,-35,0,12,44,14,-68,-26,-9,-23,93,-45,-24,-4,195,259,-64,130,-109,-69,-27,95
+M62403_s_at,508,168,290,198,149,-32,152,272,187,61,-27,166,1607,449,289,308,212,388,605,139,274,542,264,25,300,458,162,197,117,362,109,164,524,15,475,141,77,226
+S38742_s_at,17,182,-100,-14,110,-112,-52,-89,132,219,77,54,146,17,80,168,505,-11,142,244,3,-56,-55,-92,-27,-107,538,-43,57,263,-155,-113,271,74,252,-128,262,-254
+M62628_s_at,163,125,377,326,183,135,453,-389,201,218,134,181,246,39,116,349,406,1676,24,-87,443,-85,229,359,-145,392,372,489,149,407,-809,117,401,94,163,397,39,-714
+X53595_s_at,66,55,65,10,36,14,-33,-77,25,37,0,4,22,22,72,28,-19,-7,-14,41,71,94,89,91,44,23,32,55,91,-25,29,189,89,130,31,75,25,108
+M73746_s_at,-77,-14,-52,-152,11,-81,-104,-142,-116,-28,-42,-45,-43,-30,26,-91,-16,-3,-60,-69,-44,-2,-66,-39,-35,-25,-93,-40,-45,-52,-62,35,-76,-58,-8,-61,-46,-84
+M63438_s_at,5642,4858,-398,-121,687,-248,-223,1541,910,-72,-74,-71,2087,445,1843,1789,5593,14774,314,569,-228,-14,-336,-94,226,601,331,15627,1991,15292,15833,1053,2925,3969,3170,1743,1970,3928
+M92843_s_at,1051,3298,816,1169,1531,915,1552,3135,2317,776,1149,1940,2213,989,1945,804,1881,442,579,1146,943,2456,410,1320,8510,976,1265,2116,199,13294,5393,868,14013,659,6532,1103,4703,5795
+M63838_s_at,1691,329,842,799,888,490,641,878,700,386,330,96,1760,1156,1432,1032,1222,503,755,1881,317,57,528,853,977,736,301,144,120,251,573,59,383,101,68,-43,216,1122
+M64269_s_at,208,219,139,164,32,120,198,343,208,167,95,27,95,194,160,249,374,225,177,312,329,154,1,93,52,173,359,161,74,255,236,260,349,62,234,102,238,234
+X51823_at,-840,-574,-1156,-909,-377,-926,-1147,-1563,-1038,-776,-479,-645,-488,-717,-494,-627,-1003,-470,-585,-304,-748,-935,-873,-1155,-225,-493,-1132,-1102,-1175,-1044,-797,-414,-646,-301,-400,-990,-800,-833
+X51823_s_at,69,37,57,-49,-28,-5,26,58,55,-10,-20,-50,-17,22,-8,26,65,22,-19,-14,81,-43,64,47,-31,40,21,-26,-33,23,18,-32,24,-22,-3,-36,-3,14
+M81886_s_at,-280,-201,-304,-257,-217,-266,-342,-305,-396,-120,-313,-194,-264,-320,-225,-202,-546,-238,-186,-326,-291,-262,-336,-284,-225,-334,-491,-384,-259,-406,-388,-403,-367,-158,-296,-260,-321,-381
+Z26491_s_at,982,1646,299,1008,865,184,1164,560,876,240,230,544,1829,867,2019,1889,4943,271,968,3960,2192,129,163,2560,1077,1308,658,2312,1067,1420,338,116,851,594,1225,1140,978,417
+M68907_s_at,8,109,147,8,46,88,68,107,104,-74,136,-20,79,-113,41,-92,1,41,45,101,-44,115,161,100,21,174,-28,-140,-175,153,141,160,135,82,39,-92,134,175
+S67247_s_at,93,-87,94,6,44,120,-10,76,97,64,84,14,84,-1,35,-1,103,106,84,-64,158,9,254,143,143,85,40,89,-9,29,-8,91,25,9,-57,18,-13,2
+M72885_rna1_s_at,-93,1718,-334,-276,-122,-49,-208,-239,-302,21,-28,-25,-136,-144,-126,-96,-424,-55,-92,-148,77,-125,9,-279,-14,-211,-167,-197,-137,12731,2953,228,144,-95,1330,-28,5,1673
+M73239_s_at,-3,20,46,-6,18,-92,25,38,19,-3,-20,-4,-1,5,37,16,180,0,-22,36,-32,-3,26,21,-9,29,15,-53,62,8,78,22,32,-11,38,9,25,16
+M74088_s_at,67,17,-67,-7,45,-26,16,0,-6,45,44,-56,67,49,96,208,-76,35,81,228,36,40,-7,75,28,-3,-7,-75,-19,-29,-100,-18,-120,-5,127,-40,-62,-124
+X63131_s_at,-26,-151,-273,-37,47,-481,-467,80,-96,-118,-68,-270,120,-174,-8,172,-838,180,485,541,-276,-95,-74,-150,-13,-50,-690,-59,88,-67,667,1149,-175,784,-401,-264,-304,-103
+M74715_s_at,885,701,729,964,447,739,1063,838,839,466,620,498,475,552,800,738,1207,374,899,1005,152,417,613,663,643,450,913,695,553,1146,1239,1067,725,630,1016,703,1098,1165
+U04285_s_at,163,418,-1,151,269,26,174,-125,531,106,112,11,452,29,402,193,1170,211,300,620,63,-132,-170,154,116,49,-122,202,48,438,298,47,112,301,701,222,156,-70
+Z31690_s_at,304,291,204,125,289,142,399,178,154,93,94,204,142,75,256,37,844,87,196,176,-24,28,138,119,116,-60,286,133,57,333,340,22,201,125,911,302,240,182
+M75715_s_at,216,265,242,115,242,58,109,116,215,148,559,241,136,184,220,256,236,159,248,411,178,187,254,232,173,246,278,532,144,606,486,482,788,383,424,265,234,634
+M76732_s_at,-476,-581,-412,260,-395,-35,309,350,-479,-392,-337,45,-305,-400,-283,-669,-1198,-250,-272,-610,9,-343,-265,-304,-253,-337,-652,31,233,206,139,-530,-455,11,-790,-71,-12,283
+X74929_s_at,-260,-380,-399,-50,40,-259,-58,2,-374,-59,-133,-63,-207,-147,75,83,-815,62,-202,-92,-224,-36,15,191,47,-160,-555,135,-113,-268,-501,14,-114,-91,11,-198,-225,-294
+M77348_rna1_s_at,-233,-150,525,-187,-67,428,623,251,149,-65,66,287,-121,302,-35,22,-596,106,-11,-574,99,177,450,263,256,270,-273,-21,165,293,116,522,-158,167,-680,432,-23,280
+X90824_s_at,736,1614,820,1345,272,126,48,1091,840,722,260,132,981,1105,1106,1135,1267,783,995,1748,392,740,74,973,835,1581,39,1004,-177,1490,893,1278,791,299,804,769,1829,919
+M77829_s_at,-416,-422,-781,-1025,-350,-794,-446,-581,-926,-550,-510,-544,-153,-572,-394,-159,-1322,-280,-447,-342,-192,-319,-689,-469,-215,-362,-1059,-726,-663,-340,-394,188,-511,77,-605,-429,-802,-875
+M80397_s_at,144,9,361,89,329,887,-52,220,790,422,343,109,676,65,511,259,665,457,240,122,-101,124,461,553,9,396,181,601,1226,754,-157,-321,221,42,-421,589,264,-198
+X62083_s_at,2363,3780,2625,2411,2013,1799,1707,2087,3608,2988,2588,801,3472,2710,2265,2568,5099,1729,1969,6326,3806,975,1354,2332,1862,2425,2339,1929,687,3953,1172,3373,2631,1430,3497,1425,2754,2804
+M81181_s_at,322,336,30,709,172,101,562,625,447,304,191,54,510,190,341,569,22,273,357,603,101,347,267,382,-30,234,114,479,769,341,143,384,262,42,131,306,419,402
+X58528_s_at,164,162,250,70,71,282,137,49,506,161,320,33,38,229,228,139,302,204,31,378,78,31,58,185,30,113,10,67,67,103,48,29,83,18,82,136,62,110
+M81182_s_at,-13,27,18,-47,21,16,36,16,306,74,148,1,22,74,44,51,47,84,40,128,69,-70,-1,78,10,-1,32,-52,-28,5,3,-32,-12,49,1,-47,0,-56
+M81695_s_at,695,812,810,599,282,711,556,1281,746,513,461,494,315,1030,333,426,588,666,250,284,137,401,613,513,439,416,430,1702,1137,2014,2683,974,1147,478,2279,754,978,1690
+M81778_s_at,-4,41,39,-15,44,8,53,-16,57,28,11,25,-1,56,14,8,106,-3,-23,26,61,22,34,19,33,60,98,-17,62,-8,50,43,79,-3,47,-1,15,-9
+X80763_s_at,530,473,480,447,309,410,552,670,559,396,404,298,269,408,261,449,694,375,410,444,289,381,474,610,417,361,790,746,613,493,497,511,522,305,331,426,506,665
+M83652_s_at,-70,364,-208,34,218,401,255,-100,521,-169,-276,252,4,493,114,-91,78,-163,-196,-345,82,-175,121,-183,-49,-65,-239,1338,565,2892,157,-245,1179,868,1537,1675,657,562
+X62534_s_at,1688,1642,2319,1745,2127,1579,917,581,3051,4232,2302,764,5202,1263,3090,1159,3158,1335,1889,2662,4622,978,2559,1547,1899,1933,524,907,1084,3073,1856,3213,2174,2937,1080,807,719,910
+M83667_rna1_s_at,-231,322,-452,-297,302,-10,-194,-320,-57,19,-233,-122,-184,694,-199,-42,-91,-106,-139,-118,-131,-231,-226,-133,-195,-142,-311,-23,302,3890,2921,153,1696,827,1036,-124,522,2182
+M83712_s_at,116,241,-36,-20,-30,28,75,50,46,49,137,7,-53,30,9,51,41,96,33,67,-4,79,98,-200,0,-220,118,-107,69,49,-49,-45,-33,-113,-27,5,59,66
+M84820_s_at,132,76,-21,154,209,39,196,43,283,-153,210,-14,-7,241,335,-52,196,118,12,144,177,70,231,93,26,14,-203,-45,-93,83,192,191,311,215,3,206,-40,29
+U84011_s_at,8,105,212,133,165,131,157,109,265,68,93,44,60,227,88,153,217,134,54,155,106,51,64,182,65,75,137,104,108,68,38,145,121,39,38,60,124,94
+X15673_s_at,928,651,1031,796,368,983,858,832,1148,416,656,484,548,736,531,802,1337,725,435,1062,379,443,545,752,643,674,1642,1028,1009,733,795,1113,1318,973,601,1179,1061,706
+X62515_s_at,502,-102,491,228,-64,236,310,208,94,-57,-35,87,82,-76,-10,-2,53,121,-18,-74,59,128,98,47,-66,39,1,-118,62,159,-44,116,170,-23,178,185,66,120
+M87507_s_at,-17,85,79,35,115,-23,10,-38,197,3,-44,61,24,100,136,187,-47,-22,21,-40,-37,13,-66,41,54,23,35,-40,24,191,14,-26,4,27,129,120,-9,46
+M91368_s_at,-460,-385,-997,-418,-152,-371,-420,-950,-666,-99,-168,-320,-294,-356,-370,-112,-1008,-423,191,-703,-283,-205,-292,-217,-420,-436,-485,-183,163,-477,-791,-217,-568,-35,-89,-170,-305,-907
+M91669_s_at,-12,107,128,120,11,144,226,122,268,126,-25,99,57,146,130,74,171,112,180,142,7,109,93,61,162,10,217,161,93,85,211,302,78,173,145,146,135,256
+X03794_s_at,120,25,247,-385,-146,-275,-386,-631,-321,-117,37,-166,-43,-129,36,-387,-938,89,-467,-342,-495,-247,-271,-91,-321,-26,-75,-242,-500,224,280,-351,64,426,380,-54,-566,214
+S54005_s_at,8231,10026,13498,6678,8644,8309,4824,5033,13655,8147,7035,3449,8020,4893,10267,11553,4551,5135,5426,14383,1821,5089,6288,7361,5669,8519,2816,4239,3291,5504,4355,2306,3532,3002,8761,6779,6504,3017
+U33202_s_at,-81,19,88,7,5,-16,-8,77,-31,-32,-19,1,26,19,46,23,65,45,-18,3,69,-69,110,42,95,193,79,14,19,140,-40,-5,-4,-26,-29,9,22,-47
+U33203_s_at,58,-30,120,66,21,21,43,68,58,9,47,-15,44,-8,31,118,77,51,7,46,2,-3,102,92,60,37,59,46,108,-22,73,-27,92,-26,57,-18,-18,64
+S57132_s_at,554,416,734,671,474,565,567,655,687,300,378,284,408,582,409,546,1009,403,474,510,139,196,317,500,360,424,586,677,598,591,364,475,517,303,418,541,552,469
+X57348_s_at,5,-69,-65,-50,-113,53,-70,-223,169,-438,-143,4,-387,-210,-117,-117,-91,-347,106,-259,-31,78,32,-125,-158,-74,-62,-177,139,-235,17,-72,-152,-69,91,-17,-63,-90
+X56088_s_at,-26,-7,-19,-10,12,-58,-36,8,-27,-26,4,-27,-10,-6,-5,-21,-14,-15,-50,-6,-38,-17,-24,-30,-30,-34,-3,-9,-7,-91,47,-13,27,-17,16,-6,-24,-8
+X75091_s_at,994,1096,1283,802,717,1427,776,707,1677,995,666,521,1228,915,1593,917,1554,401,624,1473,107,440,668,554,452,595,693,513,569,754,520,355,649,739,572,956,1294,670
+M94172_s_at,344,437,610,611,392,583,396,238,580,282,461,366,102,524,259,396,756,453,267,68,66,282,252,323,78,384,535,551,319,522,234,295,389,197,379,524,820,509
+Y10141_s_at,357,831,177,186,208,800,697,383,860,-193,207,342,194,430,125,13,586,193,228,303,-109,521,347,327,309,119,539,156,-432,-31,-5,865,665,-106,126,593,634,562
+M95585_s_at,4,-46,47,56,-32,-16,-15,-2,-34,6,-40,35,6,-24,24,-25,54,-19,-30,-4,3,-7,18,-7,-10,31,175,-85,62,-137,-19,-2,-104,-37,-39,-10,235,-35
+X68985_s_at,421,84,488,808,114,401,746,446,281,270,201,198,112,295,243,398,369,296,314,173,76,205,554,160,388,221,736,287,250,359,287,533,427,130,206,461,660,648
+S49592_s_at,815,952,1425,1159,339,1218,551,1590,1312,1004,1067,439,1193,697,859,709,1668,782,844,944,747,927,600,1026,583,1251,1137,1153,634,1474,707,991,869,422,853,495,674,1228
+M96738_s_at,-250,-290,-209,-1329,-124,-551,-394,-494,-400,-258,-209,-284,-51,-278,-299,-38,-533,-57,-112,-278,-449,-202,-864,-134,-113,63,-1381,-290,-177,-221,-411,-4,-116,-198,-405,-591,-306,-118
+M97796_s_at,860,2779,793,1709,1037,773,798,2019,815,748,278,6931,506,1976,684,227,801,839,374,2839,322,540,571,293,6466,1561,880,265,675,4276,1036,860,1577,740,3363,1398,1053,4382
+X14253_s_at,27,156,126,105,187,188,243,265,143,51,141,20,39,170,2,68,76,116,81,-103,1,-30,47,138,133,-19,-9,141,96,185,88,106,64,82,115,155,4,37
+X60299_s_at,-28,157,264,139,43,163,75,203,122,-4,61,22,35,192,-19,-33,188,180,-10,35,-52,-3,115,31,17,14,-35,-80,2,70,155,29,243,83,-68,77,158,79
+X59303_s_at,620,164,605,656,616,97,38,190,211,410,450,317,467,1032,183,585,522,110,302,915,-321,64,307,462,209,226,378,100,663,1013,17,275,398,129,497,243,359,48
+M98399_s_at,54,209,128,109,34,122,35,47,142,78,108,11,4,108,-46,58,171,62,237,230,61,27,53,11,183,-95,137,91,341,1600,737,659,309,444,861,1361,35,253
+S76978_s_at,-40,-5,30,36,5,-48,-25,-61,-11,-27,6,7,-19,-3,30,-17,-45,-32,-39,-30,14,14,79,28,-15,-65,-39,-56,38,221,-88,-73,-43,18,11,31,-83,-84
+S38953_s_at,150,382,256,151,78,321,374,256,477,235,324,28,211,193,286,382,573,247,158,155,101,160,326,367,-36,228,361,200,108,458,141,405,495,13,307,312,449,501
+X63741_s_at,-131,-21,27,11,-25,-108,-8,-59,-15,16,13,-14,157,-133,-8,-59,-60,-27,90,-98,-27,-34,-51,-28,29,34,57,-41,-62,-65,54,-33,130,-38,13,-19,-1,-15
+X66142_s_at,957,794,976,796,497,817,982,958,1058,757,721,534,558,751,513,738,1543,551,322,886,351,483,739,674,708,611,1103,846,656,973,538,837,968,468,839,147,589,1261
+X57809_at,349,70,-256,-236,90,-60,-112,-388,-144,-67,-72,-64,62,-78,-35,18,158,534,-111,-107,-64,-23,-85,-54,-47,-14,-168,186,-175,362,-28,-197,-18,-147,-65,-160,-195,-238
+X57809_s_at,4511,2861,831,1640,783,1093,1177,1460,636,21,847,366,1517,831,1380,334,4513,11498,797,951,308,737,748,888,766,1095,187,5379,889,8793,8254,673,1919,1180,1423,923,1328,2177
+S62028_s_at,-32,-42,-205,38,-8,-128,-124,-248,102,-8,-18,-86,-40,-8,-78,-14,-130,-4,11,-17,73,-40,132,-191,-30,-24,-161,-264,-194,-136,-102,-68,-112,-49,63,-49,97,-23
+S52969_cds1_s_at,685,553,939,717,300,451,682,794,1304,466,549,375,464,576,466,862,1100,674,580,884,296,566,537,753,476,552,445,991,632,1466,764,860,791,631,371,417,810,1267
+X65784_s_at,717,834,815,779,627,757,902,1024,883,262,759,254,778,535,770,900,1533,371,585,1665,382,482,704,857,705,694,544,917,680,688,462,922,678,297,444,357,1062,753
+S56151_s_at,1647,1105,2018,2220,996,2756,1581,1632,2256,1108,1443,1243,873,1289,1162,1325,2182,836,791,1624,303,1004,1649,835,938,946,1312,1567,937,2414,2180,1572,1818,639,1767,1225,2531,2553
+S57153_s_at,-106,-60,-175,-70,-18,-181,-13,59,-101,13,-51,-30,-57,-97,-57,-16,-21,-79,-30,25,24,-71,-41,139,-16,-34,-114,-232,26,-80,69,-14,-35,-35,-88,-58,-87,38
+U95019_s_at,60,79,-104,-33,42,-76,-110,52,41,94,19,-57,0,-56,50,143,138,5,60,5,-2,-34,176,19,-19,33,126,25,-7,79,85,16,19,-11,-32,146,110,36
+U12387_s_at,186,175,348,119,97,69,77,143,207,88,158,-20,105,95,149,109,439,176,27,449,127,40,191,150,127,54,319,250,218,160,73,112,164,46,67,146,222,29
+S62904_s_at,-230,-234,-44,-375,-63,-104,-356,-68,22,-70,-122,-68,-103,-180,-78,-35,-263,-279,-98,44,-163,77,-115,-246,-147,-263,-445,-134,-199,-7,-139,-376,-70,-41,-564,49,-172,-241
+S68134_s_at,3,-16,21,7,-21,-83,-11,-107,-4,-56,-11,-18,-21,-18,-30,-2,-67,-2,-117,24,-59,-61,-13,1,-12,-13,-53,-52,-113,-81,-79,-34,-86,-27,-40,-69,-32,-100
+X86401_s_at,33,-10,93,71,3,48,-1,181,116,66,46,21,-23,-25,64,40,400,68,15,151,4,14,-56,56,4,43,101,74,74,-17,22,80,-3,7,0,189,82,153
+S69272_s_at,483,452,131,336,905,30,28,113,42,251,-14,349,1091,243,905,1062,1729,452,1327,460,64,17,138,-26,1074,861,56,1778,1021,1510,247,-193,1661,185,1083,1393,1998,327
+S69370_s_at,-40,-61,27,-118,-11,-197,-1,-106,11,2,-1,-136,75,10,16,-130,68,-86,-65,23,-86,2,-112,26,69,-16,39,-110,4,-128,-164,-189,87,-82,-27,-62,-172,-107
+X51362_s_at,583,371,664,432,320,426,413,131,435,307,459,267,309,278,357,351,1914,349,266,396,222,330,313,635,305,353,633,520,461,542,312,355,450,165,454,351,755,460
+S72024_s_at,778,187,935,1575,729,1250,902,872,638,803,1511,229,491,1221,1256,546,2117,630,463,864,93,414,921,534,556,218,1079,511,382,1171,1876,852,1188,1422,1504,871,1029,1345
+S72503_s_at,1935,714,1397,1814,269,1429,2011,2001,1414,1058,1318,919,1415,1055,975,1624,2271,1189,1022,1445,718,1731,1261,1513,1139,1716,1611,1854,1589,2244,1389,1461,2046,900,422,1338,2054,3057
+U24056_s_at,380,269,411,438,241,341,766,1006,538,495,369,314,395,507,263,334,719,454,358,492,259,371,324,371,447,420,571,442,504,420,581,591,539,351,462,436,552,714
+S73885_s_at,929,314,930,845,401,841,1100,661,921,548,502,451,704,699,629,734,2956,572,529,1985,448,145,830,201,594,583,794,-105,-36,17,555,68,565,7,469,511,843,1855
+U31929_s_at,435,372,525,450,176,321,452,541,520,321,242,277,293,399,269,342,954,352,206,392,241,376,322,174,320,382,552,570,567,251,393,345,509,106,408,367,440,604
+U15641_s_at,244,355,-355,277,139,408,-331,-134,163,109,171,-327,-11,58,95,-145,-512,-214,161,-240,-363,-244,-132,226,-383,-202,-644,12,-252,164,385,98,-26,347,-226,5,278,109
+S75256_s_at,264,207,147,-93,162,-78,-13,-40,-80,12,-3,0,-53,153,-89,139,308,144,92,-21,-169,177,-121,-278,195,61,43,132,257,197,149,592,429,41,305,-129,275,459
+U33052_s_at,303,216,301,299,128,264,-52,325,147,67,354,215,137,95,350,143,379,80,244,175,27,295,265,250,160,173,93,503,519,154,256,265,161,666,30,155,502,110
+S75881_s_at,-236,-97,-119,-222,-89,-190,-134,-56,-202,-76,-178,-33,-109,-50,-158,-192,-230,-96,-71,-163,-146,-125,-70,-276,-92,-16,-51,-218,-122,-166,-117,-122,-124,-99,-130,-151,-159,-231
+S76473_s_at,198,81,320,238,94,181,99,259,230,95,145,133,87,141,140,213,254,81,116,114,114,116,176,169,174,160,120,223,206,238,143,198,240,90,119,133,275,227
+U05012_s_at,-226,-153,-130,-307,7,-231,-347,-61,-258,-217,14,-195,-37,-313,-223,-168,-480,-149,-135,-71,44,3,-129,245,96,15,-294,-89,-14,-44,-225,-19,-217,-94,-247,-290,-380,-286
+U20816_s_at,-277,-480,-583,-534,-178,-400,-603,-742,-469,-263,-331,-208,-261,-287,-277,-421,-904,-106,-287,-433,-342,-99,-311,-289,-381,-386,-553,-354,-334,412,-22,-17,-21,-231,-174,-71,-418,-161
+S76756_s_at,308,55,256,315,102,248,287,304,229,64,157,196,23,153,40,157,378,86,162,-22,132,150,188,241,132,-100,92,-4,235,154,233,182,160,-452,98,256,163,254
+S77154_s_at,133,275,3,68,17,-124,-3,176,76,74,162,636,13,77,116,84,-16,-5,325,64,81,18,134,34,202,1722,211,271,168,474,476,170,2157,82,354,142,581,2286
+U00001_s_at,-74,57,84,31,4,-94,-6,29,60,16,41,22,39,12,-9,38,66,48,16,18,48,0,-43,38,16,-28,104,-1,72,125,42,-27,49,-21,33,-37,47,6
+S78798_s_at,-3,252,218,-50,98,133,-48,287,378,89,71,104,93,55,44,214,247,111,16,356,118,115,70,267,-1,86,9,164,110,499,97,80,167,50,261,-41,24,51
+S78873_s_at,-38,101,-234,63,279,119,141,-484,-35,-19,417,53,155,366,27,14,444,-99,451,159,-114,201,169,128,247,15,-336,-103,-214,20,145,210,-71,213,580,-64,266,54
+S79219_s_at,905,338,327,175,339,183,215,191,179,130,156,183,153,223,135,522,248,294,186,500,337,83,146,321,243,117,214,318,122,225,188,209,268,31,178,241,407,197
+S79873_s_at,332,193,189,103,247,97,241,44,268,106,180,149,627,203,175,88,1594,100,150,410,241,70,89,318,51,98,71,340,52,426,164,118,210,293,239,164,219,315
+S80437_s_at,284,652,947,328,862,816,401,278,1063,671,907,426,685,762,549,416,724,541,474,887,91,415,473,953,340,647,386,806,151,697,344,363,496,231,852,289,528,250
+X58199_s_at,463,400,444,517,179,398,480,481,444,364,293,245,80,301,135,252,578,195,277,-79,133,190,315,313,275,245,-81,158,654,574,669,498,457,291,104,427,471,787
+S81243_s_at,349,461,428,397,184,240,473,361,275,263,209,-38,122,434,192,208,697,66,125,653,154,1120,0,162,579,266,347,312,620,637,706,612,944,311,462,332,565,185
+S81264_s_at,433,298,651,369,208,387,436,965,851,384,509,311,148,354,299,333,656,290,351,409,398,272,495,572,333,287,517,563,317,459,487,480,359,266,212,763,549,744
+S81737_s_at,-143,-131,-158,-232,-66,-72,-196,-587,-205,45,-13,-132,-129,-138,-142,64,-330,68,-176,-42,-304,143,-72,67,-61,42,143,-249,-254,-138,-375,-96,369,-101,-229,-292,-280,-310
+S82471_s_at,-23,86,43,28,44,72,15,-92,233,83,-18,56,48,111,5,59,129,52,31,138,58,44,74,34,36,66,292,140,247,-27,20,127,-104,53,106,79,255,63
+S82597_rna1_s_at,73,166,-128,130,173,-97,60,263,-127,-10,124,133,214,146,282,229,669,207,265,380,127,168,-37,151,78,83,20,174,132,-153,75,271,179,239,26,24,545,293
+S83309_s_at,35,183,185,242,120,161,80,149,49,77,83,112,20,217,89,46,168,64,104,82,72,168,144,43,145,204,373,149,113,125,66,188,-57,90,144,257,12,209
+S83325_s_at,27,0,-9,221,30,120,262,136,24,143,44,68,92,20,91,110,-17,-3,-9,-81,21,137,151,-7,-104,-45,136,81,50,99,212,-86,53,10,-122,183,325,156
+S83362_s_at,137,200,63,165,152,368,440,677,171,149,202,224,177,187,70,42,83,20,240,375,206,228,355,-19,162,263,148,314,324,140,-38,512,213,270,144,107,303,528
+S83390_s_at,-531,-588,-678,-739,-303,-553,-1008,-1000,-707,-410,-329,-566,-285,-138,-271,-461,-880,-606,-219,-393,-219,-359,-661,-302,-481,-378,-1168,-724,-771,-803,-773,-510,-596,-143,-428,-722,-675,-930
+S83513_s_at,910,680,1135,932,490,624,912,878,953,669,784,449,621,687,434,735,1408,627,530,816,364,690,607,605,667,729,1171,838,757,995,606,1029,813,380,632,691,958,1369
+U22322_s_at,-42,-8,-83,1,14,-3,-31,-91,21,2,6,-38,1,-57,-12,-17,32,8,-27,34,-3,-6,-68,-56,-4,17,-4,23,-93,-55,-66,26,36,-19,30,18,46,6
+X04347_s_at,7952,8200,7381,8007,8590,11252,4837,5901,13385,16096,14091,7776,11147,9518,11945,13265,14313,12479,13196,14974,21800,9801,9497,8801,8653,10378,11401,8905,6526,7927,11160,13784,13344,13433,8531,8329,7668,8583
+U00947_s_at,7544,9020,7225,6458,6756,5777,5502,7995,11534,7976,11076,3920,6682,8338,7083,7504,18345,5061,7535,17999,11922,9158,6915,8195,8190,6181,7674,9146,6925,6695,7801,10987,13673,7472,9285,6356,6778,9776
+U12259_cds2_s_at,-560,-462,-732,-91,-223,-421,-546,-949,-619,-257,-452,53,-343,-284,-396,-409,-1192,-286,-194,-453,-357,-426,-457,-441,-265,-410,-350,-520,-507,-921,-580,-487,-681,-130,-356,-192,-457,-826
+U02566_s_at,-303,-128,-353,144,116,-161,-273,-248,86,158,61,18,273,-13,326,325,-100,-27,338,61,34,231,20,58,242,195,-140,191,372,-312,-13,8,34,143,-261,92,-159,421
+U04806_s_at,243,899,296,264,210,147,159,53,241,283,197,33,-22,409,-52,187,426,-45,159,246,124,167,186,85,-113,197,153,273,302,-137,135,74,295,295,239,143,364,270
+X73358_s_at,1550,4103,2358,2425,1267,2905,2133,2463,3841,2357,4060,1215,1729,3828,1666,2082,2081,818,1416,2827,183,1260,2027,2298,1497,1022,664,1228,687,1437,1932,744,1653,1437,1283,1506,3565,654
+U06155_at,183,48,-25,-133,239,-103,129,-98,99,-51,-33,80,153,136,142,89,343,232,66,466,291,47,20,77,304,83,-247,-111,-31,-47,-9,14,-114,-41,-54,22,93,-83
+U06155_s_at,16627,13660,18802,16263,16907,23447,24680,22449,13611,18927,17281,19268,17921,15302,14709,16884,11993,18649,18397,9927,16869,13488,24282,15906,17608,16740,23878,16654,24399,19549,16257,18273,14845,17393,13465,346,17196,16938
+U08854_s_at,62,135,136,112,77,24,132,149,158,60,58,84,74,77,36,84,261,85,-10,106,61,71,199,85,96,84,369,66,161,245,50,75,171,66,275,73,153,92
+Z48314_s_at,24,-20,-561,43,49,78,-47,-64,72,-54,143,63,49,51,-86,-47,33,115,68,10,-348,7,-455,-307,106,38,-106,-511,-399,61,-2,-37,139,-41,-36,-117,38,24
+U29463_s_at,-86,180,0,-49,-3,-142,-90,-85,166,36,79,-83,68,27,19,-33,196,-9,19,33,-69,24,-47,350,9,31,-9,112,298,-106,-16,-88,133,42,112,-1,138,-104
+U07969_s_at,321,153,254,260,22,-213,238,116,263,155,22,-64,-24,180,104,199,290,11,-6,144,113,-180,-284,84,269,-107,-106,372,110,325,84,89,158,61,188,52,248,278
+U51010_s_at,-97,207,1007,-41,-132,-113,-78,-61,-84,343,-25,-199,-82,70,-618,-376,187,-331,347,542,-169,-83,-163,-93,407,182,-267,25,86,-368,207,72,102,85,-76,-102,-325,-69
+U08191_s_at,-385,-45,-148,-544,-114,-489,-312,-464,-77,-186,-80,-142,-104,-68,-340,-140,-154,-333,-266,-69,32,-209,-125,-104,-466,26,-370,-262,-550,-489,112,-173,-200,-221,-216,-431,-206,-521
+U09087_s_at,358,82,263,218,186,209,144,167,385,146,89,37,283,179,314,106,335,119,91,268,8,30,334,204,81,109,139,34,48,74,52,33,91,58,15,61,50,0
+U18271_cds3_s_at,785,167,839,584,504,588,367,452,1046,400,386,136,600,210,744,308,883,299,263,343,302,176,642,376,242,222,428,230,177,221,297,212,297,221,182,215,320,307
+U09178_s_at,-63,285,347,187,172,161,60,79,339,22,171,34,61,217,186,77,916,90,193,365,7,-291,5,192,-9,101,145,53,48,164,121,8,114,59,127,68,107,52
+U09510_s_at,595,1039,938,477,655,679,342,593,1075,690,1213,235,694,876,783,544,1041,564,601,1078,782,678,756,699,438,636,452,665,449,675,1132,1260,909,515,805,571,651,836
+U09716_s_at,245,305,533,587,173,224,278,157,160,224,242,268,221,144,179,179,698,102,177,225,136,196,332,358,69,201,406,209,120,287,370,139,171,111,378,230,167,356
+U72935_cds3_s_at,279,229,229,384,269,199,287,382,203,126,124,171,395,181,371,199,467,102,134,273,72,149,125,267,128,80,190,222,185,71,130,105,120,41,89,112,445,213
+U09820_s_at,827,467,846,656,397,337,747,898,834,268,376,268,880,601,694,440,738,263,366,881,416,298,250,989,291,235,398,598,459,439,192,203,419,119,210,298,800,398
+Z29066_s_at,45,41,84,68,19,5,21,0,106,153,116,-31,213,5,128,-32,114,128,51,39,262,6,113,30,7,30,100,11,-19,73,68,93,69,86,82,41,-25,38
+U11717_s_at,-236,-208,-428,247,-56,-87,-105,-400,-103,-375,-152,-194,-158,-333,-70,-186,-225,-72,-172,-392,-72,-172,-254,-219,-116,-113,-209,-261,-214,-208,-145,-305,-150,-127,-417,163,-452,-371
+U13913_s_at,-5,24,10,-26,17,46,-31,11,-156,-6,-5,54,-33,-33,-18,-45,-16,7,-25,0,-47,32,13,18,29,-38,101,-89,-9,-68,-64,-17,-37,3,-23,28,-9,-39
+U28758_s_at,-11,-3,-41,41,-17,65,97,0,-94,-152,136,110,58,43,16,60,-26,-2,-86,-79,37,70,55,-94,-12,14,-251,-148,-290,165,-58,-156,-134,-81,-390,96,160,175
+U11862_s_at,-266,-186,-145,13,-161,-110,-117,2,-204,-195,-39,-45,-206,-263,-151,-237,-527,-150,-47,-216,-78,-57,-227,-259,4,-106,-140,-122,-180,-240,-302,-2,-180,-69,-299,-56,-279,-264
+U27516_s_at,-50,165,218,-77,-47,-53,115,119,-117,13,66,-40,4,13,0,-106,258,144,-7,151,-16,121,49,52,-49,10,247,34,9,-135,119,97,-195,-57,11,1,37,-257
+U12424_s_at,14,-36,-78,-24,-14,3,18,-50,-736,-24,-12,-37,-3,37,-4,-34,82,-77,18,-43,-34,-5,-41,-46,-14,-4,-87,-39,-45,-39,39,14,43,-35,8,-20,-20,-15
+U29943_s_at,62,-51,166,94,20,-32,67,44,38,35,32,20,20,116,73,-26,56,61,-24,36,-8,43,93,103,6,89,59,39,60,-135,36,133,-37,41,45,43,62,100
+U12707_s_at,1618,1309,1772,1848,946,1445,1994,2455,1731,920,1311,883,1119,1830,1688,1032,2197,776,1055,1846,520,1170,948,988,1661,1467,1331,1658,1161,2510,1095,1527,1631,785,1618,1276,2039,2405
+X75346_s_at,202,577,-25,152,135,312,-206,-65,302,50,507,270,372,99,374,28,215,2,72,352,31,715,62,348,363,115,73,143,-274,818,507,397,823,352,864,162,526,793
+U13021_s_at,-437,-205,-680,-278,-58,-344,-351,-382,-220,-294,-387,-235,-165,-150,-156,-344,-402,-119,-178,-101,-198,-171,-492,-175,-335,-344,-359,-374,-343,-507,-175,-228,-342,-75,-218,-309,-455,-395
+U13696_s_at,-211,-224,-249,-261,-113,-236,-157,-344,-264,-99,-138,-114,-92,-266,-128,-222,-366,-105,-209,-131,37,-115,-167,-171,-277,-128,-314,-179,-117,-170,-457,-268,-152,-149,-311,-215,-341,-389
+U14577_s_at,-515,-367,-938,-819,-228,-266,-457,-758,-505,-181,-206,-317,-76,-253,-360,-232,-82,-7,-237,-71,-362,112,-336,-451,-126,-62,-383,-585,-226,51,-880,-298,-426,-343,-557,121,-498,-496
+U15642_s_at,307,153,135,93,51,71,58,287,153,214,162,15,215,148,48,112,270,155,74,393,98,128,229,233,60,93,255,96,129,156,97,28,145,31,75,92,134,185
+U16120_s_at,53,-11,55,11,-9,3,-28,-94,55,9,18,2,0,5,19,30,28,10,-65,44,-27,-26,-58,-20,-46,-63,57,-57,-173,29,40,-24,64,-21,108,-7,61,-12
+X91911_s_at,634,304,114,753,411,184,465,148,719,170,449,376,301,147,380,215,6913,271,80,262,33,17,184,566,1180,276,120,913,985,1570,307,487,701,294,2610,1309,657,636
+U16812_s_at,430,325,463,226,302,364,436,601,439,415,424,209,375,574,219,517,472,357,238,281,169,285,450,320,404,389,197,527,447,643,193,305,330,218,271,358,430,730
+U16811_s_at,108,139,-79,10,85,42,-25,47,-37,137,-24,11,80,153,-22,124,262,93,-69,95,-42,2,150,14,-27,118,372,-20,28,52,84,18,-33,59,263,-75,-111,15
+X84213_s_at,559,856,399,906,210,412,2303,1254,236,449,148,738,296,444,245,1051,1683,342,705,911,677,1027,330,860,351,344,2162,1053,781,591,579,1099,588,123,1074,364,406,1676
+X74301_s_at,980,90,38,514,347,30,171,578,-12,67,35,71,396,52,584,306,91,756,428,1874,29,274,110,325,169,325,192,108,125,89,7,60,107,81,113,20,144,100
+U18297_s_at,22,-81,-63,-123,5,14,-132,-34,-39,-59,-55,-44,-34,10,-41,-95,-133,-7,-65,-44,-14,-60,-34,-42,-50,-15,-43,-45,-50,-15,-101,-57,-35,-37,-53,-60,-52,-109
+U19147_s_at,127,83,-9,21,71,46,0,80,34,74,92,50,86,13,66,31,16,60,38,109,89,90,32,60,66,49,181,179,57,180,2,55,79,-11,140,100,-26,40
+U19252_s_at,287,218,663,254,411,328,156,523,338,228,331,84,115,200,189,79,117,239,47,383,477,377,119,328,181,205,287,497,351,800,157,201,193,39,468,387,682,312
+U19557_s_at,271,126,490,307,187,293,462,355,296,248,223,125,168,255,56,161,377,217,189,178,153,241,146,236,197,262,372,305,100,485,236,392,409,119,452,227,503,358
+U31973_s_at,54,-13,-71,-25,-3,0,-20,-4,13,-47,-22,-4,-10,-21,-48,-8,-73,-14,-51,-30,-26,-100,-11,-32,14,-65,-68,-98,0,-114,-5,1,19,-19,-46,-51,-46,-17
+U20536_s_at,16,-87,61,-149,-5,-110,-33,52,-9,90,-98,-57,1,-45,-68,-121,141,71,-106,4,91,-60,-66,87,62,-88,-37,-104,38,-33,-2,-89,-122,58,-40,40,-67,-177
+U20759_s_at,-39,-84,-189,-231,-81,-110,-176,-241,-132,-68,-64,-135,-82,-145,-112,-94,-283,-117,-98,-84,-137,-129,-169,-122,-106,-107,-81,-314,-274,-162,-173,-153,-125,-103,-138,-262,-247,-109
+U22314_s_at,-34,-35,181,163,41,131,226,32,225,90,42,-30,-32,-18,38,77,204,-60,18,-4,182,27,104,29,21,-24,161,209,137,-4,63,112,44,74,136,194,355,-25
+U22431_s_at,401,871,159,150,146,40,117,577,287,323,343,386,773,122,543,488,719,148,489,1991,1740,269,96,296,670,801,82,293,84,1116,840,455,669,391,900,121,267,1495
+U22970_rna1_s_at,-411,-240,4,-475,-217,209,-336,-479,1148,132,152,-14,-334,33,-68,-59,-215,-90,-141,740,29,-184,142,-267,249,-57,-774,-628,-132,-522,176,-1067,150,-161,-1007,160,-353,-66
+X78416_s_at,114,54,70,25,83,71,52,154,106,30,106,-20,70,71,72,121,269,127,38,126,157,105,45,118,156,168,167,131,0,89,84,83,136,30,80,85,163,191
+U23435_s_at,123,171,25,53,26,289,-67,178,207,130,197,51,16,136,111,69,99,35,64,125,61,149,170,123,86,57,143,170,125,0,128,124,170,21,37,85,105,175
+U23852_s_at,785,5871,12101,314,266,10224,166,592,13450,8081,9558,208,420,4940,980,1262,762,579,336,848,2666,614,5076,393,304,501,1162,596,305,367,492,378,355,35,153,317,763,781
+U24488_s_at,-839,-1018,-867,-664,-499,-330,-564,-1293,-1147,-771,-620,-472,-488,-696,-450,-915,-1278,-522,-654,-1029,-222,-482,-340,-621,-802,-755,-1112,-739,-899,-908,-898,-904,-689,-535,-1083,-349,-779,-1271
+U25034_s_at,766,727,1041,599,423,574,534,1185,749,501,399,304,414,222,426,420,1290,539,389,321,151,559,668,185,552,366,1004,549,343,834,618,980,786,293,597,510,817,1023
+U32499_s_at,-437,-315,-496,-24,-196,-8,62,62,130,146,-345,-183,-277,-464,-3,26,77,-160,-162,1,87,-304,-275,-427,-348,-153,118,-242,-266,-679,-470,73,-418,-234,-205,13,-536,-508
+U26173_s_at,352,667,239,125,576,-26,502,1677,553,276,139,780,338,118,341,447,771,678,356,3829,589,283,284,492,163,198,208,770,238,1575,1360,668,2253,1206,1423,703,1787,2019
+U26266_s_at,289,288,447,424,364,320,381,53,869,403,526,60,673,308,929,698,1060,358,310,1047,-67,-44,395,651,166,190,201,282,43,64,-44,-179,151,66,-49,-36,192,-303
+U26312_s_at,508,545,736,442,693,496,161,260,944,568,616,232,466,593,673,636,1041,295,409,1203,769,105,592,543,220,191,250,270,156,273,296,247,343,611,431,231,403,266
+U60206_s_at,30,-84,17,54,11,42,31,35,89,3,-24,-5,40,13,-7,-25,19,-38,-6,34,41,39,-18,34,-5,-36,84,-48,74,-122,33,-14,-4,2,-45,11,-38,2
+Z16411_s_at,47,330,-1,-148,124,-26,-53,-143,-82,217,-34,-54,62,-66,11,229,393,65,67,232,-18,-45,3,59,-93,77,-37,193,57,-37,-82,125,140,-117,-19,-98,-58,53
+U27333_at,-270,-386,-542,121,-245,250,211,53,-555,-309,58,225,-364,173,-284,-417,-1019,-333,-454,-823,448,-239,207,-90,-261,-223,-416,344,295,-471,-796,-652,-446,-416,-306,94,-448,-860
+U27333_s_at,-29,-66,-30,-235,90,-71,-136,43,26,-64,-4,-56,47,-264,154,292,-240,-77,23,59,-28,0,-20,104,160,27,-26,161,-26,340,67,-164,103,125,0,-73,87,27
+U27326_s_at,319,148,314,224,110,336,431,362,382,157,125,17,83,269,169,70,242,131,11,96,154,211,340,38,246,107,305,63,201,235,373,210,212,62,280,221,230,305
+U28488_s_at,35,-15,-13,-133,68,26,-72,-73,-63,-86,-79,-57,-31,5,-19,-112,-105,-122,-40,-17,-28,-20,-113,29,-73,-31,-156,-42,-108,579,-42,-197,-13,41,-40,-47,-50,17
+U75276_s_at,7,149,313,-307,146,-33,174,157,144,-113,62,-76,211,86,447,672,531,-26,139,481,218,252,-100,202,286,114,398,51,14,7,-8,212,8,55,46,94,82,44
+Z50115_s_at,399,497,209,579,652,871,771,185,991,495,499,307,687,238,700,509,453,1414,640,1569,254,393,725,473,626,939,355,211,495,597,225,60,584,430,2,422,326,17
+U30827_s_at,1564,1467,942,869,1520,992,1270,1048,1331,785,1415,626,2361,990,1911,1992,2865,388,1513,7317,744,852,835,1458,1087,847,491,1128,480,1891,1271,1315,1499,991,923,665,1679,2282
+U31201_cds2_s_at,-367,-195,-252,-204,-159,-3,-310,-109,-266,-265,-162,-160,-179,-291,-245,-278,-360,-109,-82,-200,-204,-227,-125,-103,-83,-213,-265,-1,-33,-118,-266,-91,-62,-31,-393,-129,-348,-111
+U45328_s_at,1121,1193,1706,914,1205,1643,930,706,1790,1403,624,742,1575,824,1196,1247,1599,889,634,2833,803,944,1415,1027,17,415,154,262,271,2121,1124,1397,1108,1024,336,1154,1575,824
+U31903_s_at,1049,1079,1021,1491,89,814,1824,1835,995,1119,540,600,1352,1245,843,1535,1948,780,1165,1718,1046,700,678,799,391,961,2422,1683,1673,1027,-160,847,1175,242,985,1547,1209,1666
+U41068_cds2_s_at,895,813,1069,505,561,746,1011,886,1140,896,661,478,519,807,534,812,1826,622,634,987,152,771,940,745,663,617,1170,1282,875,1103,640,1354,954,447,727,562,904,1210
+U32674_s_at,-5,-80,-51,-208,-28,-174,-90,287,223,88,-138,-44,-19,611,44,456,-106,45,196,130,2,-260,3,-134,73,117,348,-84,-139,-158,274,245,414,130,-319,-262,-46,19
+U33448_s_at,-1814,-1466,-2535,-1238,-1011,-805,-1737,-2275,-1888,-1291,-1412,-830,-1451,-1368,-940,-1796,-1754,-1090,-1126,-962,-624,-963,-1390,-1290,-990,-676,-2628,-1223,-1106,-2104,-1778,-2301,-1295,-555,-2782,-1863,-2064,-2131
+U90065_s_at,-73,-168,-150,-1,-207,-103,-82,155,-154,-86,-113,-109,-268,-27,162,-284,-433,-123,-132,-173,-326,-111,-28,76,61,-141,-330,-40,-52,-470,-127,437,-246,-94,-249,-201,125,6
+U40271_s_at,-31,27,350,-281,-18,385,-191,-89,323,-107,35,-96,28,26,39,-174,-546,-97,-143,13,-58,-99,112,-120,-8,-162,-690,-60,-144,-256,-116,-95,-10,51,-221,-90,-260,-178
+U43203_s_at,137,-6,34,139,7,90,100,287,202,27,10,68,7,128,38,5,220,9,80,4,37,86,606,83,105,52,45,-1,108,147,131,197,169,-18,-36,486,82,40
+X82850_s_at,-209,-252,-136,406,123,120,-137,451,-145,-142,41,-97,-165,30,333,-65,-783,179,117,145,9,-142,1001,-131,-121,-179,-497,-140,115,-238,672,65,121,350,133,945,142,187
+U67092_at,-133,-17,18,-123,-6,-92,-15,-103,-128,-56,-96,7,-61,-4,-58,-95,-88,-77,-124,-21,-132,-66,-136,-54,-31,-84,-35,-106,-103,-118,89,-152,-80,11,-80,-37,-22,-181
+U67092_s_at,2180,1475,1912,3866,1614,2674,3646,4560,2185,2097,1422,1914,2067,1694,2157,1714,3159,2370,2112,2131,808,1723,2173,1395,2609,1526,3005,2235,1755,4175,3870,2353,3612,1668,1562,2631,3743,5049
+X91196_s_at,212,31,203,126,96,108,104,158,149,154,67,18,35,79,44,99,183,121,73,154,18,26,131,159,62,93,176,148,127,52,39,65,95,62,82,2,156,49
+X85116_rna1_s_at,162,169,-18,199,334,117,378,571,-8,176,139,530,182,452,304,540,1263,203,1074,1071,675,177,417,300,559,342,7,727,1639,1096,3397,4465,2274,2195,478,983,1017,1999
+U33936_s_at,227,363,343,460,505,160,453,535,-113,256,213,145,183,365,616,351,660,524,147,686,523,176,227,495,227,196,602,249,293,287,323,193,380,475,459,298,287,302
+U34070_s_at,-768,-374,-550,-460,-255,-497,-203,-997,-507,-212,-320,-166,-193,-605,-122,-189,-242,-175,-273,-334,-321,-461,-416,-42,-222,-146,-370,-539,-218,-547,-511,-72,-194,87,-49,-521,-134,-136
+X89986_s_at,-11,112,-111,-137,-31,-72,-95,-71,-72,16,-1,-24,-49,410,-85,225,-224,-42,-37,-96,133,-10,-62,-146,-73,-53,-78,-5,-158,-61,-16,-96,-49,133,106,-52,-178,-162
+U40317_s_at,-294,-234,-254,-496,-95,-216,-260,-452,-263,-157,-203,-123,-236,-146,-75,-129,-650,-83,-111,-331,-73,-296,-216,-663,-145,-175,-261,-314,-420,-457,-41,-180,-303,-49,-207,-249,-209,-442
+U35637_s_at,142,4,-43,-27,8,46,8,2,40,-3,86,37,-35,20,35,1,97,16,-14,90,59,64,-56,46,28,17,9,-37,-40,-19,57,42,34,57,49,-75,51,4
+U35835_s_at,118,219,168,91,417,679,176,37,506,125,70,44,753,329,542,202,671,111,222,647,-2,-78,203,328,-7,-42,194,47,-16,89,115,-22,264,115,-35,164,218,-31
+U41163_s_at,-724,-939,-1532,-1433,-515,-599,-1524,-1607,-1247,-572,-920,-813,-672,-406,-688,-702,-463,-490,-572,-1046,-555,-231,-965,-696,-685,-611,-1671,-990,-952,-1193,-1083,-502,-934,-327,-1098,-22,-1232,-1288
+U36759_s_at,1152,1044,718,407,495,1589,660,1083,1865,1293,652,257,349,483,756,772,1785,311,432,986,669,103,2319,862,872,780,788,1104,925,952,744,319,1176,747,829,362,1103,1645
+Z69030_s_at,870,513,814,1509,747,1017,1073,620,1161,393,1093,362,455,1122,3265,804,892,682,470,886,1308,444,898,1322,350,435,564,617,399,637,747,479,453,741,469,366,474,1251
+X85137_s_at,479,259,419,419,308,531,383,379,826,294,514,104,739,311,496,266,677,393,213,230,156,150,480,359,258,247,295,227,334,516,220,211,373,227,184,235,253,473
+U38227_s_at,-144,-146,-241,-286,-85,-174,-149,-202,-74,-211,-96,-171,-129,-124,-96,-124,-337,-35,-146,-129,-113,-83,-110,-172,-74,-135,-98,-104,-182,-228,-232,-186,-174,-18,-175,-95,-232,-312
+Z47038_s_at,1056,1181,984,1009,477,1065,1258,1326,1455,566,1123,612,466,709,599,799,1968,567,596,889,549,778,986,1093,837,563,1012,914,1156,1058,1112,1030,1042,628,1068,838,1217,1402
+X81832_s_at,-884,-884,-863,-974,-600,-714,-803,-896,-1064,-584,-519,-501,-470,-518,-375,-452,-805,-434,-395,-828,4,-545,-628,-539,-493,-181,-923,-615,-827,-1542,-1547,-1234,-394,-491,-530,-801,-1031,-1333
+U40152_s_at,-19,26,-218,-376,14,-208,-171,-401,201,-147,-11,-25,79,14,49,47,-87,-7,-129,-7,-64,-41,-260,209,27,50,-20,-11,-43,-45,-126,-244,192,-9,-35,-20,-69,-286
+U74382_s_at,-156,90,6,225,-138,-21,-206,-107,-111,293,201,-264,123,-92,256,331,-476,237,209,368,478,-10,165,318,126,64,245,-27,-163,263,334,356,210,0,-40,-230,22,357
+X93511_s_at,234,246,195,126,154,151,65,178,218,166,216,100,127,256,284,99,169,49,51,149,257,231,142,251,70,75,168,101,151,64,133,111,193,98,126,94,182,120
+U40763_s_at,80,99,95,116,78,108,139,28,105,94,161,7,107,182,212,134,162,121,93,182,96,-11,119,69,76,22,101,-75,26,114,106,82,144,123,61,27,165,166
+U40846_s_at,141,246,382,151,224,144,267,347,185,159,189,67,153,209,168,220,376,203,207,263,64,136,140,175,184,317,289,344,117,439,94,120,205,46,280,190,318,184
+U76366_s_at,664,559,1451,860,368,1122,1023,926,1288,770,899,479,690,1064,656,735,1288,571,815,1017,-66,349,1107,708,542,399,818,1045,1012,631,473,509,714,351,854,790,810,726
+U41315_rna1_s_at,115,287,-127,-11,114,-192,-89,38,-62,-59,49,-185,68,70,171,76,238,148,80,694,-164,-11,47,96,56,-26,-97,32,-120,318,364,639,-1,314,335,-105,-77,250
+X76942_s_at,318,347,278,218,199,304,171,254,203,227,448,165,114,346,286,128,345,225,172,244,202,300,188,309,153,117,225,484,302,203,309,271,279,133,195,139,385,293
+U41767_s_at,1057,785,1147,1210,594,1219,1290,1394,1247,798,885,925,800,801,678,933,1582,825,747,853,359,754,1090,909,842,701,1176,1845,1122,2165,1424,1273,1474,716,1403,1467,1833,1836
+X96506_s_at,1608,2062,1768,1997,549,2236,1611,1541,2422,1783,1276,807,1112,2231,1919,1698,4059,1116,955,2136,381,686,1440,1225,930,1212,1669,1258,1517,2161,2311,2397,1920,1185,1581,2052,2046,1927
+U51333_s_at,774,180,1156,-52,382,236,944,1314,825,948,579,-110,690,100,444,763,288,915,622,991,103,643,499,781,586,705,-103,1296,468,3659,290,1377,1100,650,857,-24,218,1925
+U43189_s_at,295,364,216,216,194,147,376,365,284,248,349,83,638,205,430,281,751,185,136,893,657,479,421,602,321,421,378,893,288,591,246,482,618,343,272,269,309,757
+U43747_s_at,161,22,222,288,364,302,193,325,156,59,66,93,159,293,186,173,296,60,85,244,144,109,231,165,218,91,303,213,74,55,269,227,247,129,158,219,220,135
+U43916_s_at,-35,-25,-152,-2,184,-243,33,13,193,-233,-34,-45,-106,-53,-47,-116,418,-111,-93,-261,-7,-56,-56,7,87,-96,-237,-163,19,62,486,-24,3,109,1132,20,474,735
+U44799_s_at,93,26,172,120,181,8,164,220,637,64,57,63,93,87,267,138,145,109,97,205,-87,-34,123,240,93,101,64,15,137,123,127,222,65,202,40,100,155,69
+U45448_s_at,1624,238,1081,1223,761,474,1271,1971,654,372,444,638,827,675,1096,2289,3190,137,904,1102,542,2140,585,1045,1381,1342,1159,1249,1255,2119,955,922,1305,660,1259,1105,1618,200
+U46746_s_at,54,-137,-27,50,38,88,75,26,150,13,62,33,-46,-7,37,53,98,-22,48,11,77,-49,43,47,96,49,-151,32,-69,98,14,8,77,78,122,-1,56,-25
+X51698_s_at,-164,-873,-1074,-137,-203,-256,-157,-235,-2228,-647,-191,-31,-65,-875,-16,-452,-2147,-306,-302,-881,36,-113,39,236,-411,115,-639,-79,-105,-559,-129,-504,-678,47,-568,-215,-1111,-876
+U47686_s_at,273,290,485,205,103,435,181,314,382,172,281,137,41,380,93,180,636,90,144,136,39,41,241,140,221,81,297,109,146,192,7,109,153,91,192,133,361,157
+U48865_s_at,-521,-420,-762,-677,-213,-633,-796,-676,-852,-106,-581,-336,-8,-565,-233,-299,-706,-178,-267,-373,-87,-485,-617,-493,-474,-273,-702,-773,-706,-419,-647,-692,-580,-195,-613,-565,-592,-704
+U49020_cds2_s_at,683,121,120,605,606,46,988,419,272,79,117,21,645,214,912,1198,710,209,557,2415,286,108,75,1114,138,339,283,31,24,82,6,71,102,74,53,11,190,162
+Z49148_s_at,13947,17262,12195,15454,15614,12808,14373,10342,16742,16647,16439,16049,15161,17070,16082,17800,15259,16022,17446,16388,717,7573,14509,15083,17628,14942,15371,16406,14425,15127,16259,16477,16848,18644,16078,15389,16075,15768
+U49835_s_at,341,1439,13197,539,334,4306,431,1463,15253,3607,8086,215,159,592,1180,511,1804,353,260,436,233,159,1521,688,447,223,1250,671,949,377,454,912,385,229,846,268,315,656
+U49957_s_at,-63,23,75,-33,-4,-16,21,152,34,15,19,-25,-44,-3,49,2,49,15,-30,-62,61,-30,0,-40,-30,-16,67,-37,-2,2,48,163,78,10,25,0,177,19
+U50361_s_at,-46,1,15,156,50,-14,36,31,9,-18,7,18,-26,-13,47,56,-35,23,6,30,-1,-74,-45,117,7,5,-65,-1,-33,-3,12,-47,-28,1,4,37,-16,-62
+U50527_s_at,96,83,76,35,102,26,77,190,32,43,17,-47,156,218,285,205,495,51,97,305,18,-44,83,241,85,26,17,37,24,15,102,17,27,75,120,2,-19,29
+U52077_s_at,83,179,331,196,227,131,194,493,382,159,220,66,259,200,279,199,403,152,251,683,294,234,245,258,110,187,236,231,286,183,201,296,259,175,120,217,416,262
+X99374_s_at,-95,-37,-78,-24,-34,-256,-60,-10,-55,-106,-133,25,-25,-124,-58,-40,-113,-28,-73,-31,-48,-15,-43,-46,-40,-42,-18,-88,-14,-69,-113,-10,-85,17,-15,-75,-76,-88
+X92493_s_at,181,142,83,176,185,145,120,187,79,24,49,12,48,68,120,414,543,212,152,114,559,47,93,158,116,334,281,123,120,86,156,218,136,131,154,44,80,129
+U52696_s_at,5294,2533,5942,5126,2460,5313,4982,6172,3758,3134,3854,3394,2480,4358,2609,3572,4214,2632,3438,1762,4778,3310,5500,4737,3368,4031,4029,5137,4640,4069,3754,4281,3107,1192,1918,3199,4479,4177
+U52828_s_at,155,126,15,132,116,103,87,44,123,140,32,61,134,20,41,66,106,124,111,84,31,58,22,38,32,106,280,85,21,76,183,1,63,29,153,120,152,176
+Z54367_s_at,758,338,727,355,92,704,435,509,1181,274,666,186,378,345,393,514,71,324,9,118,259,269,319,565,312,135,323,842,-9,1780,1026,456,603,305,1539,527,1841,1263
+U54644_s_at,850,872,1281,1547,635,1175,1221,1286,1020,996,789,630,744,903,712,733,2709,707,706,798,628,570,1508,858,770,560,1372,1060,1209,1309,1019,1113,1174,446,1012,1050,1454,1517
+U66711_rna1_s_at,3036,3198,3048,2167,1830,2948,3029,2679,3472,2857,1622,2121,2514,3694,1319,2620,4427,1553,1819,3672,547,1265,2334,1834,2548,2146,2372,2644,2166,3281,3699,2198,3686,1173,1987,4248,3967,6609
+U56402_s_at,-73,7,-66,-55,86,-126,-117,-478,10,-73,-152,-68,13,-141,271,58,109,60,-30,381,-247,2,-36,-4,-5,100,-341,-106,-199,162,-32,171,32,193,67,-92,253,-452
+U59877_s_at,-958,-429,-645,-795,-237,-663,-623,-733,-663,-367,-523,-119,-294,-787,-387,-591,-1529,43,3,-660,-116,-427,-653,-476,-151,-497,-1234,-120,-72,-39,-282,-365,-447,-119,183,193,-31,-323
+U57623_s_at,561,383,514,587,150,344,530,676,549,264,338,321,264,340,188,387,563,366,154,370,201,315,427,300,229,326,663,356,290,485,440,553,450,191,216,287,549,564
+U57971_s_at,297,349,132,443,100,142,519,301,499,188,239,280,305,291,154,454,945,206,286,363,33,302,362,126,255,109,722,441,341,391,648,306,391,249,387,393,481,610
+X60787_s_at,-167,-217,-216,-349,-31,-167,-273,-160,-226,-198,88,-234,83,-195,92,-116,-185,-138,-85,55,-99,-99,-311,-141,-284,-125,-528,-352,-221,-432,-571,-327,-212,9,-292,-312,-299,-260
+U59831_rna1_s_at,405,287,156,300,204,238,379,305,560,422,161,130,346,314,166,429,414,400,257,471,117,115,328,171,323,368,267,303,69,563,277,474,478,111,382,286,490,715
+U69140_s_at,78,65,31,120,160,30,89,-2,892,61,18,-8,28,97,143,84,134,-26,38,179,121,10,-26,150,21,27,-39,-17,-52,86,86,237,-18,115,73,49,174,-9
+U60808_s_at,-10,-43,-131,-126,-58,-96,-211,-121,-291,-100,-78,-60,-26,-85,-138,-101,-285,-104,-146,-87,-59,-111,-43,-140,-113,-90,-104,-190,-144,-208,-100,-133,-35,-150,-82,-40,-152,-175
+U61276_s_at,233,219,768,87,114,94,257,242,356,164,457,109,100,130,113,192,156,403,134,330,316,207,167,326,154,398,352,599,478,676,177,675,299,111,167,239,239,841
+U67122_s_at,857,1775,1026,272,463,769,181,335,1301,795,1692,500,772,782,722,759,1205,362,278,1333,915,443,594,765,557,354,111,413,235,498,773,525,834,692,636,435,612,796
+X99586_s_at,236,269,282,46,128,94,87,116,334,187,346,110,133,176,162,147,340,119,63,311,51,120,129,182,178,110,120,76,108,166,203,102,234,161,133,65,162,166
+U61397_s_at,673,1297,745,266,368,328,263,301,932,661,1157,317,650,578,720,691,1226,307,388,1497,1726,206,419,585,389,492,377,309,235,450,396,477,491,480,410,245,375,255
+U79261_s_at,95,-307,-312,-510,26,-572,5,-152,384,-164,231,-400,-137,-254,-133,39,-185,-293,-63,-292,297,-6,-366,-120,220,181,-492,221,9,8,-524,819,96,-177,-462,142,-167,378
+Y08417_s_at,2,26,74,40,31,0,-10,169,99,47,12,-80,17,51,-50,4,59,65,38,35,24,-45,9,3,18,26,128,31,79,107,38,9,30,-11,59,-31,54,107
+U72263_s_at,90,224,45,55,89,-3,-57,-88,28,-16,82,61,114,16,108,107,285,1,29,222,76,60,13,-4,32,0,-132,-72,-76,185,25,17,131,17,134,3,75,-95
+U67368_s_at,110,108,-3,24,70,24,33,43,77,28,58,43,24,75,36,-34,187,2,31,91,98,-17,1,131,97,30,23,16,173,28,91,82,37,14,-9,52,55,-1
+U64573_s_at,49,51,193,110,-8,32,119,85,109,59,12,24,26,105,0,83,166,-14,33,9,62,-3,28,89,52,48,147,-20,91,-14,38,24,72,15,66,43,-4,112
+U65416_rna1_s_at,945,460,1139,1050,458,727,1277,1334,969,753,847,472,1074,533,717,715,1211,642,863,1175,585,821,826,898,640,658,1132,1061,913,1187,1230,895,889,436,636,510,1028,1559
+X56687_s_at,232,377,330,258,217,659,609,386,595,123,187,25,447,436,416,283,500,28,-4,335,-81,61,410,280,-7,331,240,40,43,-28,156,198,200,-17,-222,151,655,-1
+X00437_s_at,153,12791,-591,-882,-448,28104,-1129,365,14290,15987,18275,-340,-318,16154,151,-279,-565,-90,-307,90,-17,-440,27822,-129,-316,-376,-378,54,-452,-761,-954,-765,-397,-448,-1017,-576,3028,-329
+U66726_at,-857,-1081,-1354,-1238,-420,-1033,-1092,-1310,-889,-651,-684,-860,-511,-503,-562,-446,-1310,-613,-575,-800,39,-714,-818,-398,-660,-315,-2079,-581,-610,-1032,-1137,-653,-1029,-467,-912,-1289,-1528,-1324
+U66726_s_at,29,42,130,40,28,85,87,-19,68,2,53,5,20,54,8,5,88,17,68,30,68,41,18,38,-1,6,89,9,4,59,-11,67,60,-2,121,62,51,32
+Z70276_s_at,-51,5,17,26,12,87,26,86,48,72,63,-17,-23,52,65,-50,95,35,39,18,9,0,-15,-40,-4,31,43,-148,-2,27,58,43,45,-29,51,32,89,81
+U66828_s_at,717,593,969,679,415,727,532,694,773,536,516,393,475,719,360,674,898,510,611,599,382,802,704,542,414,510,791,589,454,790,466,653,895,303,572,431,788,908
+U70064_s_at,570,443,473,668,355,654,571,784,651,460,293,425,366,525,343,487,1056,353,387,459,464,194,492,624,428,369,625,670,605,543,318,375,417,134,409,691,540,569
+U68105_s_at,5692,7041,4085,6490,7195,4109,4844,3574,9175,4488,8199,4124,4793,10548,8161,4602,8703,4437,4253,7540,8507,3089,3930,10035,4173,3857,4216,8488,4753,6348,7928,5145,6446,5244,8005,5608,6462,8054
+Z48501_s_at,8418,11569,9738,11464,9349,12415,8502,7148,11771,7696,11587,7889,6958,14111,11899,6535,14654,5751,4661,9427,2707,4033,7859,13925,8183,4737,5503,14917,7757,17609,15160,14977,15315,7780,17064,11692,14497,17712
+U68135_s_at,64,48,77,88,55,44,13,151,72,-7,42,-14,24,67,9,54,79,35,16,40,18,47,75,56,31,-4,87,-54,84,17,39,65,74,17,22,53,96,119
+U68162_cds1_s_at,18,-18,313,-101,106,19,122,280,252,124,4,-41,167,65,123,59,275,182,-14,0,147,71,81,-43,20,121,228,-20,55,226,-4,56,70,71,80,-40,346,139
+U69126_s_at,490,759,410,368,423,1381,483,551,1378,508,1758,294,681,1130,1351,538,1517,670,925,1696,994,477,417,883,294,1193,245,1193,1031,741,900,993,1287,769,292,1178,1195,1107
+U86755_s_at,9,-44,-45,174,-3,99,137,61,9,-28,-10,80,6,38,0,166,-3,16,73,150,-113,18,83,-162,33,34,-294,29,-16,-168,-114,71,79,18,-248,3,-20,81
+U70439_s_at,4531,4411,5133,3426,2889,6022,2434,2443,11509,7743,7021,3328,5589,6059,6117,3248,10539,4197,3413,7516,7540,1233,5838,2978,3708,4559,2404,3589,3243,5372,7113,6496,8446,6143,4108,4485,5092,5455
+U71203_s_at,407,274,269,269,250,289,184,517,481,200,393,183,188,320,210,212,550,136,211,287,113,209,148,340,176,-22,164,300,81,75,344,465,374,223,448,249,388,185
+Y07565_s_at,92,-31,100,203,41,53,80,40,136,72,22,27,73,-9,107,84,129,47,55,36,-44,-24,15,166,81,60,228,137,81,81,93,310,178,75,72,153,63,143
+U72509_s_at,230,179,271,208,402,140,569,119,1148,159,192,195,-10,178,309,-189,663,273,50,391,359,150,245,333,328,-2,793,276,360,111,69,222,521,335,222,558,479,658
+Y09943_s_at,-2563,-1747,-3284,-3303,-415,-2804,-3505,-3881,-2500,-1428,-1184,-1342,-820,-1420,-1688,-1644,-2871,-1501,-908,-1343,-468,-1672,-2152,-1237,-1287,-1655,-3559,-1626,-2104,-1556,-1910,-2379,62,-1553,-1335,-3088,-2302,-3199
+U72936_s_at,514,329,378,455,333,184,537,467,455,76,213,80,1771,451,583,706,1538,266,489,2008,416,292,146,648,179,294,289,189,113,119,77,109,226,58,137,95,272,89
+U73167_cds2_s_at,-14,-215,-221,35,55,-200,-599,23,106,-59,85,-91,10,147,-171,4,-552,-87,287,229,53,68,-986,130,265,32,-1334,-130,-269,-120,200,526,184,182,-220,-13,136,242
+U73477_s_at,338,1092,1111,366,528,1468,569,311,1035,1308,113,86,930,1767,1097,1165,2051,-8,601,1120,-62,204,754,845,267,228,120,859,322,1081,815,418,1093,969,1255,1066,1297,131
+Y09392_s_at,56,233,337,337,103,391,509,658,259,112,111,265,102,1113,36,-29,250,150,86,255,12,312,58,270,336,21,222,336,230,95,433,318,147,109,234,197,170,157
+U79528_s_at,1611,1369,1577,1503,945,1712,1712,1128,2241,768,643,905,948,1652,1047,1162,2115,370,923,961,595,714,1242,823,1068,883,1531,797,844,1546,1556,1248,1723,327,897,528,1556,1641
+U75309_s_at,-84,39,-185,-31,36,32,-45,32,61,3,-18,-8,77,-2,-28,-19,80,-9,-62,1,3,-48,-30,19,-47,-47,-67,-17,-38,5,5,-1,-26,31,-14,-13,17,23
+U76764_s_at,3586,3290,104,466,944,167,273,-89,784,289,346,2269,875,453,406,575,1000,293,1476,132,-18,487,241,750,1247,4776,-337,1118,-21,1293,444,-19,2158,346,2321,469,2238,1027
+U79115_s_at,-260,87,-87,89,123,-225,75,124,-82,-43,29,-153,31,-6,-97,-325,-248,-340,188,273,-83,48,-49,54,-43,128,-209,-73,108,-99,25,26,118,9,-32,-32,89,82
+U79667_s_at,-146,-196,-307,-413,-83,-208,-178,-286,-324,-15,-225,-192,-232,-273,-183,-78,-453,-224,-186,-253,-28,-120,-191,-271,-241,-231,-403,-361,-259,-343,-221,-209,-239,-83,-220,-214,-306,-286
+X99897_s_at,-750,-581,-705,-823,-288,-842,-823,-1036,-934,-468,-297,-262,-370,-648,-314,-474,-888,-372,-513,-491,-383,-515,-663,-515,-548,-350,-813,-600,-545,-649,-471,-558,-735,-175,-632,-487,-976,-924
+U80987_s_at,-616,-482,-713,-694,-281,-689,-705,-976,-603,-349,-545,-415,-358,-491,-364,-380,-882,-421,-415,-386,-224,-355,-471,-584,-384,-362,-799,-690,-661,-663,-571,-651,-654,-325,-557,-558,-702,-836
+Y10262_s_at,124,160,299,99,162,200,149,347,174,91,107,83,30,73,95,43,254,47,3,202,-82,172,193,180,115,49,198,199,146,9,100,-48,263,22,477,82,302,109
+U82108_s_at,380,307,488,398,147,344,455,734,494,407,183,185,255,117,269,-40,682,301,244,380,317,213,-102,-5,351,320,298,288,384,551,605,386,456,219,565,408,613,787
+U83239_s_at,2876,1708,2618,2120,1416,1797,2355,2748,2478,1510,1316,1646,1262,1676,1230,1449,2981,2043,1529,1577,1305,2061,1700,1636,1882,1703,2081,2217,1954,2529,2062,1806,2274,1089,1844,2045,2559,3715
+U83326_s_at,-7,-41,94,5,48,-26,-25,-8,86,-27,24,-51,-43,3,9,-28,-16,-2,-38,20,41,-7,-121,22,4,24,-12,-28,72,-76,47,24,-22,-19,6,-41,-6,87
+X99393_s_at,116,99,167,59,118,144,168,190,171,109,64,-17,105,61,81,133,325,149,56,187,107,146,47,140,120,183,380,79,84,190,17,248,199,-17,137,188,189,311
+U83598_at,32,178,222,657,179,362,221,445,50,262,300,283,-47,85,263,13,287,232,16,125,86,2,467,70,354,-78,120,55,149,-41,416,599,75,265,54,173,424,586
+U83598_s_at,220,-44,94,-19,-70,-158,196,167,-69,1,18,0,-42,314,32,-127,305,79,82,44,68,-22,79,45,47,52,148,93,19,172,-21,-52,-68,155,-114,129,24,-1
+U86759_s_at,666,391,1012,712,-93,101,836,610,-67,398,267,390,109,253,166,-156,485,-95,-217,-215,-133,-465,649,801,58,-205,940,637,406,852,313,181,227,-30,256,920,359,315
+U90543_at,-110,-349,-286,-311,-125,-485,-515,-431,-347,-224,-150,-320,86,-237,-158,-243,-539,-217,-317,-242,-237,-43,-379,-166,-189,-116,-525,-316,-295,-257,-868,-835,-209,-504,-424,-337,-412,-701
+U90543_s_at,458,383,582,489,292,462,488,370,1019,391,295,559,418,284,307,870,535,319,141,463,122,230,326,313,378,516,208,710,177,906,446,359,297,713,633,371,463,1197
+U90552_at,-217,-174,-223,-246,30,-535,-732,-235,-432,-172,-33,-331,71,-64,1,95,31,-48,136,321,163,-364,-115,45,14,81,-339,-326,-490,-324,-420,-375,-388,-222,-469,-393,-324,-437
+U90552_s_at,876,589,1369,1266,711,883,1130,1283,824,349,816,488,945,1754,2069,822,720,640,1104,2168,1190,320,501,829,481,1090,882,173,269,613,324,403,115,279,401,338,1021,828
+Y07827_s_at,8,-29,-10,-160,-37,-72,-11,-142,-90,-30,-37,-34,-14,-25,-35,-17,-82,-33,-46,4,6,-18,-26,-58,-67,-23,-53,-54,-40,-111,-110,-71,-18,-47,-132,-20,-24,-84
+U92314_s_at,-394,-686,-419,-846,-368,-608,-599,-406,-592,-228,-295,-357,-282,-111,-359,-317,-1471,-349,-75,-533,-204,-265,-205,-299,-332,-347,-215,-447,-84,-256,-471,-358,-331,-408,-643,-238,-668,-455
+U92457_s_at,-516,-1008,-674,-810,-306,-592,-1149,-1043,-983,-200,-148,-354,-106,-495,-421,-96,-2004,-419,-4,-1087,-594,31,-558,-217,-400,-560,-1053,-986,185,-469,-884,-1483,-1010,-420,-683,-507,-1243,-375
+Y08265_s_at,594,612,866,711,472,1075,752,725,701,593,782,521,422,450,746,729,867,470,408,691,333,702,813,803,473,420,796,1002,615,1188,1035,752,678,426,582,664,800,961
+X17644_s_at,-203,-9,-351,-320,208,-140,-369,-223,-152,-229,277,-221,-92,35,58,-189,-269,-93,189,451,1,-52,-302,-149,40,-253,-602,-250,-153,-166,-196,74,17,137,-126,-279,-240,-83
+X58822_rna1_s_at,-83,-296,-188,-157,-116,5,-25,16,142,-132,-179,-21,-133,20,-138,-114,-45,-70,-211,-90,1,-122,-85,-132,-290,-229,-61,-190,28,-89,-70,-120,-189,-63,-254,7,-138,-252
+X05839_rna1_s_at,-113,-59,-237,-95,-44,-26,-127,-55,-206,-126,-118,7,-35,-7,-58,-119,15,-72,-88,-113,-66,-36,-157,-77,-123,-47,-76,-152,-12,-213,-78,-70,-53,-179,59,-68,-22,-116
+X04470_s_at,-31,-289,-289,411,-77,-83,-193,-322,-237,-96,-186,37,297,-277,198,-404,-626,-19,-107,-693,136,-70,-119,-83,-251,-221,300,-85,-257,-1,-292,-178,-155,-30,516,-61,504,135
+X04706_s_at,-122,-208,-85,-186,-69,-126,-144,-265,-173,-60,-121,-66,-104,-91,-70,-89,-217,-4,-39,-149,82,-120,-134,-170,-140,-78,-136,-149,-129,-228,-39,-91,-121,-134,-181,-164,-131,-166
+Z11518_s_at,101,30,35,116,145,149,1,16,216,44,236,79,110,123,210,119,-52,59,187,339,0,56,30,194,28,126,23,50,117,86,62,-11,104,66,93,53,35,41
+X06700_s_at,154,97,103,34,30,94,157,149,93,65,95,80,1,33,94,6,110,51,14,40,66,85,112,20,166,40,211,82,110,130,79,93,134,6,92,128,55,110
+X12530_s_at,612,104,-3,-182,13,-16,-72,19,149,-37,-49,-113,207,-32,63,3830,-14,1725,3907,31,22,-17,-66,-8,-69,814,189,-123,4,32,-242,-83,79,-123,-100,22,-165,-105
+X07619_s_at,91,197,166,83,25,521,110,199,33,-149,64,251,-184,-8,-16,-49,-105,36,-19,-281,199,350,188,-16,9,-109,-265,-92,149,-35,141,266,-71,-137,79,166,-152,24
+X65965_s_at,677,2566,337,272,370,321,223,1644,494,359,703,1622,484,230,306,549,1489,216,607,2015,1289,1269,381,70,1512,860,150,469,290,17703,13557,767,1786,668,8583,558,1268,7501
+X13100_s_at,106,-23,225,77,2,67,97,109,172,37,66,-21,67,68,20,49,170,102,4,87,66,14,100,63,6,98,161,82,84,94,70,129,111,-46,24,26,96,162
+X14885_rna1_s_at,-76,-6,-138,-65,-5,-65,-38,-139,-56,-79,19,0,-48,-46,-23,-89,-86,-77,-54,-17,-6,-6,-1,-25,-5,-26,-12,-42,-14,-57,-27,90,0,-45,20,-6,-102,-122
+X52426_s_at,143,-632,-682,-116,-583,-42,-618,-299,-597,-361,-253,-159,-460,-45,-417,-192,-531,-53,-480,-603,4,-181,36,-27,162,132,140,-546,-334,-391,-454,-108,-380,-149,-401,-43,-609,-376
+X14690_s_at,78,-71,86,-53,-19,-40,-100,-58,98,-79,59,44,-13,107,-18,48,120,-7,-25,-22,184,209,-100,51,21,-33,145,118,60,71,162,103,-13,-34,-36,70,19,117
+X15954_rna1_s_at,-494,-87,-612,-565,-47,-551,-223,-668,-783,-373,-517,-148,-493,-139,-245,-127,-211,-380,-221,-90,-424,-317,-448,-212,-72,-78,-145,-365,-331,-114,-191,-302,-156,-243,-631,-570,-213,21
+X15729_s_at,2840,3719,3169,1939,2747,1911,2438,2166,3915,1834,4007,954,4673,1944,2988,4266,5065,1213,2367,7414,3597,2376,1987,3169,2358,1652,1308,3502,1466,2966,1972,2414,2633,1629,2388,1512,3472,3379
+X16260_s_at,143,9,76,-15,60,113,-73,-158,-9,152,128,-56,136,-87,-53,-158,-150,124,-22,42,193,128,93,2,124,207,384,153,-64,83,109,-21,36,253,100,-31,-146,56
+X16504_s_at,-610,-250,-896,-799,-336,-741,-662,-1266,-837,-602,-577,-379,-384,-511,-419,-541,-388,-426,-432,-571,-186,-511,-685,-542,-259,-307,-974,-744,-767,-875,-894,-634,-751,-443,-367,-1241,-915,-1023
+X16660_cds1_s_at,-1713,-1469,-2091,-1714,-909,-1596,-952,-1313,-1125,-736,-1186,-1037,-601,-756,-967,-759,-1351,-539,-561,-751,-1010,-1263,-1350,-1270,-1155,-1257,-1032,-1895,-1505,-1021,-1551,-1367,-830,-606,-762,-1501,-2222,-1125
+X70944_s_at,1002,1594,1693,1052,1126,1353,742,1229,1752,686,3315,931,1620,1159,1445,1049,1757,357,1568,3370,504,1090,1504,1422,766,919,930,1587,675,1746,1354,1631,1520,904,585,1191,1604,1376
+X56681_s_at,11038,18550,8398,5763,7880,6691,9313,17826,14471,17685,18093,12006,12034,7974,7810,5024,13170,3790,12336,15673,14895,16299,10721,9081,19908,15023,8854,15573,6927,17446,16136,18118,20011,10380,18433,11400,20909,19907
+X60955_s_at,-172,-149,-213,-273,-47,-275,-208,-404,-266,-158,-121,-156,-60,-112,-104,-119,-189,-96,-114,-108,-151,-160,-36,-52,-33,-106,-179,-179,-262,-176,-264,-159,-33,-66,-234,-156,-208,-253
+X53296_s_at,460,460,180,505,81,243,504,307,402,307,321,363,186,306,198,197,642,241,98,289,96,452,480,209,338,232,345,460,471,2573,3588,304,629,182,1497,455,517,1573
+X61755_rna1_s_at,185,-223,242,-22,-30,-291,-117,-668,211,-372,238,-183,-347,-744,-808,-91,113,76,-362,-17,123,-181,91,-375,-281,475,-1448,79,-639,136,-528,-664,146,-321,-771,-680,-207,793
+X53390_s_at,907,984,862,1177,775,1065,868,973,1424,591,449,375,919,897,1002,913,1590,529,570,1723,457,241,1020,855,671,953,686,716,800,721,578,757,1002,420,688,684,918,1020
+X55037_s_at,700,977,1033,825,259,1246,870,1505,1101,826,370,537,309,1368,411,441,1093,437,421,776,247,370,904,312,413,368,469,586,714,404,702,791,467,246,467,562,765,1007
+Y00451_s_at,255,188,99,228,426,58,181,115,223,169,283,143,183,234,331,179,328,281,69,281,208,108,64,317,179,132,76,483,149,669,366,284,230,275,2153,251,187,684
+X58431_rna2_s_at,424,368,717,537,170,577,586,589,724,379,415,201,191,283,172,450,790,432,252,478,423,346,463,576,542,534,506,969,428,967,882,758,590,1454,773,732,704,1012
+X59932_s_at,1976,1238,1143,1374,1402,1155,1861,1533,1679,507,930,527,2318,1971,2488,1672,4014,1157,1091,4577,823,1025,1303,1267,973,2667,445,1264,694,2224,895,928,1219,707,1164,1559,2636,1192
+X60104_s_at,-577,-579,-627,-769,-168,-606,-198,133,-716,-402,-570,-375,-523,-168,-363,-613,-453,-327,-165,-1233,-24,-228,-110,-97,-555,-577,215,-596,-115,-449,-775,-51,-313,-189,337,-405,-592,-566
+X63522_s_at,-293,16,-279,-180,-26,-122,-141,-242,-200,-138,-148,-47,-17,9,106,-229,-203,-116,-91,-41,-6,-187,-167,-166,-90,-84,-223,-31,-43,-299,-86,-134,-173,-38,-122,-147,-11,-153
+X74874_rna1_s_at,786,1354,644,633,394,702,813,884,897,757,1269,304,1086,784,1214,580,1066,290,487,1283,592,591,1010,1081,624,932,555,870,432,1054,1372,1799,1479,550,1543,506,920,684
+X83492_at,534,610,563,792,145,1074,699,737,691,138,326,491,91,397,257,326,442,204,214,162,269,347,307,395,392,245,597,469,718,486,812,581,406,119,460,537,528,595
+X83492_s_at,165,150,245,33,90,92,38,62,169,190,118,114,150,199,62,119,522,144,53,29,2,66,119,39,78,180,280,198,211,226,-29,162,115,14,61,70,187,338
+X83490_s_at,-66,30,96,42,43,56,62,34,113,100,23,47,16,132,17,-29,196,59,18,-17,-3,83,62,1,1,26,15,114,105,310,296,95,149,49,236,136,94,145
+X89101_s_at,637,328,483,839,226,483,687,680,588,429,327,369,242,459,364,448,632,343,368,815,208,376,590,270,767,283,425,586,877,703,934,1240,715,634,304,812,927,1535
+X64877_at,133,158,173,123,158,136,181,59,63,31,110,57,19,40,46,119,342,49,89,128,-57,-5,144,-3,156,116,225,47,125,316,158,105,87,54,97,83,136,109
+X64877_s_at,-60,-23,-14,-47,-19,-35,-53,7,54,30,-2,14,0,-33,-27,11,33,-11,-33,-23,29,-44,-74,-5,-26,-8,67,20,-9,-100,-1,-44,-21,9,13,-35,-49,-18
+X66276_s_at,288,253,480,190,127,252,336,298,350,150,246,90,147,252,183,304,1114,340,187,517,156,62,235,431,274,293,206,478,293,585,233,203,483,147,375,142,462,608
+X66894_s_at,760,659,1025,580,413,743,830,994,1099,384,703,431,436,557,503,559,1326,433,488,786,309,527,663,613,623,575,935,749,706,746,688,668,711,392,780,457,746,861
+X98337_s_at,-28,0,14,74,35,30,3,-67,13,31,4,-2,31,23,19,5,56,59,6,36,11,-11,-11,0,82,72,81,113,76,56,29,22,39,-6,48,20,56,23
+X69116_s_at,151,123,338,66,43,96,63,37,148,53,-6,38,53,69,42,59,197,80,6,118,-27,58,72,34,10,26,104,10,117,44,78,42,91,41,91,20,24,141
+Z25521_s_at,1201,2302,3242,1145,1824,1863,1270,800,5407,1055,1727,606,914,1146,1832,1079,4516,662,1228,2118,930,614,1018,1135,560,976,736,2036,608,1044,818,1189,943,1008,832,639,2013,848
+X85781_s_at,195,37,242,53,126,23,161,245,-74,117,117,51,197,62,56,120,118,45,24,-2,122,160,207,117,119,212,215,196,146,-59,49,87,111,21,42,138,118,51
+X86428_s_at,-523,-535,-756,-701,-362,-533,-808,-1064,-710,-605,-448,-468,-331,-192,-454,-290,-876,-339,-424,-488,51,-575,-465,-447,-215,-443,-1196,-294,-536,-628,-665,-299,-479,-299,-413,-663,-824,-664
+X74987_s_at,63,50,77,25,76,30,35,115,160,84,26,84,110,109,45,3,286,178,64,286,122,-162,110,113,43,55,-14,80,81,124,42,121,24,71,143,122,164,177
+X76223_s_at,-44,9252,17495,-449,-177,13526,-653,145,13158,5588,8361,34,-294,-458,-382,-330,-766,-251,92,-629,-212,-115,7781,-169,-187,43,-624,161,60,-450,-222,-168,-410,-153,-322,-75,-118,-39
+X77567_s_at,-229,192,299,-381,169,40,324,28,-247,131,41,28,211,237,383,-143,343,111,-40,-34,69,5,-383,153,-72,15,86,53,-221,215,21,224,-107,-51,132,-24,344,358
+X79200_at,336,568,613,544,310,693,154,55,1240,526,626,418,159,399,252,340,1239,199,498,405,454,1966,573,526,180,537,-57,856,72,495,440,443,294,340,785,600,455,876
+X79200_s_at,32,20,-53,-14,0,16,3,-107,24,-49,-24,-7,-11,-19,10,-58,-65,5,-19,-8,-22,-79,-28,10,-30,-58,-50,-28,-36,-1,-66,-5,-64,-34,4,-26,-7,-37
+Z34974_s_at,-464,-206,-595,-360,-133,-314,-527,-613,-202,-236,43,-14,-196,-145,-163,-254,-80,-46,-242,-203,-129,31,-186,78,-173,-179,-1,-144,60,-360,-628,-467,-281,-195,-450,-172,-301,-687
+X79683_s_at,126,66,200,95,28,81,191,104,172,83,22,182,134,30,61,116,141,171,94,80,-24,71,151,9,120,59,186,133,-103,237,60,126,197,-11,181,62,86,184
+X97267_rna1_s_at,2323,1238,1982,3947,3324,1710,1488,2215,3420,723,703,672,3260,5964,6147,3774,3511,1654,2352,4281,-88,1075,834,1826,1168,4314,1813,270,1084,-723,183,664,739,574,-140,788,2009,146
+X81836_s_at,20,-40,-36,-125,-63,-46,-8,188,3,-62,25,-27,-82,14,-27,-28,98,-41,-119,22,21,-99,81,13,23,23,165,-72,-115,-189,-34,19,68,-161,-67,-17,51,6
+X82206_s_at,357,352,485,420,381,352,159,604,580,335,796,146,440,411,383,318,635,275,151,589,249,371,205,456,306,333,253,340,281,551,558,1005,488,366,393,334,378,486
+Z70218_s_at,155,25,-159,17,8,-44,-15,131,-123,-3,-1,24,-44,67,-84,-195,232,-32,19,-121,1,-49,-34,-51,53,-179,170,-53,-88,-76,-174,-96,25,-97,-2,-24,75,-164
+X83301_s_at,-60,-100,-86,-232,29,-44,-21,-31,-93,-113,-88,-139,35,49,4,-11,61,-97,-15,21,-94,-98,-201,21,-19,-152,-84,-2,-50,-92,-94,-160,-68,-66,-103,-122,-182,-197
+X83535_s_at,-1820,-1720,-2448,-2795,-955,-1753,-2629,-3697,-2156,-1462,-1365,-1590,-1119,-1868,-1104,-1717,-3536,-794,-1552,-955,-667,-1743,-2078,-1505,-1473,-1183,-2176,-2245,-1750,-2180,-1994,-2329,-1838,-889,-2044,-1888,-2466,-2693
+X87871_s_at,-232,-243,-333,-153,-169,-311,-31,-293,-333,-97,-261,-202,-260,-173,-202,-198,-248,-125,-141,-248,121,-283,74,-213,-200,-129,231,-181,-170,-372,-325,-172,-374,-198,-274,-158,-295,-397
+Z49825_s_at,1125,1054,1787,757,230,1319,1293,1566,1085,746,990,548,524,985,626,1703,1734,1224,388,1516,702,1183,1054,818,785,599,1392,1549,1127,2928,1159,941,1711,516,506,1052,1343,2371
+Z69043_s_at,2560,2083,1009,1092,1512,967,835,827,3764,1300,2555,2147,1766,1588,2724,2648,2226,891,1073,3421,545,1012,790,1386,1372,2161,973,1538,752,2256,2144,1359,1042,1898,2099,1780,1580,1312
+X90846_at,706,544,1053,851,209,956,814,1500,872,317,454,610,215,630,354,308,626,282,252,237,371,367,640,478,448,334,688,619,853,923,783,774,656,159,479,732,478,770
+X90846_s_at,-3365,-2731,-3408,-3642,-1375,-3197,-3343,-4689,-3541,-2187,-2330,-2627,-1827,-2661,-2295,-2123,-3716,-1325,-2245,-3100,-1494,-2334,-2830,-2326,-2534,-1860,-3184,-3581,-2702,-3357,-4439,-3512,-3383,-2782,-3549,-3300,-3846,-3781
+X95240_s_at,-37,-8,20,-56,-16,-53,15,44,-23,-27,-5,-38,6,-1,-5,-85,21,3,-99,-60,1,-15,13,-5,-16,9,-61,-33,-4,14,-12,-67,0,-69,-13,-66,-50,-18
+X95632_s_at,212,111,157,-126,-14,250,-21,34,322,77,161,21,4,103,55,36,-76,34,-47,52,398,3,193,96,0,33,18,61,-146,-50,-31,52,-62,-2,-126,5,59,55
+X98178_s_at,119,215,192,112,57,99,275,173,240,99,185,54,-125,153,150,83,118,71,28,96,162,40,227,76,43,41,331,149,93,41,100,191,250,139,54,155,208,103
+X98534_s_at,1126,860,566,433,255,665,557,625,829,216,420,445,527,793,577,254,778,446,32,609,119,193,189,190,383,362,383,696,247,1302,1129,537,445,199,1364,579,1146,626
+X99886_s_at,72,64,72,59,36,24,152,167,126,99,32,44,65,80,78,78,135,133,13,72,133,39,134,40,103,111,186,50,81,107,28,51,70,-5,102,88,119,123
+Y10514_s_at,82,21,44,-51,-24,-80,-45,-43,20,62,-20,-20,32,28,46,119,-31,74,10,27,47,7,125,63,21,79,-1,42,-14,-20,-23,18,53,18,-68,1,134,0
+Y10508_s_at,-108,-134,-67,-132,-46,-165,-117,-190,-108,-15,-79,-54,-34,-30,-43,-22,-180,-58,-72,-137,-37,-151,-53,-110,-18,-56,-228,-160,-117,-116,-6,-113,-46,-63,-137,-10,-104,-129
+Z11899_s_at,611,448,582,558,330,629,776,935,577,509,462,423,474,475,618,606,1130,381,436,1139,202,329,473,361,256,496,646,543,642,840,432,614,529,213,481,427,686,1038
+Z35402_rna1_s_at,172,171,604,351,110,252,386,265,99,118,219,109,109,233,188,299,286,337,73,359,189,198,256,178,245,318,499,273,223,190,178,496,180,118,303,230,297,198
+Z48519_s_at,112,106,116,-65,40,76,-21,11,43,-7,52,-83,29,-50,74,110,125,67,76,63,0,-75,51,-3,58,-6,134,73,103,9,-3,10,119,2,176,-49,35,187
+AF000424_s_at,3156,5192,708,-337,545,1815,-342,-406,1046,810,390,1126,700,4880,912,799,2405,-97,465,-264,-22,-409,-102,-109,1565,3130,-680,687,504,2573,1234,-71,591,1292,1845,3850,4082,326
+D83174_s_at,695,628,502,856,610,590,705,733,520,442,591,429,604,637,727,857,1218,618,480,932,317,408,440,545,499,268,910,919,524,740,608,574,585,301,873,585,1119,782
+U46006_s_at,211,0,13,731,439,23,1203,38,5,9,6,58,313,-46,810,124,-48,-33,128,590,137,35,30,1658,477,61,-31,-5,36,-19,14,-66,1,-1,-5,44,25,-28
+HG3546-HT3744_s_at,367,81,596,468,582,323,408,218,541,94,52,-5,336,287,611,368,553,73,255,396,-8,86,222,345,106,-78,82,82,4,257,115,144,144,90,92,125,155,64
+HG4677-HT5102_s_at,135,61,486,139,201,362,120,175,418,115,270,281,228,314,291,277,-78,256,22,357,283,247,188,369,47,146,78,420,367,398,186,206,318,360,164,198,163,265
+K02882_cds1_s_at,314,581,692,604,152,428,488,88,549,384,231,293,410,405,351,522,358,1249,143,114,269,325,351,602,243,526,533,842,180,586,317,1,200,50,229,350,785,219
+M36430_s_at,1250,1024,1901,1510,1350,1961,1213,1496,2577,1659,1816,998,1464,1084,1647,1911,1955,889,1046,1347,297,432,1018,1506,823,557,1164,643,389,1984,1527,752,1313,971,2087,1667,2503,1657
+M95936_s_at,640,658,564,865,641,753,337,412,439,487,501,70,619,613,627,633,1780,656,393,1343,66,661,391,653,600,629,1010,497,79,1302,712,833,700,915,386,232,681,1512
+S82297_at,9712,9336,11727,10177,10411,16421,15907,13493,8893,11949,8079,15497,11377,9068,8694,10876,7736,12914,12498,6580,1971,12986,8296,8384,11552,9245,11815,9007,11349,11444,10228,10041,9451,15533,8770,13264,10601,9960
+X89399_s_at,1912,5774,4381,3752,3687,4415,2265,2224,3206,3642,2700,2583,2789,4330,5308,3486,5890,1719,1218,4926,6,1959,2747,2947,2938,2370,1489,1484,726,4234,1081,250,2324,2149,3505,2729,5162,1481
+HG3996-HT4266_at,-1047,-607,-945,-1204,-558,-1433,-1019,-1191,-1200,-463,-831,-721,-342,-749,-716,-612,-754,-568,-473,-361,-459,-727,-742,-472,-728,-261,-862,-811,-692,-1321,-1057,-1001,-790,-679,-869,-782,-1025,-1066
+M21305_at,831,27,2419,617,286,62,164,703,-15,869,95,5,116,37,96,725,-17,3174,110,1659,3821,398,28,163,119,6116,829,615,500,350,19,2453,-31,34,-92,78,708,-98
+M58460_at,-36,3,-14,-66,-23,-99,-114,-82,24,39,106,-4,-32,40,-11,-2,-50,-66,-25,19,52,-1,47,-69,27,-22,-120,-46,-137,-51,38,-81,-31,-11,-130,-171,-33,-31
+S77582_at,132,41,107,76,85,135,38,46,31,53,65,41,61,116,19,120,262,77,89,61,112,103,68,42,80,28,128,128,120,35,124,109,59,7,45,56,84,65
+U33880_at,-51,-14,23,-77,-9,-49,-57,46,-3,-19,-3,-1,-24,3,-15,-21,-22,-13,-68,-30,36,23,47,7,-27,13,84,-62,-4,-105,53,-41,34,-18,35,-10,31,-43
+X14474_at,144,182,132,179,40,53,119,59,110,53,2,-12,42,86,38,-58,242,53,-12,77,144,35,15,-13,72,87,87,43,-26,97,91,137,25,-30,172,58,69,26
+HG2147-HT2217_at,2901,2218,2602,2304,1413,2414,1976,3034,2982,1979,2277,2329,1381,2879,2111,2004,2892,1536,2065,3652,6812,2296,2173,2548,2581,2238,1826,2884,2697,2520,2956,1823,2629,1585,1734,2023,1632,2279
+HG2147-HT2217_r_at,-13,-80,-270,-242,122,-3,238,-257,130,491,-97,-1,59,150,-129,332,508,378,-450,-204,141,-86,210,41,157,215,28,717,810,-494,-511,-314,215,53,295,28,-81,-1310
+HG2171-HT2241_at,-1420,-1228,-1237,-568,-555,-1632,-1737,-1499,-1057,-894,-1070,-1350,-1088,-1207,-1482,-1209,-1109,-765,-1057,-771,-404,-1000,-1073,-836,-869,-577,-1836,-1046,-690,-1091,-1149,-1139,-1165,-835,-1521,-1381,-1551,-1263
+HG2171-HT2241_r_at,-1382,-1778,-704,-638,-818,-2322,-3123,-1823,-960,-1369,-1638,-2307,-1067,-1352,-1692,-1223,-1909,-1591,-1171,-1032,-727,-1203,-2072,-1424,-906,-741,-3733,-829,-1322,-1515,-1936,-1842,-1432,-1040,-3251,-2353,-1970,-1541
+HG2239-HT2324_at,-878,-781,-847,-880,-198,-729,-732,-1146,-1019,-153,-666,-444,-215,-617,-781,-169,-2828,-21,85,-467,-715,-363,-516,-741,147,-138,-1157,-9,-38,-340,-784,-343,-333,-106,-1156,-502,-838,-432
+HG2239-HT2324_r_at,708,708,603,765,435,761,614,562,297,718,257,794,778,-4,473,713,1809,78,596,995,-82,618,514,481,562,137,1273,473,348,982,533,567,478,731,1107,723,950,695
+HG2365-HT2461_at,12,-175,-42,-294,-100,-17,-68,2,-213,-149,-188,-191,-44,-172,-128,181,-973,27,-144,-361,57,30,-22,109,-124,-134,-280,-213,-60,-178,-593,-212,-208,-253,-359,-205,-146,-127
+HG3033-HT3194_at,-974,594,-1527,-1283,-606,-780,-784,-1376,-1028,-1169,-368,-436,-270,-1485,-649,-450,-2348,-467,-531,-975,-557,-204,-1438,-315,-953,-604,-100,-957,-995,-415,-1759,-486,-585,-327,-2150,-736,-1218,-1001
+HG3033-HT3194_r_at,1326,1569,1903,1915,1664,3088,2071,-605,1226,2106,2472,1733,1680,906,152,1024,356,1320,2192,2675,448,1892,3562,956,1698,2565,-2154,1538,4034,4227,1342,484,2056,2312,-849,2096,2272,2164
+HG3115-HT3291_at,65,-5,-27,214,61,88,82,67,7,-94,-51,120,15,99,350,-58,51,67,-2,32,-22,71,-51,42,33,96,-134,33,-9,7,68,22,-59,22,-16,-17,359,195
+HG3565-HT3768_at,-897,-1402,-1210,-1191,-650,-1595,-1389,-1239,-1540,-928,-788,-1010,-485,-1295,-934,-763,-2656,-653,-759,-867,-568,-640,-1299,-1162,-774,-665,-2229,-1453,-1541,-1291,-2233,-1690,-720,-729,-2067,-1301,-1375,-1433
+HG3565-HT3768_r_at,594,281,801,890,366,259,1018,2953,201,68,319,-48,218,286,245,484,-78,304,1425,959,249,812,47,320,1747,432,145,356,1219,188,2592,3923,510,932,-473,371,785,2125
+HG3731-HT4001_at,28,191,177,-249,34,-268,40,86,120,25,65,1,151,116,17,91,115,-80,23,51,-42,108,11,-7,146,201,294,68,108,93,39,9,53,-57,-81,-247,-21,141
+HG3731-HT4001_r_at,-151,22,-371,-20,-126,-62,-26,-377,-123,28,-130,-308,-68,-187,-200,-202,-374,-81,-98,-34,-208,-179,11,-98,28,-62,-289,-199,-274,-201,-227,-449,-143,98,-150,-20,-259,-135
+HG3991-HT4261_at,-407,-708,-639,-204,-37,-245,-233,-383,-663,-196,-396,-139,-231,-459,-501,-319,-1218,-298,-215,-255,-14,-363,-180,-252,-274,-291,-677,-451,-464,-608,-416,102,-499,-195,-776,-115,-560,-459
+HG3991-HT4261_r_at,2333,3957,3043,3460,2856,7669,7389,4658,3337,3125,5356,6420,2564,4265,2261,5206,3369,2934,3206,4453,4231,5380,3892,4925,4840,2402,4955,2912,4698,3270,2489,2883,2417,3086,4551,4033,2737,3086
+HG4340-HT4610_at,-62,-56,-35,-182,-53,-154,-50,-136,-104,-96,-80,-44,-43,-54,-76,-118,-168,-19,-38,-40,-107,-48,-58,-36,-40,-82,-143,-145,-173,-243,-124,-34,-74,23,-160,-115,-168,-225
+HG4518-HT4921_at,-173,-136,-230,-95,-29,-80,-124,-134,-229,-70,-117,-1,-77,-54,-77,-106,-203,-73,-55,-155,0,-147,-45,-63,-119,-127,-123,-87,-9,-75,-149,-195,-125,-51,-291,-96,-289,-247
+HG4518-HT4921_r_at,334,294,214,254,335,240,228,308,263,285,287,91,29,149,191,213,294,224,212,186,226,281,104,407,169,239,236,161,33,124,45,212,161,129,201,-92,326,224
+HG4557-HT4962_at,317,658,331,244,377,305,297,358,249,236,675,194,596,399,465,463,735,230,238,1122,1083,359,345,504,311,308,234,580,394,250,190,420,261,323,208,261,505,368
+HG4557-HT4962_r_at,217,304,120,215,244,183,141,32,264,297,334,150,409,273,339,222,377,128,226,485,765,162,167,338,236,270,114,426,209,304,129,337,123,289,147,99,308,414
+L11672_at,8409,6711,10145,6873,4278,5711,5368,9592,6743,6125,6089,3503,6150,5791,5106,5962,10631,3049,5056,10630,7314,4586,5526,8166,4571,8838,4770,9891,6182,4373,3865,4794,3737,1676,4225,3576,6023,6253
+L11672_r_at,5056,3888,3584,2355,1252,1954,1557,5202,3421,1287,3894,747,3844,3367,2333,2999,3260,591,1836,6103,5118,1540,2735,3159,1514,3629,1743,2473,2229,721,685,1322,794,663,1051,873,2653,2892
+M21388_at,-302,-130,-396,-284,-99,-394,-425,-257,-288,-176,-217,-156,-107,-203,-149,-136,-485,-136,-155,-284,-166,-111,-203,-240,-163,-147,-220,-314,-24,-154,-225,-211,-173,-53,-207,-156,-181,-296
+M21388_r_at,6027,4025,6681,5768,677,480,2453,5532,6511,1026,2158,592,374,2527,283,645,6310,549,663,4090,998,1509,516,1905,1147,885,2581,5405,1625,5384,3719,4207,4509,1157,4007,2384,6927,10161
+M55422_at,629,298,728,490,335,485,685,685,561,432,275,113,245,408,268,442,937,363,325,362,228,502,393,221,368,254,930,447,627,607,476,310,553,163,463,580,805,837
+M96132_at,-101,-123,-266,-121,-126,-37,-78,-88,-327,-114,-164,-54,-123,-147,-87,-145,-370,-43,-91,-153,-101,-235,-231,-346,-56,-201,-42,-262,-423,-264,-179,-164,-203,-133,-84,-146,-224,-282
+U57341_at,203,499,440,969,167,120,700,3742,108,53,340,126,166,612,82,224,131,68,3715,2522,354,1067,-100,131,2374,673,195,452,2380,287,5455,5439,767,2133,409,201,1195,5345
+U57341_r_at,6078,5383,7160,7160,3449,6364,6793,7210,7441,4454,4589,5093,3342,4884,3847,4164,7496,3007,4157,4623,2441,4326,4673,4161,4659,3329,6562,6384,4773,7579,6354,5804,7326,2608,5235,7617,8587,8402
+U90546_at,327,58,301,170,279,254,38,328,73,14,4,43,92,736,967,-21,-124,49,-29,228,243,-70,34,292,31,106,-114,-26,-14,-22,-139,-83,15,-7,-34,-71,7,-104
+U90546_r_at,351,144,390,359,320,184,361,107,279,15,176,80,137,539,545,-118,48,66,-145,193,27,342,45,340,-14,163,269,47,120,83,-252,41,72,-78,177,69,260,24
+X87344_cds10_at,378,45,377,220,221,72,315,155,512,143,411,-22,285,144,8,270,219,280,65,260,-13,177,258,292,170,226,42,373,271,749,65,299,334,14,-16,154,20,505
+X87344_cds10_r_at,931,240,1641,1403,339,1838,2065,2535,-290,1248,807,135,164,0,-42,919,423,2027,1067,-31,432,495,1497,813,127,575,1104,383,1442,1750,-625,2271,489,-303,235,684,-775,1474
+X98482_at,-3,77,95,-76,74,48,25,55,17,54,20,68,106,-6,18,-12,40,5,13,83,-21,3,-20,54,33,-25,7,76,40,25,72,42,14,-39,17,-68,69,-84
+X98482_r_at,13665,16658,15573,11275,12465,27089,25427,19436,7485,18678,18795,13817,15440,15294,14117,15431,11945,16256,14616,15843,15421,11499,17999,14915,13847,15195,20237,9395,16601,17907,13632,18447,14104,6080,13791,18190,10872,9752
+HG1067-HT1067_r_at,-1779,-1268,-2493,-952,-372,-1529,-2364,-1220,-1292,-683,-862,-753,-549,-1756,-693,-756,-1440,-849,-146,-915,-239,-1140,-756,-1603,-1000,-682,-2465,-535,-488,-1438,-1155,-629,-965,-458,-1281,-1391,-1152,-925
+HG2566-HT4792_r_at,-1401,-3906,-2918,-3270,-1787,-4257,-2214,-2808,-1471,-3066,-2313,-3148,-2439,-2464,-5836,-2126,-5785,-1748,-1945,-4466,-1370,-727,-2730,-1973,-2705,-2228,-6305,-1555,-2197,-3297,-2950,-2500,-2061,-2185,-5266,-2742,-4177,-1708
+HG2702-HT2798_r_at,-4333,-5639,-5728,-6593,-2225,-6563,-7260,-6968,-4847,-5408,-3961,-4722,-3840,-4057,-4401,-3230,-7318,-2348,-4244,-5617,-3203,-3720,-4888,-4034,-5163,-3460,-8898,-4551,-4054,-6814,-7007,-5954,-4285,-3464,-7239,-6454,-2551,-5615
+HG2887-HT3031_at,-19826,-17930,-27182,-23396,-10339,-21658,-24024,-27570,-25171,-12500,-17480,-15256,-12854,-14937,-13380,-10492,-19523,-8692,-11572,-13838,-7397,-17179,-14937,-17368,-17377,-10652,-20406,-17310,-16281,-27398,-23673,-23645,-20376,-9501,-17580,-25491,-28400,-27811
+HG2887-HT3031_r_at,-926,-724,-1454,-1354,-523,-1164,-1423,31,-2417,-586,-629,-1774,-920,-745,-1141,-934,-3025,-608,-783,-1035,-264,-166,-1060,141,-426,-61,-1517,-1210,-1173,-782,-2199,-837,-2345,-788,-1149,-1273,-1805,-3047
+U34301_at,-411,-457,-463,-339,-56,-101,-367,-782,-527,-202,-431,-346,77,-116,-58,-59,-579,-206,-185,-364,-507,-413,-298,-398,-628,-484,-646,-579,-300,-419,-301,-171,-493,185,-430,-402,-254,-394
+U34301_r_at,561,679,328,432,556,435,179,292,536,345,494,293,488,623,557,353,596,461,561,664,186,402,433,424,619,436,348,667,288,724,759,484,658,594,453,258,499,750
+X94563_xpt2_r_at,559,279,516,371,440,517,920,-347,1477,1161,-1,502,430,447,425,864,1286,294,580,127,12,239,106,169,301,166,470,1556,2979,601,315,-41,407,371,310,633,410,195
+Z46632_at,164,3,228,-7,18,1,122,-1,-82,-21,70,-38,-28,-35,-33,39,-67,7,-84,-149,-187,-27,93,48,-56,60,-87,-83,-12,-95,26,-127,-140,7,-38,-48,-56,-173
+Z46632_r_at,-217,-173,-238,-193,-39,-163,-189,-401,-164,-9,6,-87,-68,-22,-12,-99,-118,-29,9,-90,-49,-166,-62,-119,-2,6,-71,-205,-33,5579,-110,-226,-137,-93,-176,-104,-158,-174
+AF001359_f_at,75,-146,221,90,416,481,131,104,681,250,130,30,62,227,642,132,-335,580,129,-134,-87,-13,315,317,96,341,-757,564,733,76,-271,-224,118,219,21,35,-95,-476
+HG1034-HT1034_f_at,-143,-130,-144,-217,-26,-78,-173,-214,-201,-77,-82,-129,-103,-102,-66,-98,-507,-89,-72,-135,-172,-102,-117,-82,-133,-48,-267,-183,-7,-143,-155,-166,-121,79,-296,-159,-222,-237
+HG2148-HT2218_f_at,340,417,791,537,175,357,361,971,466,490,327,291,239,274,201,418,931,349,203,521,309,283,398,642,389,558,771,360,529,432,392,620,284,162,406,330,460,478
+HG3141-HT3317_f_at,160,-145,222,-29,190,-24,-373,-379,475,-194,564,-260,-74,22,595,-108,-225,30,-97,30,-343,9,-70,-258,-168,-324,-727,-540,-538,-167,-123,-388,4,37,-420,10,-135,-473
+HG3236-HT3413_f_at,1109,1487,2336,1835,457,1367,3293,2574,1605,954,1281,994,705,1058,745,1379,2007,2151,1139,1068,259,1455,1487,362,1681,964,6146,748,1276,2114,2208,2084,1905,825,1206,1582,1798,4458
+HG3576-HT3779_f_at,8421,1798,-490,2686,2345,35,1492,2577,-130,129,-380,4295,11895,895,9326,2722,2784,8129,8607,11098,1079,3426,-169,2737,3265,5083,810,1334,4984,7461,4497,-313,7892,2710,10002,8249,11045,6970
+HG3597-HT3800_f_at,9017,6913,4113,3434,2839,1454,3431,6677,3611,2782,2093,5218,10658,6636,7704,3129,9721,4575,5294,8946,2197,4150,1303,3567,7875,9641,4058,3905,5278,11468,6850,3270,6029,6458,8245,3536,4745,9261
+HG3635-HT3845_f_at,96,213,153,124,110,96,110,-1,104,35,113,-5,106,119,106,87,236,34,81,79,68,30,193,89,132,78,82,139,81,158,176,57,163,149,17,70,89,156
+HG3729-HT3999_f_at,-45,-5,198,12,-42,128,159,200,-102,-33,-58,4,-49,62,128,11,-14,5,-32,-59,37,7,-98,142,-9,60,287,-106,79,-74,219,-13,21,62,183,171,196,-89
+HG3921-HT4191_f_at,165,-232,-152,-381,-80,-464,821,137,-429,-144,-368,-566,-173,-293,-192,-407,508,2,-60,-193,108,-154,-708,32,-152,-164,12,365,187,46,504,118,-170,969,906,235,181,-88
+HG4417-HT4687_f_at,-47,-57,19,143,19,-46,102,-62,-23,27,32,-31,-61,-3,37,-24,-45,96,13,-133,-127,-82,5,-59,-80,-3,42,-3,45,-162,-5,-95,-16,53,-19,32,-5,-19
+HG688-HT688_f_at,5899,1898,1334,2682,1668,1097,2543,3448,2600,1411,1784,1976,6577,1831,4113,2321,4760,5923,3654,4963,1271,3200,1658,1609,2595,3322,3185,2378,3224,6953,3883,2399,4859,2305,7240,4865,6221,6563
+J02982_f_at,456,276,578,414,197,341,640,979,447,243,304,175,222,269,259,308,975,344,568,907,164,312,345,309,225,404,655,427,856,467,1527,1413,862,1253,531,196,446,1043
+J03801_f_at,921,4101,2799,1166,3250,3126,1053,1751,2343,1502,964,2599,123,3264,434,975,1133,1261,758,1057,448,993,1782,39,160,446,2406,4300,2397,15351,13348,2374,2165,3475,7039,5146,7380,13397
+L05514_f_at,97,43,42,36,32,49,55,71,64,-7,44,18,-17,-3,43,45,96,8,38,6,46,70,64,93,13,30,134,71,64,53,53,44,36,-13,22,23,101,87
+L49173_f_at,159,184,217,372,182,183,241,268,147,153,232,168,82,177,163,205,415,33,127,198,86,109,193,177,80,91,106,75,201,198,161,89,165,111,181,103,235,250
+L49219_f_at,170,130,210,106,150,227,176,106,189,164,62,60,91,61,225,197,110,1,150,255,184,197,56,192,143,201,64,39,93,5,21,5,108,110,52,51,145,24
+L49229_f_at,337,131,529,422,354,327,354,232,568,19,7,-27,207,290,513,190,214,5,45,312,37,184,93,424,77,-17,170,-29,38,-16,93,-37,15,17,60,56,88,-48
+L76670_f_at,-351,-607,-672,-263,-242,-321,-68,-905,-661,-490,-415,-209,-336,-469,-328,-376,-1193,-383,-414,-662,-227,-534,-359,-448,-276,-310,-724,-713,-514,-711,-717,-530,-604,-267,-677,-478,-767,-971
+M19045_f_at,382,3606,2997,1331,3069,2850,1201,1947,2629,2148,969,3939,210,3633,735,637,973,1263,694,888,447,527,1820,71,515,304,2331,4259,2517,15519,13221,2702,2475,3605,6268,7035,7969,13195
+M23575_f_at,171,76,288,87,167,108,92,346,34,210,130,51,179,226,57,203,213,89,48,197,18,-206,91,154,185,131,175,48,55,294,112,249,71,78,183,162,368,337
+S78693_f_at,25,45,60,100,40,83,53,-1,37,38,1,-20,5,58,81,-37,9,33,-12,-17,38,23,45,41,33,11,79,12,-4,49,44,16,107,41,105,57,84,28
+X14008_rna1_f_at,557,2716,1716,1143,2917,3300,830,1683,1965,1781,833,4009,93,3576,637,635,817,1631,846,883,560,886,1525,108,512,441,1976,4192,2327,15761,13087,1663,1953,4063,6612,7821,5778,13076
+X59244_f_at,425,253,436,407,221,275,174,628,354,335,550,288,474,393,268,341,726,220,200,498,512,476,302,387,291,127,273,421,302,142,381,418,332,325,341,249,353,397
+X97230_f_at,-112,-197,-287,-86,14,-60,-13,-223,-207,16,-83,11,-71,-21,-49,125,-425,-33,-98,-162,-2,-7,-24,-73,176,-2,-183,6,-36,-27,-125,-89,-44,10,-103,-95,-78,-42
+D16154_at,28,-21,-172,-218,44,-88,-137,-53,-5,-4,-78,-47,43,10,10,26,194,23,-10,-156,63,-82,-64,94,78,-66,12,-21,-16,2,-55,109,-9,9,262,-65,-118,-154
+D17793_at,12,-314,-15,-68,13,-56,183,-203,837,206,450,-7,20,230,-14,90,150,85,2,132,72,-61,-36,2,137,2,154,-6,187,-82,1083,858,541,740,9,134,205,506
+D38024_at,265,-38,255,339,282,67,265,-71,96,258,97,-1,393,208,226,805,564,682,316,704,580,73,51,331,157,844,1070,128,305,-27,-237,747,151,-17,214,0,-53,120
+D49728_at,293,1290,574,1145,448,983,868,1766,2429,440,886,281,642,965,361,1065,1325,1023,260,616,313,449,1388,313,862,1022,134,360,894,999,1431,1680,1724,896,1239,430,952,1445
+D87017_cds3_at,1122,1641,1257,1748,920,1488,1762,2027,2240,1084,1624,1215,566,1441,1234,1149,1873,1273,1136,1713,1255,987,1468,1344,1417,983,1606,1639,1466,1633,1588,1032,1798,1320,1455,1383,1820,1255
+D90042_at,26,18,145,123,65,96,85,178,-3,62,87,28,22,24,9,139,364,83,101,10,81,-6,70,98,140,70,175,207,170,107,41,75,39,29,48,49,98,-8
+HG1980-HT2023_at,3793,1748,2659,4668,3305,2354,4104,1940,8089,3134,3402,669,4462,1464,6251,3938,3917,2528,3435,3282,7928,779,2302,3397,2841,5034,1373,3206,2306,8786,8032,4255,3799,2453,7892,3878,5342,3739
+HG1996-HT2044_at,-235,-160,-199,25,-4,-62,-263,-41,113,-247,64,-54,-78,-40,2,6,-398,-11,-120,-273,-229,-103,-131,-38,-221,-118,-447,-125,-113,-38,-105,-36,-344,-81,-98,-119,-218,-288
+HG2149-HT2219_at,232,149,368,408,180,227,426,562,407,193,246,237,157,290,285,337,153,193,295,203,212,109,425,179,207,250,237,313,382,383,268,189,276,134,166,350,322,350
+HG2160-HT2230_at,9,0,3,-44,26,-78,-15,-44,14,20,2,34,-34,1,9,37,-27,41,15,29,-47,-56,-37,2,31,-22,-15,-31,-36,-68,0,14,3,9,8,-13,8,-36
+HG2600-HT2696_at,-690,-546,-944,-647,-237,-544,-818,-937,-680,-343,-425,-530,-410,-421,-495,-415,-1325,-381,-451,-667,-352,-384,-575,-537,-799,-578,-1103,-775,-697,-541,-938,-878,-740,-434,-679,-571,-761,-1126
+HG3491-HT3685_at,-56,-61,-224,115,-22,-8,-58,-149,-111,-111,-63,-83,-53,-76,-60,3,-313,-68,-94,-180,-11,-68,30,-4,-130,-126,-181,-87,-9,-191,-88,-125,-85,-11,-117,9,-77,-89
+HG3513-HT3707_at,35,41,-10,98,4,-42,45,122,47,31,11,-33,14,42,-23,24,59,57,22,26,44,27,3,-25,35,23,84,-11,12,31,64,42,61,21,43,13,52,53
+HG3636-HT3846_at,1236,1019,1261,1108,597,1306,1226,1379,1254,439,935,491,581,809,543,604,1503,647,301,822,217,717,729,854,657,563,744,1041,545,1541,879,964,1497,676,776,812,1618,1706
+HG4108-HT4378_at,470,197,312,235,255,234,277,371,342,225,301,137,198,414,186,437,650,327,329,243,191,207,235,348,212,264,394,440,603,268,270,220,383,179,297,211,478,566
+HG4109-HT4379_at,362,191,77,161,117,140,68,248,138,84,152,114,151,148,115,115,409,87,86,204,159,154,142,265,120,193,186,71,2,161,151,57,185,-17,93,90,280,216
+HG4115-HT4385_at,118,-242,58,-286,52,76,-131,-55,100,-114,-9,-96,273,-25,67,140,-717,108,33,-161,98,61,-174,59,0,-11,-342,9,-48,4,-72,4,110,-59,-301,-32,-69,-83
+HG4322-HT4592_at,97,2679,228,-99,74,172,-8,158,1105,1402,430,-11,100,133,-25,53,225,51,-10,270,2313,53,556,91,430,92,134,40,98,346,1423,2988,517,2645,1352,31,147,227
+HG4593-HT4998_at,162,351,325,715,112,193,294,301,308,251,163,163,133,157,86,272,271,207,206,198,141,223,267,212,217,190,619,192,218,232,465,155,189,61,435,341,302,365
+HG491-HT491_at,-121,59,-130,-84,-138,-327,-240,-356,-89,-138,23,-158,15,-146,-67,86,-148,28,-80,-47,-38,-53,-150,7,-73,-75,-176,74,-62,86,18,-206,-91,-30,77,-217,-45,-89
+HG881-HT881_at,369,292,320,309,112,321,255,656,439,329,247,83,170,283,1,200,441,206,393,230,163,180,258,101,164,89,361,356,437,200,335,488,328,107,442,447,401,621
+J00146_at,173,-7,127,222,63,119,47,191,37,97,144,63,58,112,22,97,127,99,56,88,107,24,79,100,78,50,26,107,151,56,144,39,139,14,90,36,179,224
+J00207_rna2_at,76,58,90,109,52,3,63,293,104,43,33,-67,42,67,93,66,83,61,55,7,42,151,70,169,99,34,167,85,86,86,34,55,34,42,-18,92,103,88
+J00210_rna1_at,-7,-65,28,4,-23,-76,-38,47,11,-35,-12,-21,-40,-27,-19,-39,3,-84,-44,-251,-54,-92,-79,-71,-67,-5,-57,-34,21,63,17,29,-77,-85,-4,-13,10,29
+J00220_cds5_at,-37,-21,70,-20,72,-85,-152,0,30,66,56,-51,67,24,36,65,28,77,45,285,197,86,151,243,73,296,-115,199,310,53,-133,39,27,53,-183,-323,36,-32
+J03910_rna1_at,-110,-267,-124,-371,135,-215,-599,-247,-463,-154,-195,21,11,-275,-369,-358,-940,-217,32,-191,-142,-130,-237,-90,43,-163,-455,-468,-264,3,-542,-83,-7,-255,-238,-145,-251,-236
+J05412_at,447,335,524,457,315,330,586,581,423,322,322,232,297,374,176,406,777,345,211,514,196,410,364,454,234,328,603,413,379,449,482,692,550,251,336,413,532,627
+K03431_cds1_at,1229,875,1008,1482,440,1251,1354,1080,1470,713,726,885,621,1093,764,970,1214,793,752,756,369,834,1272,719,962,872,1068,941,872,1589,1595,1163,1169,860,689,1154,1518,1450
+L05187_at,711,1175,1034,1067,563,661,803,1451,1139,591,584,491,478,544,366,616,1564,621,390,527,302,672,991,921,656,642,1018,989,985,765,895,827,802,367,858,739,684,1157
+L08010_at,180,97,352,136,63,284,463,182,266,107,58,100,60,40,-69,151,692,16,132,193,32,98,237,117,36,160,356,94,363,2,108,3120,117,50,216,121,99,362
+L13740_at,448,831,419,314,409,252,366,1058,432,445,354,878,733,443,345,423,647,156,1026,303,222,1067,186,453,1994,2788,1264,518,363,470,663,359,4971,137,899,207,412,1559
+L14430_at,-23,-65,-10,-47,-15,19,-70,-8,-92,-24,4,25,-49,20,-15,-13,-2,-46,-29,-27,-32,-7,-24,-66,-58,0,-28,-111,-48,-109,48,-33,-18,11,-20,-32,-18,-38
+L20433_at,-196,-313,-416,-329,-117,-400,-404,-352,-456,-280,-326,-244,220,-319,-210,-313,-601,-225,-29,-295,-131,-283,-330,-348,-352,-86,-464,-461,-158,-558,-501,-433,-346,-241,-369,-363,-465,-575
+L32606_at,-499,-177,-526,-587,-208,-528,-332,-796,-658,-56,-294,-379,-74,-439,-302,-152,-197,-193,-73,-97,-209,-255,-142,-439,-314,-134,-158,-242,-387,-658,-465,-497,-76,-38,-34,-187,-213,-398
+L34035_at,-107,-98,-84,-89,-5,-76,-78,-113,-141,36,-69,-61,-33,-76,-28,-139,-202,4,-110,-153,-101,20,-47,-9,-106,-81,-89,-133,-36,-214,-176,-49,-109,37,-13,-105,43,-157
+M10942_at,812,3515,796,976,524,439,1213,605,399,3623,506,2674,64,539,272,702,434,175,1140,344,2684,275,630,319,606,2554,769,359,387,837,1546,926,918,371,319,769,734,1831
+M10943_at,220,86,353,184,180,280,235,281,358,205,304,87,69,284,140,354,446,287,106,400,51,99,87,92,90,111,217,8,298,256,147,160,397,25,455,177,249,182
+M12125_at,354,557,398,407,165,730,468,-40,222,188,184,372,279,173,279,294,456,21,336,593,199,96,224,551,487,200,12,372,86,-83,75,343,359,65,295,41,428,418
+M13485_at,389,230,461,294,194,296,354,364,432,108,244,209,236,188,98,431,638,338,143,339,27,243,226,342,135,167,627,342,327,764,580,680,499,450,752,291,418,703
+M14306_at,51,37,14,-39,26,-74,6,59,11,-6,6,-10,-23,14,-10,29,-45,7,-15,17,-13,34,60,69,-20,-29,-7,-41,-9,-8,27,-37,41,-1,27,-54,-10,42
+M16714_at,137,106,151,89,46,78,31,118,150,22,62,21,31,38,42,39,129,21,36,48,61,96,62,71,35,81,50,17,28,40,66,119,24,77,82,-6,70,84
+M19888_at,70,-13,38,1,30,-8,-58,11,100,-44,14,116,17,51,111,-6,33,96,30,-33,127,83,205,-25,61,168,259,-10,-4,15,-59,-25,-24,-58,-89,-9,-2,-5
+M21302_at,201,-423,103,-10,-220,26,-45,-403,148,83,-341,-209,-251,-17,-263,-295,-920,-275,-269,-483,-102,-108,178,-137,-220,-169,-574,-337,-262,-340,-119,-279,-278,50,-370,-92,18,-639
+M21539_at,415,210,345,413,222,243,376,560,394,254,205,205,268,183,217,293,428,279,226,479,194,258,326,427,221,356,142,269,363,298,458,463,386,343,52,239,378,579
+M23263_at,208,234,550,353,314,229,258,440,579,327,284,239,228,298,148,377,555,333,228,126,2,459,336,278,-28,457,397,469,247,174,223,356,241,102,341,227,556,445
+M30838_at,873,377,958,1010,293,787,1043,1311,1098,551,720,639,536,496,472,735,1005,198,468,499,336,700,638,526,380,624,771,910,942,457,444,754,735,311,322,788,804,741
+M31523_at,1320,898,597,1644,1322,787,946,1917,1440,442,617,474,1969,686,2572,1439,989,1186,1224,4555,2707,274,590,1823,553,1909,1076,299,389,126,190,275,353,279,250,381,671,200
+M31932_at,1588,1608,1914,1237,896,922,804,1140,1626,1108,1054,974,1134,1139,758,645,2639,679,650,1717,624,500,680,630,1054,860,943,890,863,2114,1251,1732,1087,647,1561,697,1567,2648
+M32578_at,-457,-20,-49,445,8,-419,-126,241,91,-45,160,540,-71,-200,-287,-361,15,-274,18,-139,373,175,199,-204,122,-384,408,191,-247,-201,1908,-91,673,275,364,1599,886,970
+M35999_at,-43,0,-208,-20,-103,-14,-13,-52,104,-152,-5,-27,-112,-28,-49,-76,-252,-99,4,-130,-16,40,-36,-265,-37,-8,-86,-40,31,-85,146,-31,9,-71,-58,-10,-23,-38
+M36072_at,12923,12948,12759,14392,14312,16330,14146,14192,12788,15852,15411,17167,12386,14808,12760,14369,13227,16250,13728,9687,13082,12428,14266,14870,15470,13425,17145,13742,12616,15145,13368,15182,14398,15862,13573,18620,14482,15461
+M37075_at,36,101,-321,287,46,-350,-184,-635,-345,295,243,-28,139,-22,89,74,-86,258,90,161,-204,-90,267,126,2,285,378,235,-64,-29,335,-35,86,111,-4,-108,284,111
+M37981_at,-24,18,67,99,18,160,50,2,21,158,232,0,13,22,-10,30,80,-23,5,4,28,18,45,16,29,-3,87,-18,19,5,10,25,11,15,25,22,27,23
+M38180_rna1_at,8,3,-29,14,-4,71,-31,-31,-21,3,-28,-24,-40,-37,-23,-43,-40,-15,30,1,-54,7,37,-30,-27,41,26,-13,9,-4,-4,-33,-27,7,33,6,-38,55
+M55418_at,49,120,106,111,79,30,80,47,60,107,24,91,25,32,1,49,112,41,41,21,162,31,68,36,26,27,29,82,72,22,55,-3,146,81,55,91,58,161
+M55419_at,-11,-20,1,-27,0,1,-5,-97,-12,-19,-9,41,-15,18,11,-18,71,-24,-30,31,51,-40,28,35,-4,-14,-10,-3,0,-52,-22,37,13,-46,17,18,-46,-6
+M60746_at,50,360,469,422,171,334,-43,-172,-89,298,162,225,231,3,63,376,756,80,223,322,208,137,216,225,236,296,593,356,-69,93,269,435,396,125,419,347,423,443
+M60751_at,24,42,-96,-22,-22,-48,-73,-86,-33,-21,-47,28,-10,-31,-8,-16,-1,-28,-36,-8,28,-37,-34,-8,-16,13,-21,-41,-60,-160,-54,-9,-38,-58,80,7,-3,-2
+M61855_at,246,154,307,193,46,33,173,277,256,179,197,96,127,108,61,148,500,201,103,148,101,207,243,127,172,228,298,429,84,309,266,218,170,-18,204,112,304,202
+M68519_rna1_at,-279,-369,-500,-772,-140,-339,-872,-665,-322,-231,-221,-675,-342,-674,-316,-284,-689,-495,-527,-466,-61,-258,-613,-465,-300,-247,-1156,-361,-509,-595,-994,-162,-686,-265,-860,-204,-479,-989
+M77144_rna1_at,-13,-2,-12,24,-17,-87,-168,-241,17,-16,-21,-45,-10,-129,11,-35,254,70,-46,-31,28,-65,-66,53,-63,-101,34,-86,-103,-1,-42,27,-21,-34,116,5,6,-9
+M81650_rna1_at,104,29,54,222,32,33,30,77,58,36,10,12,4,26,-3,35,2,29,66,87,9,58,36,35,37,37,181,102,81,69,8,65,-45,37,-9,85,60,1
+M90354_at,-106,-64,-126,-100,-41,-135,-87,-308,-106,-71,-99,-84,-59,20,-95,-171,-62,-49,-109,-72,-19,-52,-115,-68,-126,-75,-200,-90,-76,-172,-166,-125,-191,-66,0,-62,-61,-127
+M92642_at,2797,2188,2221,2219,1976,1536,1473,1526,2203,1363,2100,1514,2161,1889,2195,2681,3013,1223,1897,3010,1386,729,1860,2339,2133,2730,1445,2685,1947,2205,1257,884,2299,1112,1500,1373,1872,1773
+M93311_at,39,47,119,102,31,-30,25,98,68,6,20,112,33,14,58,-5,47,-23,84,57,-52,32,-17,44,19,55,-62,73,21,81,105,-52,40,43,25,22,117,-8
+M99435_at,-133,32,-92,-106,-45,-17,-193,-116,-277,-54,-178,-50,-12,-134,0,6,-205,-124,-4,432,-159,3,-161,-202,24,67,117,-310,-4,-276,-178,17,-294,-62,-119,-202,-236,-87
+M99436_at,-68,-186,-174,-23,-51,-268,-21,-89,-217,-152,-140,-280,-139,-234,-191,-170,-44,16,-154,-86,-34,-147,-39,-107,-21,-153,-29,-347,-55,-56,-547,-73,-113,-99,-321,-190,-89,-577
+M99438_at,-296,211,-148,-244,-83,-163,-238,-391,-157,-36,-7,-142,-107,-86,-71,-174,-214,-114,-2,-120,-126,-30,-18,-1,-108,-69,-402,-140,-252,152,235,157,12,29,162,-11,-65,36
+M99439_at,959,316,923,598,399,545,576,2105,1181,539,888,356,458,531,319,1139,1910,514,983,1455,194,508,473,437,379,499,557,729,839,873,1034,440,813,468,389,383,904,1291
+S68287_at,-96,-72,-122,-214,-100,-103,-124,-106,-120,-53,-128,-79,-106,-84,-57,-98,-204,-58,-63,-100,-8,-31,-60,-130,-37,-117,-106,-144,-156,-180,-118,-73,-43,-58,-64,-57,-134,-136
+S72043_rna1_at,-30,-149,261,1860,-62,698,267,1661,-12,-146,-185,1066,-187,-113,308,5,-229,-77,39,-471,267,-9,623,382,-10,67,638,139,509,116,835,-74,203,273,-321,881,728,455
+S73840_at,173,110,207,152,110,78,174,260,228,95,57,38,261,100,124,171,178,197,127,277,113,158,100,242,86,255,145,129,-45,273,-62,181,233,18,110,194,156,589
+S74720_at,-107,-57,-176,-208,-72,-252,-87,-175,-317,-77,-94,-169,-130,-140,-140,-104,-148,-91,-129,-49,-134,-137,-144,-71,-80,-123,-126,-218,33,-148,-162,-91,-107,-22,-105,-175,-212,-185
+S78774_at,-268,-149,-141,-400,-176,-53,-181,-278,-346,-222,-186,-205,-197,-351,-104,-204,-388,-283,-160,-234,-144,-124,-56,-219,-227,-266,-388,-358,-447,-58,-268,-343,-307,-111,-255,-228,-540,-319
+U00928_at,55,-47,30,40,-6,3,67,40,209,-57,111,14,4,-8,-98,40,-235,-2,-83,89,-24,-15,-113,-11,-2,72,-140,165,-60,-46,13,35,6,-161,-116,9,-97,118
+U01317_cds4_at,119,44,172,395,124,-28,1107,5012,-44,121,239,102,136,497,54,184,491,112,5089,8308,194,367,146,163,5352,988,20,164,6162,777,18403,17415,2740,8991,1409,142,1127,3437
+U02388_at,-138,-65,-176,-130,-40,-231,-169,-281,-192,-90,-71,-185,-12,-66,-147,-79,10,-98,-81,-34,-23,-120,-214,-115,-26,2,-150,-119,4,-87,-93,-80,-86,-49,-113,-95,-216,-89
+U03858_at,129,731,180,20,66,-49,58,413,63,19,85,-48,89,161,11,0,-35,-58,59,90,103,121,26,193,130,-8,-25,-18,141,-32,250,67,107,51,112,149,24,250
+U05861_at,44,-196,54,-114,-26,51,-65,-106,114,-80,68,-112,-7,-135,15,-51,-302,-95,-53,-108,-47,-60,-91,-17,-37,13,-56,5,-98,160,546,71,284,105,-147,-125,-136,-36
+U12140_at,210,143,312,335,151,133,198,260,269,217,110,155,202,179,163,170,241,124,154,136,163,74,112,134,150,218,334,254,168,174,198,296,371,34,175,88,197,338
+U19765_at,159,458,229,190,295,179,117,32,455,382,159,119,421,348,474,239,576,171,272,987,578,94,129,185,184,168,217,107,240,68,145,176,179,209,374,82,154,140
+U21556_at,-20,-154,-176,-34,1,33,-159,-319,-226,36,-47,-76,86,-100,8,-83,-175,-66,4,-171,-101,-88,-34,-21,-36,-144,-173,-43,4,178,50,-64,-169,-21,-91,-2,-81,273
+U24153_at,-59,-214,-91,189,-49,-8,-89,-275,-234,-305,-158,64,-52,-116,-108,-213,-520,-97,-88,-224,-109,2,-227,5,-81,-204,-309,-122,31,-20,-229,-159,-192,-105,-211,-132,-247,-294
+U24683_at,-213,85,315,67,-131,106,-75,-89,-73,8,-177,-222,-7,-111,-54,-148,76,93,124,-254,132,41,256,-467,-227,20,164,-128,-182,214,-12,-270,61,31,-165,35,-36,35
+U24685_at,123,325,80,239,149,145,189,107,-83,83,131,114,155,2,256,100,185,834,48,137,252,245,212,-8,35,355,422,227,125,294,-32,-17,135,57,148,66,219,88
+U25975_at,594,440,639,442,259,494,273,680,968,250,183,169,430,497,484,326,1637,210,370,409,6,401,138,701,196,279,237,363,663,608,290,196,348,130,413,286,596,444
+U27460_at,738,2200,837,652,400,679,645,128,1047,288,640,48,448,382,700,560,1899,89,294,801,883,108,598,751,176,232,172,124,120,192,72,142,84,177,178,188,307,178
+U28014_at,199,527,460,347,322,293,389,116,958,321,564,296,283,875,926,793,1229,147,360,1469,1255,156,199,716,354,528,377,738,519,402,433,359,647,516,322,438,519,1177
+U28015_at,-43,32,-58,4,24,26,43,-82,7,-35,-10,1,-16,69,62,1,-66,-20,-1,75,-46,-2,-104,-51,-36,-4,-76,-64,-79,-23,-59,-31,19,-33,-18,-9,17,-97
+U40279_at,-50,310,350,221,187,259,455,497,541,159,164,127,15,309,243,48,678,188,130,-39,464,154,189,306,251,217,4,133,425,649,573,287,692,202,705,419,360,717
+U43944_at,7,38,4,-31,59,0,-5,-5,-29,-18,44,74,88,34,48,-35,127,26,-12,-4,132,22,-41,73,-7,56,233,30,180,-13,78,9,-40,17,-41,45,-21,43
+U44103_at,190,164,107,50,132,40,85,-16,31,35,94,61,187,115,300,254,302,116,97,259,206,53,96,221,69,15,186,-5,-31,250,91,186,192,55,118,37,64,113
+U44105_at,37,-9,-35,-44,-24,-10,-23,-25,6,-60,-9,35,-8,-9,-27,-35,-55,-30,-45,-56,9,-14,24,-81,-5,-30,-35,-50,40,-39,-2,-21,-67,-13,3,27,-33,9
+U49441_at,783,710,871,680,404,762,1055,1025,1039,333,695,592,448,599,513,488,899,543,504,660,617,567,832,1009,694,564,949,1022,894,1078,815,792,1062,464,616,491,909,1039
+U62432_at,-42,29,45,-41,5,-16,-16,-20,-11,27,57,25,-3,-14,10,-46,43,-28,-34,-10,62,-39,-45,28,10,-7,14,-30,52,-28,10,-56,-18,-7,-1,-26,-61,-78
+U66061_cds3_at,201,87,147,199,224,85,198,127,294,171,115,64,147,233,135,163,270,135,147,302,171,77,53,182,95,162,118,196,139,378,196,267,271,203,148,102,1306,191
+U66077_at,177,161,320,150,117,99,159,274,214,77,48,44,73,166,158,127,288,114,83,130,72,128,155,106,123,79,328,67,252,207,144,159,142,41,180,206,111,337
+U76388_at,711,1155,732,625,800,359,1107,91,753,623,682,278,807,409,408,408,2294,336,467,1101,69,354,391,425,763,440,807,365,363,1141,566,869,970,542,1588,1045,1327,1046
+U82279_at,12,-169,-131,-253,-33,-261,-226,-229,-148,-187,-147,-145,-14,-123,9,-130,-318,-81,-111,-159,-33,-119,-165,-126,-39,-112,-175,-57,-62,-70,-110,-210,-191,-41,-128,-184,-149,-131
+U82979_at,11,-165,-136,216,412,-140,157,199,49,-108,-160,385,-30,-68,207,467,472,23,-38,502,251,-108,-5,291,404,321,198,-219,43,580,22,519,262,167,320,94,-111,117
+U83117_at,-107,58,-107,95,52,21,142,-106,65,96,-14,35,26,0,47,-35,109,-47,16,18,88,90,-36,11,51,26,76,50,45,34,108,-6,-26,53,84,34,-60,39
+U84388_at,93,215,155,151,770,117,146,59,190,111,154,97,106,175,297,385,218,53,318,585,251,2,70,216,112,536,101,6,-91,92,111,80,76,89,84,26,115,109
+U92027_at,365,150,507,399,157,279,203,311,370,205,255,149,264,268,188,243,700,206,163,259,217,112,184,231,192,178,488,306,137,401,113,106,300,143,439,264,436,214
+X00088_at,-117,-57,-99,-133,-65,-188,-164,-229,-129,-160,-88,-50,-35,-77,-46,-111,-292,-90,-77,-79,-112,-156,-121,-109,-48,-136,-203,-189,-79,-50,-75,-124,-181,-19,-238,-206,-320,-199
+X00948_at,56,55,103,-77,16,140,70,127,71,-45,68,44,39,25,24,47,-26,-55,-72,39,77,81,-3,75,27,2,46,33,-7,-52,21,86,67,31,22,-60,80,-53
+X00949_at,-22,47,-13,-23,18,-30,73,-17,-46,42,34,-25,-12,-31,19,49,98,36,-5,-37,54,-27,66,6,4,72,56,41,43,-38,22,-1,-35,-13,17,60,-24,72
+X01703_at,2620,4782,2397,1107,2087,1086,152,2367,6747,6032,5199,1951,2255,883,1797,2329,3761,1172,416,6552,8070,1256,1495,1723,1700,2170,1087,1165,651,1542,556,503,2422,1386,3633,1714,4127,4685
+X02956_at,87,23,106,37,41,46,94,-29,58,41,37,27,23,101,25,21,64,78,53,44,21,60,87,114,41,42,123,5,55,11,77,97,60,78,22,40,124,98
+X02958_at,62,63,-4,30,14,21,18,-32,170,64,51,89,-2,-66,106,151,-82,65,-44,110,37,132,155,185,-76,79,54,-6,-55,38,6,21,52,47,6,155,147,133
+X06825_at,-108,-209,10,-176,-56,35,-117,-322,-225,-33,-35,-113,-51,-265,73,7,-575,-125,32,3,-182,-56,98,16,1,86,-179,37,-79,87,-181,-178,-121,-59,-522,-129,-5,-23
+X16546_at,174,309,226,151,672,353,114,122,48,282,215,135,111,236,159,281,811,124,130,194,34,139,22,292,132,217,75,714,423,2776,1897,162,226,1561,989,1004,454,959
+X17093_at,5956,1234,830,1252,1449,807,1834,5601,955,897,206,3052,10164,1998,9762,2090,1493,2872,8203,10202,2902,2798,322,1290,3915,5542,1746,1457,1074,3289,1452,281,2267,439,1679,517,1387,1002
+X54489_rna1_at,84,-53,75,80,-14,65,50,-29,68,19,-10,-4,14,1,61,40,2,8,24,36,-77,45,68,-14,33,6,61,28,93,123,31,-18,99,7,41,-57,137,428
+X55989_rna1_at,279,26,114,215,173,234,488,245,12,54,93,217,-15,2,131,53,-158,24,-63,-65,176,170,174,201,-8,68,192,216,79,645,159,65,95,175,70,412,90,335
+X58399_at,343,-177,-294,128,-30,0,104,85,3,-188,-255,-142,439,-211,765,501,-159,-109,18,2342,58,-48,85,367,-260,383,-305,-82,-98,-229,-311,-148,-132,-57,182,-100,-58,-233
+X58401_at,-1,-73,-34,-167,-47,-88,-31,-29,-19,-20,-51,-68,-31,-69,-22,29,-149,-24,3,20,76,-78,-104,-70,-6,-57,-4,26,-38,-28,-70,-104,-87,-45,-152,-120,-145,-62
+X60487_at,44,33,45,45,80,58,53,95,139,112,81,56,143,16,95,130,282,77,91,136,16,26,-39,108,117,110,45,134,-9,185,93,110,45,5,56,58,68,131
+X69115_at,499,309,613,216,123,506,423,586,599,155,374,234,300,448,373,418,612,251,292,340,217,122,391,387,394,347,441,319,675,555,246,406,389,129,483,330,540,637
+X69654_at,14339,5086,9752,8995,3407,6280,9502,13141,14781,4396,5914,9678,6609,10724,12996,5843,17349,8178,3462,9987,10260,3061,8399,15264,4503,10193,4658,15349,4222,8346,9990,3885,12727,17184,4889,5717,13917,5336
+X72304_at,76,80,-92,-52,10,46,-60,-56,-28,16,49,-50,-14,-36,53,85,-67,-10,-107,-79,12,-1,-11,58,2,-3,-150,22,-26,38,-96,-79,-111,-37,-45,-26,-63,-128
+X72475_at,525,517,549,472,263,446,525,497,466,386,284,239,166,317,273,128,613,204,389,396,216,381,275,340,431,295,564,692,490,465,451,607,352,355,624,364,571,624
+X78712_at,-122,-263,-152,-269,-123,-183,-263,-119,-198,-44,-112,-123,-153,-187,-86,-104,-296,-161,-139,-156,-191,-193,-397,-294,-23,-107,-311,-473,-346,-346,-290,-48,-198,-25,-314,-85,-338,-95
+X87211_at,118,65,132,-397,207,-69,-470,23,64,109,100,107,143,67,28,200,-162,79,51,90,136,30,85,109,247,262,31,266,55,150,611,484,64,206,48,-27,105,-337
+X90530_at,274,263,257,420,294,142,515,379,362,357,338,241,803,175,234,481,950,315,346,790,144,143,184,328,405,250,477,515,488,535,332,342,376,315,349,342,480,528
+X98225_at,-174,-110,-228,-241,47,-172,-85,-535,12,-271,-117,-99,-4,-29,-82,152,-570,11,55,-202,38,-112,-199,71,-151,52,-281,84,-144,-63,-227,110,-111,218,-174,-311,-19,-10
+X98296_at,332,441,147,388,343,232,203,325,258,82,415,396,618,360,418,141,353,181,118,438,465,289,267,359,254,297,48,244,40,285,550,343,339,371,571,256,192,305
+X99133_at,-685,-592,-1092,-325,-127,-833,-1181,-1599,-758,-465,-458,-120,-209,-342,-470,-166,-765,-330,-51,-149,-309,-865,-421,-282,-409,-393,-422,-241,-620,-482,-665,155,-365,79,-673,160,-805,-14
+Y07566_at,146,119,118,3,155,60,-21,133,115,51,144,99,109,110,115,135,292,84,50,278,136,69,148,153,122,136,147,126,132,172,75,106,160,163,142,71,125,134
+Y13618_at,123,59,132,134,51,156,75,61,176,49,126,67,4,121,33,93,165,48,30,48,54,58,-15,167,56,50,59,47,14,140,75,95,88,31,86,138,160,103
+Z00010_at,-141,-159,-302,-175,-57,-110,-87,-251,-105,-129,-237,-83,-103,-112,-97,-182,-210,-15,-102,-230,-128,-108,-188,-150,-132,-54,-341,-109,-153,-206,-141,-175,-279,-91,-123,-243,-218,-203
+Z30643_at,1619,1457,1528,1384,798,1475,1693,968,2527,1340,2610,1583,604,1245,863,1159,782,967,626,665,368,982,1491,1168,1215,990,1020,2027,1269,3047,1598,1120,2559,648,1337,1879,3096,2168
+Z30644_at,1127,1378,1324,1340,806,-321,1389,1733,1554,923,426,991,1429,1101,912,1151,611,820,1503,1893,639,944,1573,424,887,878,1680,1568,1642,1832,2355,2374,1444,1049,1932,1260,2811,3223
+Z46261_at,-308,-210,-494,-432,-180,-103,-356,-404,-409,-154,-310,-168,-171,-283,-210,-188,-601,-114,-163,-162,-149,-298,-163,-351,-146,-202,-370,-308,-334,-282,-311,-345,-336,-149,-204,-273,-266,-492
+Z47556_rna2_at,-156,-156,-200,-242,-57,-168,-243,-230,-187,-85,-122,-146,-109,-184,-123,-129,-348,-97,-77,-123,-144,-103,-89,-194,-135,-125,-255,-149,-221,-158,-147,-151,-160,-142,-130,-226,-176,-218
+Z49105_at,540,188,485,564,390,553,379,461,648,353,523,205,214,270,350,505,526,441,528,308,-87,194,433,-61,555,415,461,755,351,105,361,-82,758,322,190,306,393,895
+Z68274_at,35,-75,25,29,46,115,137,107,182,164,41,-15,61,189,64,205,-73,-29,-64,23,206,87,41,194,-88,61,-34,36,62,40,42,91,-27,47,-190,1,-43,-167
+Z80779_at,-12,243,80,-2,53,-85,18,32,52,24,51,2,31,81,0,-4,171,-3,-68,-12,43,35,-30,50,112,13,-62,42,-55,-1,87,45,48,15,-1,-54,-39,-67
+Z80781_at,65,59,102,24,26,96,-11,-53,42,172,101,44,121,2,30,53,133,83,3,113,167,-61,-49,59,12,52,118,185,21,22,-40,-20,7,-11,13,57,23,-100
+Z80783_at,210,307,581,771,126,618,445,803,654,391,315,277,251,426,229,199,800,330,219,293,223,333,275,382,269,233,593,352,471,313,582,577,266,234,442,582,532,682
+Z80787_at,204,471,216,293,119,176,194,172,256,216,114,287,123,89,71,230,619,111,83,300,504,150,313,66,287,213,431,455,245,276,224,386,279,93,242,344,241,286
+Z83336_at,1522,1222,1462,1402,501,1111,1182,1442,1206,747,733,719,1120,671,777,1108,2093,761,1223,1479,900,651,820,1357,1122,1485,2204,1762,1315,1901,771,826,1223,562,1431,1267,1346,1725
+Z83735_at,-76,-45,-203,27,13,62,15,-176,-169,126,-78,-43,-93,-132,-58,-162,-130,-49,-57,-114,43,-179,17,-93,105,-50,-154,-105,-81,-93,10,-81,25,-74,168,-2,62,31
+D17427_at,348,125,135,102,59,238,105,208,126,89,156,45,219,160,157,175,336,97,229,303,17,54,182,213,225,64,142,231,141,273,215,289,226,241,243,112,215,351
+D17547_at,210,62,174,185,57,113,117,307,114,24,113,12,119,77,52,162,212,80,83,118,26,11,100,153,87,132,90,37,28,330,91,158,208,83,19,-9,259,210
+D29992_at,167,0,-17,-36,34,49,94,149,77,18,-8,8,89,5,73,151,122,3,137,40,-4,11,43,121,-19,67,-6,195,-2,165,-50,-25,-20,65,-28,6,141,78
+D64053_at,-14,-20,-80,-8,5,-1,36,14,23,-28,21,-15,3,86,14,22,-45,1,5,-22,132,23,-11,61,-7,-13,12,-15,-14,26,-7,17,8,-37,-39,-24,53,76
+D86096_cds6_at,161,69,23,-17,33,71,43,56,-25,1,6,-17,41,32,35,70,-55,-23,-10,30,14,20,-17,26,30,5,122,-68,4,28,68,48,30,23,25,26,37,12
+J00277_at,-256,-48,-245,-160,17,-195,-146,-403,59,-199,-44,-142,-184,-136,8,-66,-791,-199,-31,-239,127,-260,-271,7,-109,-102,-627,-323,-153,-316,-381,-296,-450,-109,-109,-173,-379,-597
+J00314_at,1128,204,1322,826,865,1331,497,22,2373,1141,848,350,2028,608,994,407,2676,868,421,999,-14,75,391,880,203,44,226,-10,151,1161,194,106,1123,723,550,765,185,49
+J03634_at,-41,70,176,39,61,-55,115,250,27,14,3,66,56,158,73,140,7,87,127,85,-121,75,227,262,111,-249,-54,113,211,71,177,274,134,89,-112,57,342,315
+L05144_at,248,198,374,320,177,236,320,466,285,205,138,97,198,250,106,216,488,222,143,312,42,141,-13,255,158,193,250,280,257,273,190,108,195,47,238,240,312,344
+L08904_at,241,598,200,629,206,225,201,299,592,70,419,136,357,227,269,231,1108,223,110,656,713,187,112,227,256,172,291,307,120,403,264,425,246,262,477,439,641,450
+L11931_at,-139,-148,29,7,24,5,-84,-236,-148,-16,-179,38,95,-80,-7,99,-364,14,79,-440,34,-132,-20,-115,127,31,-173,4,76,-257,-56,22,185,-50,-349,-78,13,-357
+L13943_at,6,24,45,76,50,5,1,7,26,78,-21,20,114,87,81,54,112,28,-1,11,-32,116,-15,68,30,-19,-7,18,-36,59,-7,3,81,2,51,-15,37,350
+L32961_at,70,75,247,238,60,208,344,311,63,141,48,73,130,74,136,75,238,43,193,128,87,41,275,11,38,44,237,283,187,138,235,268,210,85,231,260,144,360
+L35594_at,108,-3,33,-78,37,156,-47,-80,20,-65,-40,-106,37,-20,-12,-73,-111,-19,-42,382,-56,-26,7,-110,-77,76,-93,-181,103,-4,-79,9,-167,10,908,342,-24,-3
+L36644_at,13,-36,-138,-220,38,-133,-53,-62,-169,-121,1,-103,-73,-99,6,-62,-40,24,-23,-9,2,56,-64,52,-65,6,118,-225,-170,-198,29,-109,68,23,-53,-198,-15,20
+L37112_at,1520,1329,2023,1617,666,1772,1858,1709,1752,1215,1306,886,1040,1273,824,1267,2245,884,993,1366,724,793,1331,1585,1128,649,2015,1935,1370,2168,825,1443,1540,360,1751,2213,1895,2382
+M15395_at,172,1568,319,238,1081,1036,186,40,2414,872,217,51,691,2555,1805,801,2377,352,51,109,273,69,283,361,69,301,-37,3061,733,6763,1777,108,620,2021,5527,2723,2655,1096
+M16594_at,-195,-153,-103,-39,-45,-152,-174,-274,-219,-136,-97,-34,-127,-139,-109,-47,-328,-191,-71,-185,-74,-49,-180,-83,-227,-148,-190,-79,-170,-173,-256,-206,-102,-79,-113,-77,-147,-152
+M16653_at,-363,-219,-451,-541,-100,-398,-463,-536,-484,-277,-34,-300,-274,-294,-305,-156,-632,9,-139,-330,-212,-388,-305,-88,-177,-181,-434,-301,-278,-86,-542,-376,-524,-107,-386,-431,-411,-616
+M17252_at,-513,-432,-1137,-1009,-237,-1538,-1245,-1503,-1098,-1100,-208,-901,-408,-884,-961,-982,-1152,-516,-678,-1295,-366,-855,-1227,-526,-541,-432,-1542,-574,-872,-560,-272,-1044,-524,-311,-1235,-706,-1284,-1241
+M24069_at,1123,1002,174,800,1169,206,687,1551,374,408,881,692,1150,205,1085,740,613,102,1150,2913,106,41,302,859,1572,1012,131,889,113,259,866,552,845,739,480,381,531,670
+M25296_at,433,190,244,161,377,266,104,266,565,160,470,109,113,144,190,456,-64,338,182,-163,22,415,484,221,311,121,298,131,-52,722,333,455,249,-73,118,376,75,150
+M25667_at,390,220,563,207,10,147,473,700,515,256,257,126,164,226,116,357,627,431,173,-59,153,306,417,344,124,330,384,551,346,182,312,443,374,157,36,398,461,363
+M28170_at,397,-39,183,363,251,74,280,235,24,-54,-16,84,87,155,371,360,-217,195,285,470,514,95,53,418,391,495,219,-11,67,-47,-21,-18,-64,35,-139,-5,-49,18
+M28439_at,130,118,128,131,72,76,223,167,120,85,102,41,144,231,103,246,158,236,103,239,89,82,151,158,138,264,87,232,-21,228,84,58,209,98,46,141,244,215
+M36634_at,136,43,172,108,21,147,131,176,222,106,150,61,43,52,84,143,196,46,68,76,16,92,117,52,106,132,101,151,132,177,81,167,87,49,33,98,134,142
+M60614_at,-199,201,14,-582,-96,-615,-102,304,-28,-198,-206,-316,-26,-126,-24,251,-502,-147,-112,59,179,5,-497,234,-172,52,-796,-191,129,2,-515,-180,-380,-158,-711,-436,-568,-264
+M62303_at,-1,-98,199,239,55,-55,199,-80,197,57,-23,67,134,105,-47,205,203,134,-41,91,29,61,-55,139,132,-43,79,-92,-55,184,-54,109,110,-25,-35,115,130,153
+M64752_at,101,130,192,89,45,104,105,118,148,47,89,100,65,60,123,118,176,68,63,141,62,22,165,142,69,121,173,87,153,107,83,117,69,58,29,107,88,147
+M95740_at,37,-73,83,-37,52,-74,-15,398,-12,44,39,-38,-82,-105,-102,143,-153,92,158,178,43,253,-7,131,64,-75,183,-39,262,368,86,81,67,339,134,26,24,101
+M96956_at,29,-57,1,93,-11,24,-85,193,105,-6,-82,-12,-39,35,38,122,-38,68,98,-45,-32,-53,-96,2,-49,42,-79,120,-36,86,67,-37,-133,51,-83,-14,58,-32
+U01337_at,1385,1103,946,772,474,668,1290,1349,1465,774,1221,636,2125,989,901,1239,2725,806,950,2090,553,1007,1025,1186,1039,1057,1322,1752,1187,2569,1202,1572,1165,688,1586,493,1436,1522
+U01828_at,64,36,106,54,29,8,92,140,82,25,69,15,50,60,51,135,155,71,47,91,44,3,17,102,50,22,128,6,57,32,86,85,64,2,97,40,45,63
+U03494_at,27,-43,572,503,163,473,569,739,444,233,382,63,483,307,445,484,55,51,132,779,282,341,414,543,292,310,505,474,413,-14,256,-40,0,303,-411,244,598,-33
+U04241_at,3416,7600,6598,5197,3382,8291,5837,6283,8812,4883,6789,2131,3229,7144,4285,4832,6346,2554,2664,8502,655,4685,5289,5833,2763,3077,1059,3360,1471,3663,4502,3808,2919,2389,2645,3858,6853,3109
+U09587_at,1492,1817,1497,1101,1419,1154,1114,1310,2858,1461,2383,423,1597,1388,1658,1565,2688,1483,1922,3559,3231,961,1542,1360,813,1435,1398,1167,1007,1292,1859,1594,1619,1185,1753,1188,868,950
+U14187_at,759,599,961,593,429,901,949,1080,864,603,579,479,469,541,375,706,947,555,486,295,248,595,843,482,441,383,483,833,574,851,950,779,690,370,599,818,1022,1164
+U18934_at,-60,-15,-77,-40,-14,37,23,-88,-29,-33,3,-37,-51,-82,-42,-9,-109,-2,-46,-57,-31,-31,18,-17,25,-73,-75,-72,-28,-26,4,-44,-69,-87,52,-62,-61,-104
+U20499_at,1095,1296,1216,1062,1163,933,1098,958,1064,586,802,699,1032,1398,1427,1094,1392,616,962,1315,1189,867,801,1643,708,1163,957,986,1005,1008,360,892,407,255,590,605,862,620
+U21689_at,-1660,-973,-3091,-2041,-976,-1703,-1912,-2178,-1948,-573,-1413,-1460,-1277,-929,-1552,-1266,-3062,-1042,-1265,-2091,-767,-823,-1347,-1920,-1439,-1103,-2890,-2290,-1890,-3375,-1906,-2892,-2784,-1108,-4208,-3085,-3797,-3765
+U35234_at,1260,74,810,1554,551,1467,1572,1833,1027,524,916,823,338,820,580,706,523,520,476,510,534,550,1276,995,802,308,489,1369,755,1248,593,969,1192,395,453,1423,931,1004
+U46744_at,-188,-128,-41,-199,-87,-126,-114,-175,-152,-166,-80,-137,-102,-179,-11,-81,-660,-128,-187,-113,-73,-69,-201,-122,-118,-164,-97,-78,-367,-156,-286,-171,-55,-17,-141,-193,-158,-270
+U47677_at,523,327,671,530,87,537,675,836,519,396,328,326,303,309,335,356,449,356,288,358,159,311,497,353,365,287,436,403,108,440,3,621,629,205,359,342,72,793
+U62434_at,-54,-5,-7,-59,-15,-88,-10,-119,-5,10,-18,-11,-12,-36,-13,-93,-51,-45,-32,-44,-12,-10,-39,-64,-32,-10,-64,-80,62,-95,-23,-43,-21,-30,-37,6,-1,-38
+U69611_at,25,56,57,88,73,74,109,5,66,96,0,15,73,35,143,234,132,-1,27,267,-21,20,56,159,-15,52,62,138,36,95,100,27,66,-7,91,66,51,7
+X00038_at,-16,-89,7,-197,-34,-232,10,-149,-48,-4,-64,-229,39,-110,-78,39,-27,-98,-29,-9,-69,-150,-193,-63,-138,-44,-208,-53,-48,-65,-224,-90,-64,318,-105,-53,-43,-39
+X00540_at,97,0,27,-3,11,-14,58,49,96,42,-12,86,16,75,10,54,146,21,11,71,-6,31,0,59,39,75,126,-35,-21,31,69,4,46,35,73,-5,62,49
+X05345_at,119,-56,-75,173,153,-8,-67,-485,62,-7,84,45,-12,7,261,114,-245,66,30,264,-126,-173,17,228,-3,107,-29,-119,79,-130,78,255,-190,45,-262,-23,-94,-111
+X06318_at,430,495,260,304,170,170,213,487,546,57,261,102,187,363,356,472,884,84,244,980,247,49,77,195,194,349,71,152,173,234,74,148,116,66,127,88,563,101
+X07496_at,-121,-191,-393,-248,-116,-407,-347,-332,63,-60,-106,-235,-179,-258,-181,-96,178,-174,-1,-164,-198,-172,-117,-90,-50,-117,73,-230,-24,-39,-204,71,48,-59,40,-214,140,-20
+X07730_at,547,357,207,398,151,510,915,494,144,381,93,719,71,721,208,268,-14,245,126,96,-1,772,961,401,333,202,220,313,1024,1169,848,607,717,255,921,825,926,512
+X12953_at,497,152,229,239,226,71,268,200,299,138,396,56,316,189,620,410,860,91,284,834,194,68,127,376,19,180,204,400,103,757,423,194,384,307,504,221,265,383
+X14767_at,82,504,98,110,-7,8,114,53,240,247,19,-25,52,-40,63,27,50,-41,10,374,-33,32,383,4,-43,-8,92,-28,-153,464,323,-13,0,61,785,77,481,512
+X16105_at,184,558,193,670,46,615,783,187,123,210,81,293,-4,48,190,326,1089,53,27,114,132,130,575,101,17,49,406,0,50,213,350,289,129,243,433,417,402,482
+X51345_at,783,4514,401,395,1393,440,1223,2452,1729,679,507,1898,1127,462,1182,789,912,2827,2678,6599,1356,426,429,445,2285,9558,1602,2560,254,9054,5104,1803,8428,1257,4756,834,4719,4784
+X52889_at,1311,958,1649,1536,483,1258,1594,1427,1181,631,985,741,914,852,837,1196,2233,941,851,1592,552,285,1202,1625,1101,1145,1430,1448,1163,1401,1173,1145,1496,524,1243,1096,1146,1968
+X53683_at,285,56,370,201,-26,216,136,167,128,50,433,5,287,-89,-26,98,-168,153,149,-44,357,11,298,20,49,197,630,-94,204,809,12,544,289,-21,-119,139,-212,954
+X78711_at,147,104,167,153,50,40,78,56,109,50,53,80,53,100,124,91,325,143,74,77,66,113,108,128,56,76,139,76,108,92,66,91,114,74,115,62,144,278
+X80878_at,167,300,21,283,117,-44,344,704,466,146,114,-102,195,211,252,305,1182,-16,-120,166,-33,-20,129,-119,-340,115,646,316,113,119,432,75,-174,-22,141,120,265,478
+X81637_at,-5,21,272,-95,107,48,161,-124,81,-27,108,-102,-62,-72,29,68,79,59,-18,123,77,-85,129,270,7,115,-7,6,52,150,-29,79,40,41,-219,-81,89,-17
+X95876_at,914,375,954,662,-265,650,473,373,-437,138,225,-191,123,1468,-272,462,1070,579,417,-334,413,423,634,548,-167,219,316,862,795,539,29,-151,-166,-155,-111,300,93,389
+X96754_at,-456,-168,-500,-7,-31,-289,-131,-461,-284,67,136,-79,-297,22,-75,-26,-260,-199,-38,-178,-66,-36,-222,-231,-66,-162,-686,-408,-156,-197,-389,-109,-228,-117,-627,-414,-581,-521
+X98253_at,1159,767,1381,1015,711,798,1033,1316,1124,823,812,411,914,811,622,815,1840,881,644,1301,549,903,803,1040,774,953,1329,1220,1048,1315,841,946,1015,416,790,767,1353,1628
+Y00477_at,859,755,1111,790,604,757,757,965,791,576,612,373,558,789,485,642,1404,621,468,743,208,485,623,937,482,696,923,770,548,833,631,818,552,828,798,593,908,1079
+Z11933_at,-286,-188,-191,-173,-86,-99,-127,-175,-154,-60,-133,-63,-55,-105,-58,-119,-166,-123,-12,-101,-9,-138,-119,-188,-1,-109,-312,-138,-48,-168,-86,-2,-291,-74,-69,-154,-175,-367
+Z14978_at,806,470,1270,554,-106,1463,381,1215,313,-1,711,0,738,-121,560,242,796,808,682,964,-429,332,-376,-587,434,113,1329,163,993,1124,1637,1461,1009,177,697,718,781,-262
+Z68193_at,-8,6,108,-60,-18,163,10,370,12,-61,59,-44,-3,216,-48,-42,75,-17,-40,118,-82,168,307,-15,62,1,-67,-32,117,245,273,119,195,139,124,227,121,-56
+Z86000_at,538,863,737,882,386,816,741,782,602,548,349,389,459,505,456,572,1386,402,435,599,528,287,454,612,452,498,830,700,678,925,713,1217,804,335,961,525,1111,547
+M27749_at,949,864,1023,3807,1481,775,1401,2568,966,426,615,1490,1664,702,2803,3879,2060,479,1461,5916,677,857,1440,1556,1305,1583,4802,1072,1324,1273,947,813,943,888,637,1496,1544,1177
+M27749_r_at,-442,-541,-330,-198,72,94,114,-1242,-808,-195,-724,-490,-111,-92,369,627,-206,122,46,1146,-237,-151,-495,679,35,250,-226,-25,-750,-20,-941,-790,-867,-286,-1132,-863,89,-1187
+M33318_r_at,14,-132,13,-223,26,-270,-102,-166,-18,-132,-183,-159,-14,-105,-135,-91,-332,-40,9,-160,-92,-87,-60,-209,-141,-71,-18,-179,7,-240,-187,-135,-177,-63,-212,-103,-109,-28
+M34516_at,6698,2897,-740,1392,2312,-44,-1290,665,832,-222,1040,780,1325,902,546,-3,1755,10528,533,883,12522,694,169,-797,742,544,2653,7631,591,11169,9892,874,1199,1250,2098,953,116,1877
+M34516_r_at,4120,3348,691,2029,1926,890,725,2037,1086,640,818,559,991,1223,786,371,5927,9380,640,877,6492,789,805,641,652,955,3630,6794,1594,5842,6255,1192,1176,845,2991,1130,1005,2278
+U22028_at,-58,-278,-130,-300,208,-35,30,-278,165,-54,4,45,109,117,9,223,-515,-78,68,160,-129,-102,-262,-25,132,-209,-239,-163,-110,-295,-1,17,269,102,-414,-113,525,329
+U22028_r_at,324,113,110,143,-8,26,275,301,91,28,93,132,134,254,-34,45,-157,-39,-16,57,21,193,218,-1,89,76,89,-37,242,309,205,216,57,-3,54,143,127,255
+U88898_at,72,26,96,156,17,128,122,283,119,102,10,99,35,121,-21,105,100,89,64,79,-89,44,58,64,101,16,103,47,151,75,49,142,43,75,114,-49,41,94
+U88898_r_at,1865,820,1393,1521,613,1659,3481,2084,2092,911,837,1093,855,1910,549,841,1392,919,1160,531,502,891,957,1588,666,1039,1242,2292,2854,1995,1397,2370,1737,787,822,1168,1432,2468
+X97261_at,26,13,-14,-20,-8,-10,-35,62,50,-4,-7,-2,11,32,-4,-55,-17,-17,-45,42,89,34,24,-126,2,-16,67,-10,163,-149,12,93,31,3,44,-9,-38,16
+X97261_r_at,-201,-106,-372,-673,-47,-291,-349,-556,-278,-100,-100,-234,-24,-159,-191,-62,-289,-38,-164,-121,-159,-357,-526,-212,-126,-241,-341,-310,-233,-176,-385,-324,-197,-219,-111,-367,-274,-234
+D32129_f_at,7118,14580,5245,6779,8732,2633,5586,10295,6382,3845,5139,7372,15435,12962,15728,3104,12882,8097,7561,12559,3711,16325,1782,4768,13714,13713,5293,7265,6074,18066,12242,6275,8724,11383,15229,8454,7373,9068
+D38437_f_at,119,242,312,322,338,373,287,247,382,251,216,107,236,404,541,345,575,249,128,792,159,102,277,339,337,303,262,191,185,159,192,259,217,498,214,214,350,173
+D38498_f_at,139,346,323,265,214,257,351,254,342,210,217,97,218,381,533,374,639,243,103,700,128,143,157,330,268,316,327,153,206,249,622,415,191,424,541,580,346,72
+HG1515-HT1515_f_at,2829,4197,3850,3935,3033,3362,3839,2775,7457,4413,6224,3696,3052,4972,5917,4746,9199,3085,4366,10401,5112,3191,4422,6100,4814,3175,3029,5660,3294,3689,4667,4015,5974,4980,5351,3623,4599,4659
+HG2139-HT2208_f_at,20,-57,28,-19,-11,-120,38,-85,-49,-53,-61,7,10,-71,-41,29,-85,-5,-15,133,-152,-73,66,-96,8,-61,-104,-102,57,-17,18,42,-52,5,-5,-48,-66,-64
+HG2255-HT2344_f_at,55,27,75,74,73,74,-28,-58,93,96,44,-37,56,-8,126,-13,207,61,24,69,-3,-7,93,-4,26,-56,26,-117,-72,-32,150,31,162,97,43,18,39,31
+HG2915-HT3059_f_at,7531,8445,3385,5252,2911,3314,3481,6015,4966,2183,3278,4912,9826,5473,11837,3198,4631,5217,4756,12565,438,4150,1556,3574,6723,7873,1653,4867,2880,14675,9258,3634,8218,6039,10429,3487,8715,7913
+HG2917-HT3061_f_at,7632,7445,3275,5700,3719,3158,4150,5646,4446,2398,3348,4499,11134,5416,12184,3615,5630,4725,5356,13750,533,3865,1430,3197,6488,7486,2491,5750,3243,12718,10502,2688,8121,4821,10241,3540,8342,9328
+HG3527-HT3721_f_at,1183,1434,2022,2615,924,1820,2226,2353,2455,1266,2377,1845,1301,1613,1194,1673,1633,1232,826,1308,-298,669,1711,1422,2411,1626,2142,973,2419,1394,1030,1335,1027,1236,1637,2129,2017,2492
+HG3707-HT3922_f_at,-1315,-689,-1334,-840,-405,-1328,-1270,-1928,-1510,-612,-999,-741,-698,-481,-646,-645,-1196,-602,-465,-920,54,-944,-1027,-1036,-693,-561,-1403,-813,-750,-1025,-957,-874,-730,-392,-696,-1029,-1587,-1662
+HG4027-HT4297_f_at,51,25,-9,99,48,65,84,106,80,53,68,61,-7,26,60,81,-25,-1,-21,18,-21,26,98,91,6,67,122,20,26,16,14,102,36,63,-54,74,41,200
+HG4236-HT4506_f_at,158,86,152,167,70,222,70,190,63,89,73,76,21,82,78,0,405,68,107,26,52,141,151,73,92,-70,167,74,117,-22,66,-2,66,117,57,30,238,231
+HG4490-HT4876_f_at,1045,390,1141,1526,407,1194,1379,1791,556,259,354,612,224,218,499,557,543,331,340,436,129,923,1111,854,528,346,403,938,649,1594,611,904,966,587,448,506,1664,1518
+HG458-HT458_f_at,-165,-125,-172,-172,-70,-241,-168,-317,-41,36,-67,-156,-139,-44,-100,-94,-56,-90,-85,-105,-29,-74,-281,-137,-106,-147,-148,-162,-276,-264,-303,-175,-242,-82,-255,-163,-81,-236
+HG67-HT67_f_at,-35,-45,55,-74,-10,-168,-186,-85,-69,-21,69,-20,7,-110,66,45,196,-21,-167,264,54,-128,-18,-21,-96,-31,-109,-256,-221,-215,-100,-45,-152,15,-150,-311,-38,-88
+J00117_f_at,-1589,-772,-914,-1134,-713,-554,-314,-1932,-1644,-1744,-714,-813,-819,-908,-645,-1371,-1474,-407,-1353,-242,-763,-745,-834,-385,-721,-142,-1764,-1042,-1026,-1430,-964,-1083,-1269,-504,-2423,-937,-1688,-1313
+J00148_cds2_f_at,-93,-154,-184,41,-25,24,-82,-178,-342,-193,-246,-80,-26,-134,81,-2,-564,-136,-34,106,-99,53,-75,-107,-107,-147,-405,-380,-281,-380,-378,-49,-280,-63,-466,-232,-119,-211
+J00209_f_at,-48,-32,27,-7,-28,-53,-26,44,-21,-53,-16,38,-48,-52,-35,-35,-26,-11,-29,-64,-13,-39,-75,-65,-85,-34,45,-41,-12,-45,-18,1,17,-25,-61,14,-1,-32
+J00212_f_at,395,272,540,380,218,382,433,467,526,295,420,252,170,359,208,291,748,270,182,209,214,238,368,378,198,295,744,445,310,421,403,288,375,95,448,415,583,701
+J03071_cds3_f_at,267,176,130,216,205,133,374,41,374,66,162,112,203,92,143,271,458,-23,198,74,29,-34,123,398,166,204,219,336,209,149,99,180,220,130,313,184,318,245
+K02405_f_at,2730,772,208,1383,593,357,562,1232,582,246,236,1133,3130,486,1980,573,863,5045,2547,5052,705,1409,197,654,1354,1099,755,601,1221,2258,1294,1054,1460,789,1831,1866,2153,2203
+K03183_f_at,-213,-65,-463,-31,58,296,73,-1734,-225,-242,-375,57,-874,-359,103,-605,605,-570,111,893,-423,-82,359,-396,21,-7,705,-1354,341,-565,-1215,-226,134,261,-657,-336,304,-38
+K03189_f_at,1296,723,436,1010,790,974,685,1061,1209,857,631,787,437,582,498,1376,1580,655,-47,266,-348,589,326,443,590,702,613,1263,1046,2355,667,641,1347,504,1841,1247,1284,1386
+K03192_f_at,29,-15,347,246,121,261,206,-68,197,247,130,99,140,11,140,224,423,186,76,79,96,-206,254,117,37,193,217,48,-48,67,-110,109,13,-57,32,198,149,246
+K03204_f_at,-536,-456,-445,-608,-310,-533,-583,-875,-511,-384,-358,-369,-234,-434,-148,-291,-784,-290,-260,-112,-181,-317,-381,-355,-411,-333,-284,-488,-485,-493,-610,-72,-436,19,-189,-285,-677,-557
+K03207_f_at,682,299,402,274,143,-142,411,946,129,591,128,228,115,420,556,312,393,154,-93,361,21,602,535,693,551,89,-430,823,209,-747,-494,986,388,239,105,31,463,680
+L00389_f_at,145,315,750,-6,104,227,1087,362,543,283,218,284,94,192,156,595,463,584,293,288,132,551,328,-91,505,268,2512,100,214,498,499,675,429,70,233,486,471,596
+L02326_f_at,691,953,818,2381,1655,793,1021,2163,771,328,786,800,1398,357,1701,1670,1043,1999,1048,4099,514,1173,982,1430,1137,1607,2508,1715,1077,1946,2357,865,1098,799,532,773,1047,797
+L05188_f_at,191,248,400,316,199,433,502,247,383,120,268,206,198,272,95,284,404,133,261,257,193,156,349,175,232,375,411,305,290,384,397,235,390,209,208,294,375,398
+L18877_f_at,378,116,323,237,137,286,94,296,299,157,194,185,211,224,111,265,474,165,238,242,162,214,231,371,210,254,352,325,425,243,217,396,242,91,104,170,342,264
+L18920_f_at,45,-14,193,190,39,67,124,164,109,35,18,-18,43,131,25,11,131,11,31,8,177,15,134,64,70,32,137,-9,88,-3,50,103,36,9,130,58,70,78
+L42583_f_at,537,438,358,503,300,334,362,647,764,355,538,260,367,451,397,461,698,299,387,536,194,398,343,774,589,439,237,669,420,356,717,550,824,344,464,503,710,570
+L42601_f_at,432,518,468,430,481,321,389,536,525,294,714,517,474,346,348,368,756,214,314,676,168,421,393,814,698,359,597,515,516,800,586,335,999,454,726,410,548,656
+L42611_f_at,1299,903,1283,1641,473,1031,1313,721,1923,849,932,849,755,999,766,993,1065,368,887,1346,624,396,881,850,1527,874,1373,1821,1671,1320,1418,653,1437,684,1114,596,1585,2014
+L76568_xpt3_f_at,989,258,432,400,261,92,243,523,974,629,393,377,594,697,986,104,1739,415,57,791,1295,39,347,1944,104,836,95,1139,274,432,423,242,723,1518,525,-11,988,104
+M20030_f_at,-320,-115,-239,-19,1,-279,-309,-347,-153,187,-150,-166,-144,-246,-30,13,500,-71,54,-76,48,-86,-113,5,-162,-116,-278,-271,-341,-298,-208,-174,-203,-254,-49,-23,-278,89
+M22612_f_at,-216,-374,-442,-132,-128,60,-294,-452,-413,-243,-284,-100,-191,-193,-218,-169,-564,-244,-154,-218,-36,-215,-36,-305,-263,-204,-492,-463,-295,-344,-622,-198,-11,-29,-271,-85,9352,-360
+M27318_f_at,115,0,4,68,15,174,179,37,90,25,-16,8,66,88,-7,77,192,41,39,-24,67,115,136,-112,75,40,-4,128,120,-25,-7,-13,-26,-3,-18,53,35,88
+M28585_f_at,-26,-39,-57,-60,-8,-44,-68,7,-85,48,-24,-30,-8,-69,-24,8,20,-36,-16,-35,-77,-48,-60,-118,-4,-11,32,-21,26,-64,-58,3,-10,-13,-22,-22,-96,-50
+M33317_f_at,215,97,168,267,25,101,181,-29,103,99,81,142,140,100,17,146,389,79,-67,-284,242,113,286,97,112,195,237,274,257,-27,101,48,189,-49,585,70,196,126
+M33600_f_at,13537,3319,552,3529,4240,1417,3216,4776,786,838,236,4666,17459,1640,8739,3370,4405,14706,9377,12634,1575,6251,216,4465,3297,9173,2523,3570,6588,12950,4575,304,9662,2705,13176,8513,10526,8252
+M37755_f_at,905,701,961,878,551,711,828,985,844,434,932,487,465,653,402,705,1050,490,522,611,393,639,813,795,616,706,1120,1069,834,745,783,892,705,333,803,667,891,1025
+M57423_f_at,172,40,39,25,61,103,23,-59,86,147,82,50,114,61,98,90,73,15,-89,70,-21,103,34,31,51,-37,87,-2,40,-9,31,202,58,82,134,45,46,134
+M60750_f_at,1184,1887,903,1161,698,48,999,308,572,968,440,1460,884,333,519,777,3562,594,261,929,724,414,539,2050,2519,891,536,894,266,637,430,1011,637,352,986,313,1121,668
+M77481_rna1_f_at,17,-54,-80,-66,-8,-51,-33,-50,-46,-18,-21,-48,16,-27,-55,-42,60,-26,-5,74,18,-94,-142,-28,27,-11,-90,-130,-48,-93,152,74,-114,-5,-66,-136,-27,-29
+M90356_f_at,176,216,168,360,490,94,277,22,497,502,437,329,469,291,514,456,563,261,533,817,1133,141,461,376,280,215,231,357,276,152,264,278,406,483,415,200,426,342
+M92269_f_at,-226,-71,-198,-106,-51,-32,-141,-199,9,-49,-101,-60,-110,-104,-90,-64,-261,-87,-106,-115,31,79,-37,-109,-39,9,-400,-224,-62,-299,-108,-113,0,-95,-162,-143,93,-180
+U03735_f_at,119,3,116,31,10,26,43,46,21,19,65,60,-1,69,-35,67,49,89,-25,22,106,-340,26,45,-147,-41,103,34,-43,-109,18,108,7,-61,-135,20,3,112
+U10689_f_at,130,163,271,165,56,158,131,281,173,134,141,119,1,198,-249,148,61,17,-269,156,13,-3247,197,84,166,55,255,196,223,98,213,274,7,10,-312,149,237,302
+U10690_f_at,246,394,383,223,139,197,383,526,444,201,192,208,184,426,115,208,978,268,139,343,297,298,205,278,297,269,597,284,276,46,278,639,359,85,300,172,450,410
+U22029_f_at,26,-83,36,-46,45,-33,30,-134,11,76,38,-148,-71,-56,-4,118,157,58,150,198,7,-22,-20,-39,-113,219,-9,249,26,-46,-1,241,75,-9,-145,-7,-30,158
+U49974_f_at,63,153,157,90,-29,106,102,184,107,109,64,17,26,21,68,51,318,35,11,165,0,30,153,171,54,63,131,212,43,-171,50,230,108,-50,-381,111,145,56
+U65918_f_at,60,18,28,-19,23,55,-11,-23,6,21,-33,-34,11,70,9,-23,36,-15,-21,59,28,39,11,-36,-6,1,31,23,-9,-61,57,22,20,-42,-2,-11,-12,32
+V00532_rna1_f_at,-20,3,12,-36,-20,1,-57,-121,-43,-43,-26,-10,-58,-80,-29,-56,28,-58,-28,-56,36,-20,-58,-22,-67,-21,-23,-37,-57,-74,28,35,-74,7,61,-39,-76,-74
+V00533_rna1_f_at,-30,-135,-213,-87,-104,-149,-168,-224,-152,-119,-100,27,-149,-161,-93,-117,-237,-118,-117,-92,-74,-107,30,-108,-132,-146,-111,-146,-115,-204,-154,-232,-98,-45,-180,-146,-111,-165
+V00542_f_at,-91,-72,-110,-103,-47,-108,-193,-245,-52,7,-246,-66,-148,-43,-107,-27,-84,-67,-118,-77,-37,-130,-11,-128,-88,-11,-179,-112,-238,-107,-23,-106,-20,-75,-116,-49,-18,-85
+V00551_f_at,-43,-34,23,33,-13,8,-57,-7,-2,-20,-20,-8,-41,4,-27,-126,-54,-15,-46,-52,0,-105,-1,-19,-111,-71,-73,-35,-48,-132,-56,-21,-13,-41,-122,-41,-51,-77
+V01516_f_at,488,518,426,534,325,330,297,535,635,311,663,537,339,594,256,570,625,340,440,561,296,341,659,574,591,490,372,842,514,525,774,719,777,424,635,589,554,999
+X00090_f_at,1,-175,-155,31,-24,-62,-53,-176,52,-112,-92,143,97,-178,89,-36,142,-78,19,36,-121,-68,87,-101,-151,-16,-84,-275,-189,-113,-47,-116,5,70,177,44,-88,-106
+X13930_f_at,504,440,687,376,299,266,552,731,596,561,463,373,532,341,507,447,1138,350,478,786,427,180,590,506,599,427,1176,639,442,512,573,594,557,326,736,201,710,763
+X53065_f_at,391,200,387,317,162,209,362,235,285,170,221,239,219,329,212,225,496,258,153,251,179,141,172,286,267,181,364,281,420,294,239,299,303,99,233,187,385,564
+X64177_f_at,-763,51,-474,-336,-56,-391,-618,-1202,-821,1093,-473,761,-558,-522,-572,-546,-2229,-252,1274,-635,-514,221,-474,-218,40,-551,-1071,-444,-853,119,962,-675,-559,-17,12,-453,-1025,-1136
+X67491_f_at,172,154,180,325,279,302,379,215,752,233,415,208,82,251,432,175,656,73,133,96,-84,74,360,542,69,89,150,21,26,270,425,71,317,190,1034,338,705,197
+X71345_f_at,149,418,272,149,183,167,280,203,182,159,227,319,189,179,140,215,399,273,250,467,212,255,81,278,256,298,375,349,153,172,418,255,585,119,55,-39,9230,485
+X97444_f_at,341,433,591,173,259,473,351,311,642,329,704,235,77,202,207,334,476,377,293,370,166,274,360,389,256,321,549,536,278,616,479,366,546,390,630,358,665,715
+Z80780_f_at,788,736,959,431,605,184,211,-443,-153,334,43,1434,790,-25,507,791,785,-1,171,548,186,31,34,951,1030,586,-115,657,45,559,691,803,328,151,1835,391,925,-176
+X00351_f_at,21210,21059,24292,17558,18530,33638,20531,17000,22307,20357,18573,14924,17084,20761,19599,19110,22689,22481,12040,15575,868,7597,19551,19009,10929,16563,15848,16027,10462,26818,17484,11184,16876,9184,21787,21617,24514,18039
+X01677_f_at,13771,15097,17378,13818,15619,27972,18708,11531,15594,18398,17651,23030,15408,13972,13935,15036,14758,17485,15675,11343,2518,16025,23399,14012,17512,13508,17149,13940,16721,18306,16806,16523,13859,19228,15527,17676,14574,15518
+M31667_f_at,598,563,1808,576,65,999,1828,848,932,570,816,685,125,371,180,590,1335,1371,602,488,227,644,948,109,830,419,2447,538,459,1227,1253,1030,1102,374,385,852,1338,1608
+L41268_f_at,396,171,363,455,122,268,452,293,437,222,175,370,143,88,189,285,698,212,310,131,203,238,495,137,611,267,312,521,228,597,328,236,375,61,196,74,67,403
+X99479_f_at,245,-149,325,594,126,405,720,607,467,216,9,175,56,-81,97,129,305,146,222,47,0,-190,292,-121,230,123,816,84,96,-117,454,21,-105,131,-253,245,-56,221
+HG658-HT658_f_at,14476,13686,6560,8955,8443,3632,9542,15741,7641,6039,6012,11347,15086,11387,14741,4700,10977,10693,10248,13484,10409,16305,2129,10672,12817,15085,6656,8102,7771,16593,13591,11303,10547,9355,13538,10144,10373,12292
+M94880_f_at,10882,11789,5023,9567,8512,4214,7144,11441,6286,3584,4479,10249,14833,11702,14856,3458,11984,8760,7370,10960,393,14711,1730,5703,13201,10872,4226,6639,4972,15921,13307,8768,10235,11461,14783,9846,9002,10418
+S80905_f_at,701,76,804,367,182,508,835,1311,345,416,187,352,368,243,341,419,436,494,281,-273,323,542,444,453,222,449,702,956,226,536,391,-442,685,-95,104,190,745,259
+X03068_f_at,2762,1567,1090,1708,1503,839,993,3406,1098,629,817,3158,9319,846,2605,1407,1116,8160,3243,6136,1153,1821,566,2108,2127,3101,1381,1807,2051,5627,2441,818,4431,1028,3624,2633,2842,2884
+Z34822_f_at,-325,-191,-258,-357,-78,-311,-361,-334,-242,-142,-232,-271,-93,-217,-140,-179,-100,-64,-173,-118,-143,-218,-271,-300,-130,-193,-168,-230,-447,-331,-396,-365,-210,-142,-242,-230,-348,-224
+U87593_f_at,-67,-88,9,45,29,46,-68,56,-58,-24,-25,-47,3,90,85,75,-6,16,73,140,68,39,-39,-33,32,162,-109,11,67,-21,-51,-93,18,-26,-97,20,111,66
+U88902_cds1_f_at,346,290,220,430,159,199,448,325,293,298,150,120,270,179,175,302,600,514,272,509,199,107,159,170,253,995,827,283,370,386,228,202,403,58,386,207,330,464
+AC002076_cds2_at,-68,14,-58,-35,18,-5,-16,-29,6,-13,-28,-27,23,8,-9,-66,199,52,-14,43,-114,-37,0,-61,-71,-5,29,18,16,-8,-50,-91,-31,-2,59,-20,-19,46
+D64015_at,229,194,294,128,71,168,317,272,239,80,306,126,192,98,206,187,650,188,153,246,28,176,273,406,178,127,211,383,228,356,197,267,207,113,308,132,295,238
+HG2510-HT2606_at,-14,56,95,42,42,48,67,106,-4,88,114,-24,28,87,35,17,189,34,10,52,18,10,62,50,62,41,92,71,110,27,54,3,135,-30,32,27,80,118
+L10717_at,108,303,143,22,44,145,36,172,143,22,97,2,23,187,66,30,117,22,51,14,73,9,121,52,36,30,15,82,86,-3,74,20,86,54,60,53,109,84
+L34355_at,28,-242,-25,-131,-33,-209,546,133,-129,-82,44,-287,10,-93,-29,98,-414,229,-24,113,101,-153,-214,9,163,189,-240,157,161,416,222,-139,-228,-71,-326,-205,-54,-103
+L78833_cds4_at,349,214,464,342,159,147,304,428,359,252,177,137,216,179,107,276,659,236,156,378,78,149,305,246,200,294,381,339,185,362,211,147,216,95,139,319,388,545
+M13981_at,61,-28,513,142,71,376,243,103,368,107,195,162,33,84,181,115,40,-62,89,65,134,-1,332,192,26,91,-70,198,173,203,99,150,120,59,-118,149,172,129
+M21064_at,273,143,238,277,134,252,349,283,292,292,192,181,188,198,126,190,299,172,142,216,69,79,284,201,160,140,413,323,55,388,251,130,247,19,247,281,292,348
+M93143_at,384,231,720,307,178,384,312,445,585,256,173,91,266,282,438,203,898,376,204,414,226,132,231,552,230,338,483,496,415,432,249,160,399,45,192,306,205,477
+S78825_at,-306,-336,-204,-320,-182,-426,-488,-556,-349,264,-244,-281,-134,-217,-167,-211,-249,-173,-147,-114,-241,-528,-104,-677,-129,-110,-273,-294,-413,-257,-430,-381,-220,-78,-394,-442,-396,-193
+U11863_at,-1827,-2380,-1772,-2022,-179,-2217,-2300,-3019,-1439,-1037,-1395,-1399,-1707,-1687,-404,-280,-3383,-1066,-728,-569,-873,-698,-1096,-1784,-1387,-164,-1448,-1927,-1959,-2149,-3452,-4082,-1651,-887,-1634,-2404,-2525,-2866
+U29175_at,1582,624,753,743,626,1157,552,572,1776,756,1972,219,1322,732,1636,2076,917,453,1660,2174,3707,295,1377,1456,404,1982,949,454,391,412,393,286,429,314,208,385,688,248
+U48730_at,185,169,315,240,156,115,30,289,356,42,185,48,213,267,120,79,241,186,318,225,103,158,129,176,138,190,120,260,93,234,146,103,173,173,225,36,348,209
+U58516_at,511,837,1199,835,649,1221,819,629,980,986,642,224,583,440,722,631,1215,573,397,1020,595,402,1058,725,392,678,816,1009,336,1653,486,1121,755,492,737,592,938,634
+U73738_at,-125,-36,33,218,57,-76,-178,-86,6,26,32,60,3,52,20,-26,127,-57,-48,-110,-12,57,140,13,8,77,45,-55,-45,67,-32,102,-23,54,63,57,-15,-58
+X06956_at,389,442,168,174,504,172,151,302,177,101,137,194,530,229,332,455,255,694,1939,209,36,253,176,249,506,2527,62,139,170,486,334,330,573,277,472,215,433,375
+X16699_at,-37,-17,52,-110,-26,-74,-18,23,-12,21,-81,-10,-39,-4,-5,-62,50,-19,-18,-51,26,-52,-22,1,24,-36,-71,-57,12,-88,35,-112,42,-13,33,-22,-2,-23
+X83863_at,793,782,1138,627,250,645,1140,1799,758,570,672,291,696,431,195,736,1701,636,538,1435,208,1010,617,646,1034,838,583,834,752,1293,1733,1567,987,279,737,588,1170,2315
+Z17240_at,329,295,777,170,314,341,482,446,385,359,208,41,302,269,59,445,1109,205,90,255,113,405,336,391,69,313,677,557,295,342,304,627,279,51,227,361,284,250
+L49218_f_at,36,11,41,-50,14,26,10,59,115,9,25,8,24,8,31,42,61,17,-50,53,-8,19,9,81,24,21,-1,-12,28,26,12,21,22,6,-9,-26,39,-12
+M71243_f_at,191,76,228,126,56,193,369,781,244,171,116,-2,74,163,116,246,526,127,333,545,22,270,243,203,807,145,208,335,1558,246,3193,2520,662,2484,371,133,298,790
+Z78285_f_at,-37,-14,-41,-91,-25,-53,-42,20,-39,7,-62,-80,-11,-22,-18,-43,-83,-13,-24,-16,-22,-27,36,-94,-41,-19,10,-65,-67,23,-33,0,-46,-2,-31,-32,-3,-10
diff --git a/assets/exercises/intake.txt b/assets/exercises/intake.txt
new file mode 100644
index 0000000..f2a17a4
--- /dev/null
+++ b/assets/exercises/intake.txt
@@ -0,0 +1,12 @@
+pre post
+1 5260 3910
+2 5470 4220
+3 5640 3885
+4 6180 5160
+5 6390 5645
+6 6515 4680
+7 6805 5265
+8 7515 5975
+9 7515 6790
+10 8230 6900
+11 8770 7335
diff --git a/assets/exercises/spider_wolff_gorb_2013.csv b/assets/exercises/spider_wolff_gorb_2013.csv
new file mode 100644
index 0000000..733338d
--- /dev/null
+++ b/assets/exercises/spider_wolff_gorb_2013.csv
@@ -0,0 +1,284 @@
+# data provided by Jonas O. Wolff and Stanislav N. Gorb: doi:10.1038/srep01101
+leg,type,friction
+L1,pull,0.9
+L1,pull,0.91
+L1,pull,0.86
+L1,pull,0.85
+L1,pull,0.8
+L1,pull,0.87
+L1,pull,0.92
+L1,pull,0.83
+L1,pull,0.88
+L1,pull,0.87
+L1,pull,0.83
+L1,pull,0.76
+L1,pull,0.73
+L1,pull,0.79
+L1,pull,0.73
+L1,pull,0.77
+L1,pull,0.62
+L1,pull,0.72
+L1,pull,0.72
+L1,pull,0.61
+L1,pull,0.64
+L1,pull,0.59
+L1,pull,1.15
+L1,pull,1.08
+L1,pull,0.92
+L1,pull,1.26
+L1,pull,0.88
+L1,pull,1.04
+L1,pull,1.09
+L1,pull,0.78
+L1,pull,1.12
+L1,pull,1.46
+L1,pull,1.69
+L1,pull,1.66
+L1,push,0.39
+L1,push,0.34
+L1,push,0.37
+L1,push,0.39
+L1,push,0.37
+L1,push,0.33
+L1,push,0.3
+L1,push,0.36
+L1,push,0.32
+L1,push,0.53
+L1,push,0.45
+L1,push,0.35
+L1,push,0.34
+L1,push,0.3
+L1,push,0.37
+L1,push,0.34
+L1,push,0.36
+L1,push,0.41
+L1,push,0.4
+L1,push,0.39
+L1,push,0.38
+L1,push,0.39
+L1,push,0.45
+L1,push,0.31
+L1,push,0.33
+L1,push,0.24
+L1,push,0.3
+L1,push,0.34
+L1,push,0.37
+L1,push,0.32
+L1,push,0.29
+L1,push,0.87
+L1,push,0.97
+L1,push,0.88
+L2,pull,0.91
+L2,pull,0.9
+L2,pull,0.9
+L2,pull,0.9
+L2,pull,0.98
+L2,pull,1.18
+L2,pull,1.12
+L2,pull,1.24
+L2,pull,1.25
+L2,pull,1.24
+L2,pull,1.32
+L2,pull,1.26
+L2,pull,1.38
+L2,pull,1.34
+L2,pull,1.26
+L2,push,0.54
+L2,push,0.51
+L2,push,0.48
+L2,push,0.49
+L2,push,0.59
+L2,push,0.46
+L2,push,0.63
+L2,push,0.52
+L2,push,0.52
+L2,push,0.54
+L2,push,0.55
+L2,push,0.46
+L2,push,0.57
+L2,push,0.52
+L2,push,0.53
+L3,pull,1.46
+L3,pull,1.52
+L3,pull,1.47
+L3,pull,1.33
+L3,pull,1.13
+L3,pull,0.97
+L3,pull,1.07
+L3,pull,1.08
+L3,pull,1.03
+L3,pull,0.81
+L3,pull,1.44
+L3,pull,1.5
+L3,pull,1.48
+L3,pull,1.11
+L3,pull,1.64
+L3,pull,1.52
+L3,pull,1.34
+L3,pull,1.21
+L3,pull,1.18
+L3,pull,1.32
+L3,pull,1.21
+L3,pull,1.14
+L3,pull,1.07
+L3,pull,1.35
+L3,pull,0.97
+L3,pull,1.08
+L3,pull,0.99
+L3,pull,0.98
+L3,pull,0.98
+L3,pull,1.44
+L3,pull,1.36
+L3,pull,1.31
+L3,pull,1.06
+L3,pull,1.12
+L3,pull,1.25
+L3,pull,1.01
+L3,pull,1.04
+L3,pull,1.26
+L3,pull,1.48
+L3,pull,1.74
+L3,pull,1.69
+L3,pull,1.84
+L3,pull,1.67
+L3,pull,1.15
+L3,pull,1.21
+L3,pull,1.27
+L3,pull,1.34
+L3,pull,0.99
+L3,pull,0.88
+L3,pull,1.77
+L3,pull,1.27
+L3,pull,1.71
+L3,push,0.36
+L3,push,0.28
+L3,push,0.34
+L3,push,0.29
+L3,push,0.25
+L3,push,0.33
+L3,push,0.29
+L3,push,0.26
+L3,push,0.25
+L3,push,0.39
+L3,push,0.31
+L3,push,0.37
+L3,push,0.31
+L3,push,0.44
+L3,push,0.4
+L3,push,0.38
+L3,push,0.38
+L3,push,0.37
+L3,push,0.37
+L3,push,0.38
+L3,push,0.4
+L3,push,0.42
+L3,push,0.39
+L3,push,0.4
+L3,push,0.35
+L3,push,0.35
+L3,push,0.35
+L3,push,0.35
+L3,push,0.35
+L3,push,0.41
+L3,push,0.42
+L3,push,0.4
+L3,push,0.39
+L3,push,0.41
+L3,push,0.41
+L3,push,0.37
+L3,push,0.42
+L3,push,0.45
+L3,push,0.41
+L3,push,0.42
+L3,push,0.44
+L3,push,0.42
+L3,push,0.42
+L3,push,0.41
+L3,push,0.39
+L3,push,0.39
+L3,push,0.45
+L3,push,0.38
+L3,push,0.39
+L3,push,0.42
+L3,push,0.41
+L3,push,0.41
+L4,pull,1.78
+L4,pull,1.56
+L4,pull,1.48
+L4,pull,1.41
+L4,pull,1.46
+L4,pull,1.33
+L4,pull,1.46
+L4,pull,1.48
+L4,pull,1.59
+L4,pull,1.41
+L4,pull,1.53
+L4,pull,1.5
+L4,pull,1.56
+L4,pull,1.32
+L4,pull,1.51
+L4,pull,1.44
+L4,pull,1.48
+L4,pull,1.51
+L4,pull,1.52
+L4,pull,1.17
+L4,pull,1.47
+L4,pull,1.38
+L4,pull,1.53
+L4,pull,1.34
+L4,pull,1.29
+L4,pull,1.29
+L4,pull,1.2
+L4,pull,1.16
+L4,pull,1.39
+L4,pull,1.74
+L4,pull,1.31
+L4,pull,1.33
+L4,pull,1.39
+L4,pull,1.26
+L4,pull,1.3
+L4,pull,1.23
+L4,pull,1.2
+L4,pull,1.15
+L4,pull,1.24
+L4,pull,1.33
+L4,push,0.65
+L4,push,0.65
+L4,push,0.67
+L4,push,0.66
+L4,push,0.64
+L4,push,0.61
+L4,push,0.57
+L4,push,0.71
+L4,push,0.67
+L4,push,0.53
+L4,push,0.81
+L4,push,0.76
+L4,push,0.77
+L4,push,0.82
+L4,push,0.64
+L4,push,0.7
+L4,push,0.72
+L4,push,0.84
+L4,push,0.86
+L4,push,0.44
+L4,push,0.42
+L4,push,0.43
+L4,push,0.53
+L4,push,0.45
+L4,push,0.37
+L4,push,0.32
+L4,push,0.35
+L4,push,0.35
+L4,push,0.26
+L4,push,0.23
+L4,push,0.24
+L4,push,0.21
+L4,push,0.25
+L4,push,0.21
+L4,push,0.2
+L4,push,0.2
+L4,push,0.24
+L4,push,0.21
+L4,push,0.17
+L4,push,0.27
diff --git a/assets/exercises/students.csv b/assets/exercises/students.csv
new file mode 100644
index 0000000..bede7ef
--- /dev/null
+++ b/assets/exercises/students.csv
@@ -0,0 +1,48 @@
+gender,height,weight,shoesize,leftrighthanded,smoker,wrist_R,wrist_L,siblings,mother_height,father_height
+M,183,72,42,R,NS,17,16.6,2,170,174
+M,183,68,43,R,NS,17,16,1,170,178
+M,182,73,44,R,NS,18.5,18,2,168,181
+M,175,66,41,L,NS,17,17,2,156,178
+M,158,42,41,R,NS,14,14,2,156,178
+M,179,70,47,R,S,16,16,1,150,190
+F,172,61,38,L,NS ,15.3,15,2,168,186
+M,185,69,44,R,NS,16.5,15,1,172,167
+M,177,75,43,R,S,17,16.3,1,161,169
+F,165,50,37,R,NS,15,15,3,163,175
+M,186,93,45,R,S,18.6,18.7,1,176,173
+F,165,53,39,R,NS,15.3,15,1,166,180
+F,156,48,37,R,NS,15,"15,2",2,168,177
+M,178,75,43,R,NS,17,16.8,0,175,167
+F,172,49,39,R,NS,14,14,1,168,180
+F,168,52,38,R,NS,14.1,13.7,1,165,185
+M,183,72,42,R,NS,17,16.6,2,170,174
+M,178,73,42,R,NS,18,17,1,165,168
+M,183,60,43,R,NS,17,17,1,174,178
+F,166,48,38,R,NS,14,14,2,158,172
+M,1.77,70,45,R,NS,17,17,1,173,175
+M,180,70,43,R,NS,17,17,4,160,170
+M,174,69,42,R,NS,16.7,16.4,1,164,175
+M,184,70,46,R,NS,17,17.5,1.5,160,175
+M,168,69,43,R,S,16.5,16,1,153,176
+F,176,59,39,R,NS,15,15,1,166,182
+F,159,51,38,R,S,15.6,15.8,1,168,167
+M,169,60,41,R,NS,15,15,1,157,168
+F,164,61,38.5,R,S,15.5,15.5,1,170,178
+F,150,49,35,R,NS,14.5,14.5,4,148,165
+F,163,54,37.5,R,NS,15.2,14.8,3,167,164
+M,181,96,44,R,NS,18.6,19.3,1,164,174
+F,169,68,40,G,nS,14.3,14.5,1,161,178
+M,170,65,44,R,S,15.2,15.5,1,175,178
+F,160,50,34.5,R,NS,14.5,14.3,0,162,172
+M,180,63,42,R,NS,14.5,14.2,2,160,182
+F,165,49,38,R,NS,14,14.5,1,168,182
+M,184,80,45,R,NS,17,16,2,162,175
+F,170,65,40,R,NS,16,15,2,161,178
+F,173,66,40,D,NS,16.5,16,1,175,185
+F,165,63,39,L,NS,17.2,17.2,0,162,182
+F,159,52,37,R,NS,15,15,1,157,170
+M,181,65,44,L,NS,17.5,17,1,162,172
+F,175,76,42,R,NS,16.6,16.8,1,161,189
+F,170,58,38,R,NS,14.6,14.7,0,159,180
+F,168,60,41,R,NS,14.5,14,3,173,178
+F,172,62,39,R,S,14.8,14.8,1,165,185
diff --git a/assets/images/SIB_logo.svg b/assets/images/SIB_logo.svg
new file mode 100644
index 0000000..b5f2113
--- /dev/null
+++ b/assets/images/SIB_logo.svg
@@ -0,0 +1,138 @@
+
+
+
+
+
+ image/svg+xml
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
diff --git a/assets/images/favicon.png b/assets/images/favicon.png
new file mode 100644
index 0000000..1cf13b9
Binary files /dev/null and b/assets/images/favicon.png differ
diff --git a/assets/images/reactions_zoom.png b/assets/images/reactions_zoom.png
new file mode 100644
index 0000000..96f0751
Binary files /dev/null and b/assets/images/reactions_zoom.png differ
diff --git a/assets/images/reply_in_thread.png b/assets/images/reply_in_thread.png
new file mode 100644
index 0000000..13d338e
Binary files /dev/null and b/assets/images/reply_in_thread.png differ
diff --git a/assets/images/zoom_icons.png b/assets/images/zoom_icons.png
new file mode 100644
index 0000000..50f31fc
Binary files /dev/null and b/assets/images/zoom_icons.png differ
diff --git a/assets/javascripts/bundle.7389ff0e.min.js b/assets/javascripts/bundle.7389ff0e.min.js
new file mode 100644
index 0000000..c7df719
--- /dev/null
+++ b/assets/javascripts/bundle.7389ff0e.min.js
@@ -0,0 +1,29 @@
+"use strict";(()=>{var Mi=Object.create;var gr=Object.defineProperty;var Li=Object.getOwnPropertyDescriptor;var _i=Object.getOwnPropertyNames,Ft=Object.getOwnPropertySymbols,Ai=Object.getPrototypeOf,xr=Object.prototype.hasOwnProperty,ro=Object.prototype.propertyIsEnumerable;var to=(e,t,r)=>t in e?gr(e,t,{enumerable:!0,configurable:!0,writable:!0,value:r}):e[t]=r,P=(e,t)=>{for(var r in t||(t={}))xr.call(t,r)&&to(e,r,t[r]);if(Ft)for(var r of Ft(t))ro.call(t,r)&&to(e,r,t[r]);return e};var oo=(e,t)=>{var r={};for(var o in e)xr.call(e,o)&&t.indexOf(o)<0&&(r[o]=e[o]);if(e!=null&&Ft)for(var o of Ft(e))t.indexOf(o)<0&&ro.call(e,o)&&(r[o]=e[o]);return r};var yr=(e,t)=>()=>(t||e((t={exports:{}}).exports,t),t.exports);var Ci=(e,t,r,o)=>{if(t&&typeof t=="object"||typeof t=="function")for(let n of _i(t))!xr.call(e,n)&&n!==r&&gr(e,n,{get:()=>t[n],enumerable:!(o=Li(t,n))||o.enumerable});return e};var jt=(e,t,r)=>(r=e!=null?Mi(Ai(e)):{},Ci(t||!e||!e.__esModule?gr(r,"default",{value:e,enumerable:!0}):r,e));var no=(e,t,r)=>new Promise((o,n)=>{var i=c=>{try{a(r.next(c))}catch(p){n(p)}},s=c=>{try{a(r.throw(c))}catch(p){n(p)}},a=c=>c.done?o(c.value):Promise.resolve(c.value).then(i,s);a((r=r.apply(e,t)).next())});var ao=yr((Er,io)=>{(function(e,t){typeof Er=="object"&&typeof io!="undefined"?t():typeof define=="function"&&define.amd?define(t):t()})(Er,function(){"use strict";function e(r){var o=!0,n=!1,i=null,s={text:!0,search:!0,url:!0,tel:!0,email:!0,password:!0,number:!0,date:!0,month:!0,week:!0,time:!0,datetime:!0,"datetime-local":!0};function a(C){return!!(C&&C!==document&&C.nodeName!=="HTML"&&C.nodeName!=="BODY"&&"classList"in C&&"contains"in C.classList)}function c(C){var ct=C.type,Ve=C.tagName;return!!(Ve==="INPUT"&&s[ct]&&!C.readOnly||Ve==="TEXTAREA"&&!C.readOnly||C.isContentEditable)}function p(C){C.classList.contains("focus-visible")||(C.classList.add("focus-visible"),C.setAttribute("data-focus-visible-added",""))}function l(C){C.hasAttribute("data-focus-visible-added")&&(C.classList.remove("focus-visible"),C.removeAttribute("data-focus-visible-added"))}function f(C){C.metaKey||C.altKey||C.ctrlKey||(a(r.activeElement)&&p(r.activeElement),o=!0)}function u(C){o=!1}function d(C){a(C.target)&&(o||c(C.target))&&p(C.target)}function y(C){a(C.target)&&(C.target.classList.contains("focus-visible")||C.target.hasAttribute("data-focus-visible-added"))&&(n=!0,window.clearTimeout(i),i=window.setTimeout(function(){n=!1},100),l(C.target))}function b(C){document.visibilityState==="hidden"&&(n&&(o=!0),D())}function D(){document.addEventListener("mousemove",J),document.addEventListener("mousedown",J),document.addEventListener("mouseup",J),document.addEventListener("pointermove",J),document.addEventListener("pointerdown",J),document.addEventListener("pointerup",J),document.addEventListener("touchmove",J),document.addEventListener("touchstart",J),document.addEventListener("touchend",J)}function Q(){document.removeEventListener("mousemove",J),document.removeEventListener("mousedown",J),document.removeEventListener("mouseup",J),document.removeEventListener("pointermove",J),document.removeEventListener("pointerdown",J),document.removeEventListener("pointerup",J),document.removeEventListener("touchmove",J),document.removeEventListener("touchstart",J),document.removeEventListener("touchend",J)}function J(C){C.target.nodeName&&C.target.nodeName.toLowerCase()==="html"||(o=!1,Q())}document.addEventListener("keydown",f,!0),document.addEventListener("mousedown",u,!0),document.addEventListener("pointerdown",u,!0),document.addEventListener("touchstart",u,!0),document.addEventListener("visibilitychange",b,!0),D(),r.addEventListener("focus",d,!0),r.addEventListener("blur",y,!0),r.nodeType===Node.DOCUMENT_FRAGMENT_NODE&&r.host?r.host.setAttribute("data-js-focus-visible",""):r.nodeType===Node.DOCUMENT_NODE&&(document.documentElement.classList.add("js-focus-visible"),document.documentElement.setAttribute("data-js-focus-visible",""))}if(typeof window!="undefined"&&typeof document!="undefined"){window.applyFocusVisiblePolyfill=e;var t;try{t=new CustomEvent("focus-visible-polyfill-ready")}catch(r){t=document.createEvent("CustomEvent"),t.initCustomEvent("focus-visible-polyfill-ready",!1,!1,{})}window.dispatchEvent(t)}typeof document!="undefined"&&e(document)})});var Kr=yr((kt,qr)=>{/*!
+ * clipboard.js v2.0.11
+ * https://clipboardjs.com/
+ *
+ * Licensed MIT © Zeno Rocha
+ */(function(t,r){typeof kt=="object"&&typeof qr=="object"?qr.exports=r():typeof define=="function"&&define.amd?define([],r):typeof kt=="object"?kt.ClipboardJS=r():t.ClipboardJS=r()})(kt,function(){return function(){var e={686:function(o,n,i){"use strict";i.d(n,{default:function(){return Oi}});var s=i(279),a=i.n(s),c=i(370),p=i.n(c),l=i(817),f=i.n(l);function u(V){try{return document.execCommand(V)}catch(_){return!1}}var d=function(_){var O=f()(_);return u("cut"),O},y=d;function b(V){var _=document.documentElement.getAttribute("dir")==="rtl",O=document.createElement("textarea");O.style.fontSize="12pt",O.style.border="0",O.style.padding="0",O.style.margin="0",O.style.position="absolute",O.style[_?"right":"left"]="-9999px";var $=window.pageYOffset||document.documentElement.scrollTop;return O.style.top="".concat($,"px"),O.setAttribute("readonly",""),O.value=V,O}var D=function(_,O){var $=b(_);O.container.appendChild($);var N=f()($);return u("copy"),$.remove(),N},Q=function(_){var O=arguments.length>1&&arguments[1]!==void 0?arguments[1]:{container:document.body},$="";return typeof _=="string"?$=D(_,O):_ instanceof HTMLInputElement&&!["text","search","url","tel","password"].includes(_==null?void 0:_.type)?$=D(_.value,O):($=f()(_),u("copy")),$},J=Q;function C(V){"@babel/helpers - typeof";return typeof Symbol=="function"&&typeof Symbol.iterator=="symbol"?C=function(O){return typeof O}:C=function(O){return O&&typeof Symbol=="function"&&O.constructor===Symbol&&O!==Symbol.prototype?"symbol":typeof O},C(V)}var ct=function(){var _=arguments.length>0&&arguments[0]!==void 0?arguments[0]:{},O=_.action,$=O===void 0?"copy":O,N=_.container,Y=_.target,ke=_.text;if($!=="copy"&&$!=="cut")throw new Error('Invalid "action" value, use either "copy" or "cut"');if(Y!==void 0)if(Y&&C(Y)==="object"&&Y.nodeType===1){if($==="copy"&&Y.hasAttribute("disabled"))throw new Error('Invalid "target" attribute. Please use "readonly" instead of "disabled" attribute');if($==="cut"&&(Y.hasAttribute("readonly")||Y.hasAttribute("disabled")))throw new Error(`Invalid "target" attribute. You can't cut text from elements with "readonly" or "disabled" attributes`)}else throw new Error('Invalid "target" value, use a valid Element');if(ke)return J(ke,{container:N});if(Y)return $==="cut"?y(Y):J(Y,{container:N})},Ve=ct;function Fe(V){"@babel/helpers - typeof";return typeof Symbol=="function"&&typeof Symbol.iterator=="symbol"?Fe=function(O){return typeof O}:Fe=function(O){return O&&typeof Symbol=="function"&&O.constructor===Symbol&&O!==Symbol.prototype?"symbol":typeof O},Fe(V)}function vi(V,_){if(!(V instanceof _))throw new TypeError("Cannot call a class as a function")}function eo(V,_){for(var O=0;O<_.length;O++){var $=_[O];$.enumerable=$.enumerable||!1,$.configurable=!0,"value"in $&&($.writable=!0),Object.defineProperty(V,$.key,$)}}function gi(V,_,O){return _&&eo(V.prototype,_),O&&eo(V,O),V}function xi(V,_){if(typeof _!="function"&&_!==null)throw new TypeError("Super expression must either be null or a function");V.prototype=Object.create(_&&_.prototype,{constructor:{value:V,writable:!0,configurable:!0}}),_&&br(V,_)}function br(V,_){return br=Object.setPrototypeOf||function($,N){return $.__proto__=N,$},br(V,_)}function yi(V){var _=Ti();return function(){var $=Rt(V),N;if(_){var Y=Rt(this).constructor;N=Reflect.construct($,arguments,Y)}else N=$.apply(this,arguments);return Ei(this,N)}}function Ei(V,_){return _&&(Fe(_)==="object"||typeof _=="function")?_:wi(V)}function wi(V){if(V===void 0)throw new ReferenceError("this hasn't been initialised - super() hasn't been called");return V}function Ti(){if(typeof Reflect=="undefined"||!Reflect.construct||Reflect.construct.sham)return!1;if(typeof Proxy=="function")return!0;try{return Date.prototype.toString.call(Reflect.construct(Date,[],function(){})),!0}catch(V){return!1}}function Rt(V){return Rt=Object.setPrototypeOf?Object.getPrototypeOf:function(O){return O.__proto__||Object.getPrototypeOf(O)},Rt(V)}function vr(V,_){var O="data-clipboard-".concat(V);if(_.hasAttribute(O))return _.getAttribute(O)}var Si=function(V){xi(O,V);var _=yi(O);function O($,N){var Y;return vi(this,O),Y=_.call(this),Y.resolveOptions(N),Y.listenClick($),Y}return gi(O,[{key:"resolveOptions",value:function(){var N=arguments.length>0&&arguments[0]!==void 0?arguments[0]:{};this.action=typeof N.action=="function"?N.action:this.defaultAction,this.target=typeof N.target=="function"?N.target:this.defaultTarget,this.text=typeof N.text=="function"?N.text:this.defaultText,this.container=Fe(N.container)==="object"?N.container:document.body}},{key:"listenClick",value:function(N){var Y=this;this.listener=p()(N,"click",function(ke){return Y.onClick(ke)})}},{key:"onClick",value:function(N){var Y=N.delegateTarget||N.currentTarget,ke=this.action(Y)||"copy",It=Ve({action:ke,container:this.container,target:this.target(Y),text:this.text(Y)});this.emit(It?"success":"error",{action:ke,text:It,trigger:Y,clearSelection:function(){Y&&Y.focus(),window.getSelection().removeAllRanges()}})}},{key:"defaultAction",value:function(N){return vr("action",N)}},{key:"defaultTarget",value:function(N){var Y=vr("target",N);if(Y)return document.querySelector(Y)}},{key:"defaultText",value:function(N){return vr("text",N)}},{key:"destroy",value:function(){this.listener.destroy()}}],[{key:"copy",value:function(N){var Y=arguments.length>1&&arguments[1]!==void 0?arguments[1]:{container:document.body};return J(N,Y)}},{key:"cut",value:function(N){return y(N)}},{key:"isSupported",value:function(){var N=arguments.length>0&&arguments[0]!==void 0?arguments[0]:["copy","cut"],Y=typeof N=="string"?[N]:N,ke=!!document.queryCommandSupported;return Y.forEach(function(It){ke=ke&&!!document.queryCommandSupported(It)}),ke}}]),O}(a()),Oi=Si},828:function(o){var n=9;if(typeof Element!="undefined"&&!Element.prototype.matches){var i=Element.prototype;i.matches=i.matchesSelector||i.mozMatchesSelector||i.msMatchesSelector||i.oMatchesSelector||i.webkitMatchesSelector}function s(a,c){for(;a&&a.nodeType!==n;){if(typeof a.matches=="function"&&a.matches(c))return a;a=a.parentNode}}o.exports=s},438:function(o,n,i){var s=i(828);function a(l,f,u,d,y){var b=p.apply(this,arguments);return l.addEventListener(u,b,y),{destroy:function(){l.removeEventListener(u,b,y)}}}function c(l,f,u,d,y){return typeof l.addEventListener=="function"?a.apply(null,arguments):typeof u=="function"?a.bind(null,document).apply(null,arguments):(typeof l=="string"&&(l=document.querySelectorAll(l)),Array.prototype.map.call(l,function(b){return a(b,f,u,d,y)}))}function p(l,f,u,d){return function(y){y.delegateTarget=s(y.target,f),y.delegateTarget&&d.call(l,y)}}o.exports=c},879:function(o,n){n.node=function(i){return i!==void 0&&i instanceof HTMLElement&&i.nodeType===1},n.nodeList=function(i){var s=Object.prototype.toString.call(i);return i!==void 0&&(s==="[object NodeList]"||s==="[object HTMLCollection]")&&"length"in i&&(i.length===0||n.node(i[0]))},n.string=function(i){return typeof i=="string"||i instanceof String},n.fn=function(i){var s=Object.prototype.toString.call(i);return s==="[object Function]"}},370:function(o,n,i){var s=i(879),a=i(438);function c(u,d,y){if(!u&&!d&&!y)throw new Error("Missing required arguments");if(!s.string(d))throw new TypeError("Second argument must be a String");if(!s.fn(y))throw new TypeError("Third argument must be a Function");if(s.node(u))return p(u,d,y);if(s.nodeList(u))return l(u,d,y);if(s.string(u))return f(u,d,y);throw new TypeError("First argument must be a String, HTMLElement, HTMLCollection, or NodeList")}function p(u,d,y){return u.addEventListener(d,y),{destroy:function(){u.removeEventListener(d,y)}}}function l(u,d,y){return Array.prototype.forEach.call(u,function(b){b.addEventListener(d,y)}),{destroy:function(){Array.prototype.forEach.call(u,function(b){b.removeEventListener(d,y)})}}}function f(u,d,y){return a(document.body,u,d,y)}o.exports=c},817:function(o){function n(i){var s;if(i.nodeName==="SELECT")i.focus(),s=i.value;else if(i.nodeName==="INPUT"||i.nodeName==="TEXTAREA"){var a=i.hasAttribute("readonly");a||i.setAttribute("readonly",""),i.select(),i.setSelectionRange(0,i.value.length),a||i.removeAttribute("readonly"),s=i.value}else{i.hasAttribute("contenteditable")&&i.focus();var c=window.getSelection(),p=document.createRange();p.selectNodeContents(i),c.removeAllRanges(),c.addRange(p),s=c.toString()}return s}o.exports=n},279:function(o){function n(){}n.prototype={on:function(i,s,a){var c=this.e||(this.e={});return(c[i]||(c[i]=[])).push({fn:s,ctx:a}),this},once:function(i,s,a){var c=this;function p(){c.off(i,p),s.apply(a,arguments)}return p._=s,this.on(i,p,a)},emit:function(i){var s=[].slice.call(arguments,1),a=((this.e||(this.e={}))[i]||[]).slice(),c=0,p=a.length;for(c;c{"use strict";/*!
+ * escape-html
+ * Copyright(c) 2012-2013 TJ Holowaychuk
+ * Copyright(c) 2015 Andreas Lubbe
+ * Copyright(c) 2015 Tiancheng "Timothy" Gu
+ * MIT Licensed
+ */var Wa=/["'&<>]/;Vn.exports=Ua;function Ua(e){var t=""+e,r=Wa.exec(t);if(!r)return t;var o,n="",i=0,s=0;for(i=r.index;i0&&i[i.length-1])&&(p[0]===6||p[0]===2)){r=0;continue}if(p[0]===3&&(!i||p[1]>i[0]&&p[1]=e.length&&(e=void 0),{value:e&&e[o++],done:!e}}};throw new TypeError(t?"Object is not iterable.":"Symbol.iterator is not defined.")}function z(e,t){var r=typeof Symbol=="function"&&e[Symbol.iterator];if(!r)return e;var o=r.call(e),n,i=[],s;try{for(;(t===void 0||t-- >0)&&!(n=o.next()).done;)i.push(n.value)}catch(a){s={error:a}}finally{try{n&&!n.done&&(r=o.return)&&r.call(o)}finally{if(s)throw s.error}}return i}function K(e,t,r){if(r||arguments.length===2)for(var o=0,n=t.length,i;o1||a(u,d)})})}function a(u,d){try{c(o[u](d))}catch(y){f(i[0][3],y)}}function c(u){u.value instanceof ot?Promise.resolve(u.value.v).then(p,l):f(i[0][2],u)}function p(u){a("next",u)}function l(u){a("throw",u)}function f(u,d){u(d),i.shift(),i.length&&a(i[0][0],i[0][1])}}function po(e){if(!Symbol.asyncIterator)throw new TypeError("Symbol.asyncIterator is not defined.");var t=e[Symbol.asyncIterator],r;return t?t.call(e):(e=typeof be=="function"?be(e):e[Symbol.iterator](),r={},o("next"),o("throw"),o("return"),r[Symbol.asyncIterator]=function(){return this},r);function o(i){r[i]=e[i]&&function(s){return new Promise(function(a,c){s=e[i](s),n(a,c,s.done,s.value)})}}function n(i,s,a,c){Promise.resolve(c).then(function(p){i({value:p,done:a})},s)}}function k(e){return typeof e=="function"}function pt(e){var t=function(o){Error.call(o),o.stack=new Error().stack},r=e(t);return r.prototype=Object.create(Error.prototype),r.prototype.constructor=r,r}var Ut=pt(function(e){return function(r){e(this),this.message=r?r.length+` errors occurred during unsubscription:
+`+r.map(function(o,n){return n+1+") "+o.toString()}).join(`
+ `):"",this.name="UnsubscriptionError",this.errors=r}});function ze(e,t){if(e){var r=e.indexOf(t);0<=r&&e.splice(r,1)}}var je=function(){function e(t){this.initialTeardown=t,this.closed=!1,this._parentage=null,this._finalizers=null}return e.prototype.unsubscribe=function(){var t,r,o,n,i;if(!this.closed){this.closed=!0;var s=this._parentage;if(s)if(this._parentage=null,Array.isArray(s))try{for(var a=be(s),c=a.next();!c.done;c=a.next()){var p=c.value;p.remove(this)}}catch(b){t={error:b}}finally{try{c&&!c.done&&(r=a.return)&&r.call(a)}finally{if(t)throw t.error}}else s.remove(this);var l=this.initialTeardown;if(k(l))try{l()}catch(b){i=b instanceof Ut?b.errors:[b]}var f=this._finalizers;if(f){this._finalizers=null;try{for(var u=be(f),d=u.next();!d.done;d=u.next()){var y=d.value;try{lo(y)}catch(b){i=i!=null?i:[],b instanceof Ut?i=K(K([],z(i)),z(b.errors)):i.push(b)}}}catch(b){o={error:b}}finally{try{d&&!d.done&&(n=u.return)&&n.call(u)}finally{if(o)throw o.error}}}if(i)throw new Ut(i)}},e.prototype.add=function(t){var r;if(t&&t!==this)if(this.closed)lo(t);else{if(t instanceof e){if(t.closed||t._hasParent(this))return;t._addParent(this)}(this._finalizers=(r=this._finalizers)!==null&&r!==void 0?r:[]).push(t)}},e.prototype._hasParent=function(t){var r=this._parentage;return r===t||Array.isArray(r)&&r.includes(t)},e.prototype._addParent=function(t){var r=this._parentage;this._parentage=Array.isArray(r)?(r.push(t),r):r?[r,t]:t},e.prototype._removeParent=function(t){var r=this._parentage;r===t?this._parentage=null:Array.isArray(r)&&ze(r,t)},e.prototype.remove=function(t){var r=this._finalizers;r&&ze(r,t),t instanceof e&&t._removeParent(this)},e.EMPTY=function(){var t=new e;return t.closed=!0,t}(),e}();var Tr=je.EMPTY;function Nt(e){return e instanceof je||e&&"closed"in e&&k(e.remove)&&k(e.add)&&k(e.unsubscribe)}function lo(e){k(e)?e():e.unsubscribe()}var He={onUnhandledError:null,onStoppedNotification:null,Promise:void 0,useDeprecatedSynchronousErrorHandling:!1,useDeprecatedNextContext:!1};var lt={setTimeout:function(e,t){for(var r=[],o=2;o0},enumerable:!1,configurable:!0}),t.prototype._trySubscribe=function(r){return this._throwIfClosed(),e.prototype._trySubscribe.call(this,r)},t.prototype._subscribe=function(r){return this._throwIfClosed(),this._checkFinalizedStatuses(r),this._innerSubscribe(r)},t.prototype._innerSubscribe=function(r){var o=this,n=this,i=n.hasError,s=n.isStopped,a=n.observers;return i||s?Tr:(this.currentObservers=null,a.push(r),new je(function(){o.currentObservers=null,ze(a,r)}))},t.prototype._checkFinalizedStatuses=function(r){var o=this,n=o.hasError,i=o.thrownError,s=o.isStopped;n?r.error(i):s&&r.complete()},t.prototype.asObservable=function(){var r=new I;return r.source=this,r},t.create=function(r,o){return new xo(r,o)},t}(I);var xo=function(e){se(t,e);function t(r,o){var n=e.call(this)||this;return n.destination=r,n.source=o,n}return t.prototype.next=function(r){var o,n;(n=(o=this.destination)===null||o===void 0?void 0:o.next)===null||n===void 0||n.call(o,r)},t.prototype.error=function(r){var o,n;(n=(o=this.destination)===null||o===void 0?void 0:o.error)===null||n===void 0||n.call(o,r)},t.prototype.complete=function(){var r,o;(o=(r=this.destination)===null||r===void 0?void 0:r.complete)===null||o===void 0||o.call(r)},t.prototype._subscribe=function(r){var o,n;return(n=(o=this.source)===null||o===void 0?void 0:o.subscribe(r))!==null&&n!==void 0?n:Tr},t}(x);var St={now:function(){return(St.delegate||Date).now()},delegate:void 0};var Ot=function(e){se(t,e);function t(r,o,n){r===void 0&&(r=1/0),o===void 0&&(o=1/0),n===void 0&&(n=St);var i=e.call(this)||this;return i._bufferSize=r,i._windowTime=o,i._timestampProvider=n,i._buffer=[],i._infiniteTimeWindow=!0,i._infiniteTimeWindow=o===1/0,i._bufferSize=Math.max(1,r),i._windowTime=Math.max(1,o),i}return t.prototype.next=function(r){var o=this,n=o.isStopped,i=o._buffer,s=o._infiniteTimeWindow,a=o._timestampProvider,c=o._windowTime;n||(i.push(r),!s&&i.push(a.now()+c)),this._trimBuffer(),e.prototype.next.call(this,r)},t.prototype._subscribe=function(r){this._throwIfClosed(),this._trimBuffer();for(var o=this._innerSubscribe(r),n=this,i=n._infiniteTimeWindow,s=n._buffer,a=s.slice(),c=0;c0?e.prototype.requestAsyncId.call(this,r,o,n):(r.actions.push(this),r._scheduled||(r._scheduled=ut.requestAnimationFrame(function(){return r.flush(void 0)})))},t.prototype.recycleAsyncId=function(r,o,n){var i;if(n===void 0&&(n=0),n!=null?n>0:this.delay>0)return e.prototype.recycleAsyncId.call(this,r,o,n);var s=r.actions;o!=null&&((i=s[s.length-1])===null||i===void 0?void 0:i.id)!==o&&(ut.cancelAnimationFrame(o),r._scheduled=void 0)},t}(zt);var wo=function(e){se(t,e);function t(){return e!==null&&e.apply(this,arguments)||this}return t.prototype.flush=function(r){this._active=!0;var o=this._scheduled;this._scheduled=void 0;var n=this.actions,i;r=r||n.shift();do if(i=r.execute(r.state,r.delay))break;while((r=n[0])&&r.id===o&&n.shift());if(this._active=!1,i){for(;(r=n[0])&&r.id===o&&n.shift();)r.unsubscribe();throw i}},t}(qt);var ge=new wo(Eo);var M=new I(function(e){return e.complete()});function Kt(e){return e&&k(e.schedule)}function Cr(e){return e[e.length-1]}function Ge(e){return k(Cr(e))?e.pop():void 0}function Ae(e){return Kt(Cr(e))?e.pop():void 0}function Qt(e,t){return typeof Cr(e)=="number"?e.pop():t}var dt=function(e){return e&&typeof e.length=="number"&&typeof e!="function"};function Yt(e){return k(e==null?void 0:e.then)}function Bt(e){return k(e[ft])}function Gt(e){return Symbol.asyncIterator&&k(e==null?void 0:e[Symbol.asyncIterator])}function Jt(e){return new TypeError("You provided "+(e!==null&&typeof e=="object"?"an invalid object":"'"+e+"'")+" where a stream was expected. You can provide an Observable, Promise, ReadableStream, Array, AsyncIterable, or Iterable.")}function Wi(){return typeof Symbol!="function"||!Symbol.iterator?"@@iterator":Symbol.iterator}var Xt=Wi();function Zt(e){return k(e==null?void 0:e[Xt])}function er(e){return co(this,arguments,function(){var r,o,n,i;return Wt(this,function(s){switch(s.label){case 0:r=e.getReader(),s.label=1;case 1:s.trys.push([1,,9,10]),s.label=2;case 2:return[4,ot(r.read())];case 3:return o=s.sent(),n=o.value,i=o.done,i?[4,ot(void 0)]:[3,5];case 4:return[2,s.sent()];case 5:return[4,ot(n)];case 6:return[4,s.sent()];case 7:return s.sent(),[3,2];case 8:return[3,10];case 9:return r.releaseLock(),[7];case 10:return[2]}})})}function tr(e){return k(e==null?void 0:e.getReader)}function F(e){if(e instanceof I)return e;if(e!=null){if(Bt(e))return Ui(e);if(dt(e))return Ni(e);if(Yt(e))return Di(e);if(Gt(e))return To(e);if(Zt(e))return Vi(e);if(tr(e))return zi(e)}throw Jt(e)}function Ui(e){return new I(function(t){var r=e[ft]();if(k(r.subscribe))return r.subscribe(t);throw new TypeError("Provided object does not correctly implement Symbol.observable")})}function Ni(e){return new I(function(t){for(var r=0;r=2;return function(o){return o.pipe(e?v(function(n,i){return e(n,i,o)}):pe,ue(1),r?$e(t):Uo(function(){return new or}))}}function Rr(e){return e<=0?function(){return M}:g(function(t,r){var o=[];t.subscribe(E(r,function(n){o.push(n),e=2,!0))}function de(e){e===void 0&&(e={});var t=e.connector,r=t===void 0?function(){return new x}:t,o=e.resetOnError,n=o===void 0?!0:o,i=e.resetOnComplete,s=i===void 0?!0:i,a=e.resetOnRefCountZero,c=a===void 0?!0:a;return function(p){var l,f,u,d=0,y=!1,b=!1,D=function(){f==null||f.unsubscribe(),f=void 0},Q=function(){D(),l=u=void 0,y=b=!1},J=function(){var C=l;Q(),C==null||C.unsubscribe()};return g(function(C,ct){d++,!b&&!y&&D();var Ve=u=u!=null?u:r();ct.add(function(){d--,d===0&&!b&&!y&&(f=jr(J,c))}),Ve.subscribe(ct),!l&&d>0&&(l=new it({next:function(Fe){return Ve.next(Fe)},error:function(Fe){b=!0,D(),f=jr(Q,n,Fe),Ve.error(Fe)},complete:function(){y=!0,D(),f=jr(Q,s),Ve.complete()}}),F(C).subscribe(l))})(p)}}function jr(e,t){for(var r=[],o=2;oe.next(document)),e}function W(e,t=document){return Array.from(t.querySelectorAll(e))}function U(e,t=document){let r=ce(e,t);if(typeof r=="undefined")throw new ReferenceError(`Missing element: expected "${e}" to be present`);return r}function ce(e,t=document){return t.querySelector(e)||void 0}function Ie(){return document.activeElement instanceof HTMLElement&&document.activeElement||void 0}var ca=L(h(document.body,"focusin"),h(document.body,"focusout")).pipe(ye(1),q(void 0),m(()=>Ie()||document.body),Z(1));function vt(e){return ca.pipe(m(t=>e.contains(t)),X())}function qo(e,t){return L(h(e,"mouseenter").pipe(m(()=>!0)),h(e,"mouseleave").pipe(m(()=>!1))).pipe(t?ye(t):pe,q(!1))}function Ue(e){return{x:e.offsetLeft,y:e.offsetTop}}function Ko(e){return L(h(window,"load"),h(window,"resize")).pipe(Le(0,ge),m(()=>Ue(e)),q(Ue(e)))}function ir(e){return{x:e.scrollLeft,y:e.scrollTop}}function et(e){return L(h(e,"scroll"),h(window,"resize")).pipe(Le(0,ge),m(()=>ir(e)),q(ir(e)))}function Qo(e,t){if(typeof t=="string"||typeof t=="number")e.innerHTML+=t.toString();else if(t instanceof Node)e.appendChild(t);else if(Array.isArray(t))for(let r of t)Qo(e,r)}function S(e,t,...r){let o=document.createElement(e);if(t)for(let n of Object.keys(t))typeof t[n]!="undefined"&&(typeof t[n]!="boolean"?o.setAttribute(n,t[n]):o.setAttribute(n,""));for(let n of r)Qo(o,n);return o}function ar(e){if(e>999){let t=+((e-950)%1e3>99);return`${((e+1e-6)/1e3).toFixed(t)}k`}else return e.toString()}function gt(e){let t=S("script",{src:e});return H(()=>(document.head.appendChild(t),L(h(t,"load"),h(t,"error").pipe(w(()=>kr(()=>new ReferenceError(`Invalid script: ${e}`))))).pipe(m(()=>{}),A(()=>document.head.removeChild(t)),ue(1))))}var Yo=new x,pa=H(()=>typeof ResizeObserver=="undefined"?gt("https://unpkg.com/resize-observer-polyfill"):R(void 0)).pipe(m(()=>new ResizeObserver(e=>{for(let t of e)Yo.next(t)})),w(e=>L(Ke,R(e)).pipe(A(()=>e.disconnect()))),Z(1));function le(e){return{width:e.offsetWidth,height:e.offsetHeight}}function Se(e){return pa.pipe(T(t=>t.observe(e)),w(t=>Yo.pipe(v(({target:r})=>r===e),A(()=>t.unobserve(e)),m(()=>le(e)))),q(le(e)))}function xt(e){return{width:e.scrollWidth,height:e.scrollHeight}}function sr(e){let t=e.parentElement;for(;t&&(e.scrollWidth<=t.scrollWidth&&e.scrollHeight<=t.scrollHeight);)t=(e=t).parentElement;return t?e:void 0}var Bo=new x,la=H(()=>R(new IntersectionObserver(e=>{for(let t of e)Bo.next(t)},{threshold:0}))).pipe(w(e=>L(Ke,R(e)).pipe(A(()=>e.disconnect()))),Z(1));function yt(e){return la.pipe(T(t=>t.observe(e)),w(t=>Bo.pipe(v(({target:r})=>r===e),A(()=>t.unobserve(e)),m(({isIntersecting:r})=>r))))}function Go(e,t=16){return et(e).pipe(m(({y:r})=>{let o=le(e),n=xt(e);return r>=n.height-o.height-t}),X())}var cr={drawer:U("[data-md-toggle=drawer]"),search:U("[data-md-toggle=search]")};function Jo(e){return cr[e].checked}function Ye(e,t){cr[e].checked!==t&&cr[e].click()}function Ne(e){let t=cr[e];return h(t,"change").pipe(m(()=>t.checked),q(t.checked))}function ma(e,t){switch(e.constructor){case HTMLInputElement:return e.type==="radio"?/^Arrow/.test(t):!0;case HTMLSelectElement:case HTMLTextAreaElement:return!0;default:return e.isContentEditable}}function fa(){return L(h(window,"compositionstart").pipe(m(()=>!0)),h(window,"compositionend").pipe(m(()=>!1))).pipe(q(!1))}function Xo(){let e=h(window,"keydown").pipe(v(t=>!(t.metaKey||t.ctrlKey)),m(t=>({mode:Jo("search")?"search":"global",type:t.key,claim(){t.preventDefault(),t.stopPropagation()}})),v(({mode:t,type:r})=>{if(t==="global"){let o=Ie();if(typeof o!="undefined")return!ma(o,r)}return!0}),de());return fa().pipe(w(t=>t?M:e))}function me(){return new URL(location.href)}function st(e,t=!1){if(G("navigation.instant")&&!t){let r=S("a",{href:e.href});document.body.appendChild(r),r.click(),r.remove()}else location.href=e.href}function Zo(){return new x}function en(){return location.hash.slice(1)}function pr(e){let t=S("a",{href:e});t.addEventListener("click",r=>r.stopPropagation()),t.click()}function ua(e){return L(h(window,"hashchange"),e).pipe(m(en),q(en()),v(t=>t.length>0),Z(1))}function tn(e){return ua(e).pipe(m(t=>ce(`[id="${t}"]`)),v(t=>typeof t!="undefined"))}function At(e){let t=matchMedia(e);return nr(r=>t.addListener(()=>r(t.matches))).pipe(q(t.matches))}function rn(){let e=matchMedia("print");return L(h(window,"beforeprint").pipe(m(()=>!0)),h(window,"afterprint").pipe(m(()=>!1))).pipe(q(e.matches))}function Dr(e,t){return e.pipe(w(r=>r?t():M))}function lr(e,t){return new I(r=>{let o=new XMLHttpRequest;o.open("GET",`${e}`),o.responseType="blob",o.addEventListener("load",()=>{o.status>=200&&o.status<300?(r.next(o.response),r.complete()):r.error(new Error(o.statusText))}),o.addEventListener("error",()=>{r.error(new Error("Network Error"))}),o.addEventListener("abort",()=>{r.error(new Error("Request aborted"))}),typeof(t==null?void 0:t.progress$)!="undefined"&&(o.addEventListener("progress",n=>{if(n.lengthComputable)t.progress$.next(n.loaded/n.total*100);else{let i=Number(o.getResponseHeader("Content-Length"))||0;t.progress$.next(n.loaded/i*100)}}),t.progress$.next(5)),o.send()})}function De(e,t){return lr(e,t).pipe(w(r=>r.text()),m(r=>JSON.parse(r)),Z(1))}function on(e,t){let r=new DOMParser;return lr(e,t).pipe(w(o=>o.text()),m(o=>r.parseFromString(o,"text/xml")),Z(1))}function nn(){return{x:Math.max(0,scrollX),y:Math.max(0,scrollY)}}function an(){return L(h(window,"scroll",{passive:!0}),h(window,"resize",{passive:!0})).pipe(m(nn),q(nn()))}function sn(){return{width:innerWidth,height:innerHeight}}function cn(){return h(window,"resize",{passive:!0}).pipe(m(sn),q(sn()))}function pn(){return B([an(),cn()]).pipe(m(([e,t])=>({offset:e,size:t})),Z(1))}function mr(e,{viewport$:t,header$:r}){let o=t.pipe(te("size")),n=B([o,r]).pipe(m(()=>Ue(e)));return B([r,t,n]).pipe(m(([{height:i},{offset:s,size:a},{x:c,y:p}])=>({offset:{x:s.x-c,y:s.y-p+i},size:a})))}function da(e){return h(e,"message",t=>t.data)}function ha(e){let t=new x;return t.subscribe(r=>e.postMessage(r)),t}function ln(e,t=new Worker(e)){let r=da(t),o=ha(t),n=new x;n.subscribe(o);let i=o.pipe(ee(),oe(!0));return n.pipe(ee(),Re(r.pipe(j(i))),de())}var ba=U("#__config"),Et=JSON.parse(ba.textContent);Et.base=`${new URL(Et.base,me())}`;function he(){return Et}function G(e){return Et.features.includes(e)}function we(e,t){return typeof t!="undefined"?Et.translations[e].replace("#",t.toString()):Et.translations[e]}function Oe(e,t=document){return U(`[data-md-component=${e}]`,t)}function ne(e,t=document){return W(`[data-md-component=${e}]`,t)}function va(e){let t=U(".md-typeset > :first-child",e);return h(t,"click",{once:!0}).pipe(m(()=>U(".md-typeset",e)),m(r=>({hash:__md_hash(r.innerHTML)})))}function mn(e){if(!G("announce.dismiss")||!e.childElementCount)return M;if(!e.hidden){let t=U(".md-typeset",e);__md_hash(t.innerHTML)===__md_get("__announce")&&(e.hidden=!0)}return H(()=>{let t=new x;return t.subscribe(({hash:r})=>{e.hidden=!0,__md_set("__announce",r)}),va(e).pipe(T(r=>t.next(r)),A(()=>t.complete()),m(r=>P({ref:e},r)))})}function ga(e,{target$:t}){return t.pipe(m(r=>({hidden:r!==e})))}function fn(e,t){let r=new x;return r.subscribe(({hidden:o})=>{e.hidden=o}),ga(e,t).pipe(T(o=>r.next(o)),A(()=>r.complete()),m(o=>P({ref:e},o)))}function Ct(e,t){return t==="inline"?S("div",{class:"md-tooltip md-tooltip--inline",id:e,role:"tooltip"},S("div",{class:"md-tooltip__inner md-typeset"})):S("div",{class:"md-tooltip",id:e,role:"tooltip"},S("div",{class:"md-tooltip__inner md-typeset"}))}function un(e,t){if(t=t?`${t}_annotation_${e}`:void 0,t){let r=t?`#${t}`:void 0;return S("aside",{class:"md-annotation",tabIndex:0},Ct(t),S("a",{href:r,class:"md-annotation__index",tabIndex:-1},S("span",{"data-md-annotation-id":e})))}else return S("aside",{class:"md-annotation",tabIndex:0},Ct(t),S("span",{class:"md-annotation__index",tabIndex:-1},S("span",{"data-md-annotation-id":e})))}function dn(e){return S("button",{class:"md-clipboard md-icon",title:we("clipboard.copy"),"data-clipboard-target":`#${e} > code`})}function Vr(e,t){let r=t&2,o=t&1,n=Object.keys(e.terms).filter(c=>!e.terms[c]).reduce((c,p)=>[...c,S("del",null,p)," "],[]).slice(0,-1),i=he(),s=new URL(e.location,i.base);G("search.highlight")&&s.searchParams.set("h",Object.entries(e.terms).filter(([,c])=>c).reduce((c,[p])=>`${c} ${p}`.trim(),""));let{tags:a}=he();return S("a",{href:`${s}`,class:"md-search-result__link",tabIndex:-1},S("article",{class:"md-search-result__article md-typeset","data-md-score":e.score.toFixed(2)},r>0&&S("div",{class:"md-search-result__icon md-icon"}),r>0&&S("h1",null,e.title),r<=0&&S("h2",null,e.title),o>0&&e.text.length>0&&e.text,e.tags&&e.tags.map(c=>{let p=a?c in a?`md-tag-icon md-tag--${a[c]}`:"md-tag-icon":"";return S("span",{class:`md-tag ${p}`},c)}),o>0&&n.length>0&&S("p",{class:"md-search-result__terms"},we("search.result.term.missing"),": ",...n)))}function hn(e){let t=e[0].score,r=[...e],o=he(),n=r.findIndex(l=>!`${new URL(l.location,o.base)}`.includes("#")),[i]=r.splice(n,1),s=r.findIndex(l=>l.scoreVr(l,1)),...c.length?[S("details",{class:"md-search-result__more"},S("summary",{tabIndex:-1},S("div",null,c.length>0&&c.length===1?we("search.result.more.one"):we("search.result.more.other",c.length))),...c.map(l=>Vr(l,1)))]:[]];return S("li",{class:"md-search-result__item"},p)}function bn(e){return S("ul",{class:"md-source__facts"},Object.entries(e).map(([t,r])=>S("li",{class:`md-source__fact md-source__fact--${t}`},typeof r=="number"?ar(r):r)))}function zr(e){let t=`tabbed-control tabbed-control--${e}`;return S("div",{class:t,hidden:!0},S("button",{class:"tabbed-button",tabIndex:-1,"aria-hidden":"true"}))}function vn(e){return S("div",{class:"md-typeset__scrollwrap"},S("div",{class:"md-typeset__table"},e))}function xa(e){let t=he(),r=new URL(`../${e.version}/`,t.base);return S("li",{class:"md-version__item"},S("a",{href:`${r}`,class:"md-version__link"},e.title))}function gn(e,t){return S("div",{class:"md-version"},S("button",{class:"md-version__current","aria-label":we("select.version")},t.title),S("ul",{class:"md-version__list"},e.map(xa)))}var ya=0;function Ea(e,t){document.body.append(e);let{width:r}=le(e);e.style.setProperty("--md-tooltip-width",`${r}px`),e.remove();let o=sr(t),n=typeof o!="undefined"?et(o):R({x:0,y:0}),i=L(vt(t),qo(t)).pipe(X());return B([i,n]).pipe(m(([s,a])=>{let{x:c,y:p}=Ue(t),l=le(t),f=t.closest("table");return f&&t.parentElement&&(c+=f.offsetLeft+t.parentElement.offsetLeft,p+=f.offsetTop+t.parentElement.offsetTop),{active:s,offset:{x:c-a.x+l.width/2-r/2,y:p-a.y+l.height+8}}}))}function Be(e){let t=e.title;if(!t.length)return M;let r=`__tooltip_${ya++}`,o=Ct(r,"inline"),n=U(".md-typeset",o);return n.innerHTML=t,H(()=>{let i=new x;return i.subscribe({next({offset:s}){o.style.setProperty("--md-tooltip-x",`${s.x}px`),o.style.setProperty("--md-tooltip-y",`${s.y}px`)},complete(){o.style.removeProperty("--md-tooltip-x"),o.style.removeProperty("--md-tooltip-y")}}),L(i.pipe(v(({active:s})=>s)),i.pipe(ye(250),v(({active:s})=>!s))).subscribe({next({active:s}){s?(e.insertAdjacentElement("afterend",o),e.setAttribute("aria-describedby",r),e.removeAttribute("title")):(o.remove(),e.removeAttribute("aria-describedby"),e.setAttribute("title",t))},complete(){o.remove(),e.removeAttribute("aria-describedby"),e.setAttribute("title",t)}}),i.pipe(Le(16,ge)).subscribe(({active:s})=>{o.classList.toggle("md-tooltip--active",s)}),i.pipe(_t(125,ge),v(()=>!!e.offsetParent),m(()=>e.offsetParent.getBoundingClientRect()),m(({x:s})=>s)).subscribe({next(s){s?o.style.setProperty("--md-tooltip-0",`${-s}px`):o.style.removeProperty("--md-tooltip-0")},complete(){o.style.removeProperty("--md-tooltip-0")}}),Ea(o,e).pipe(T(s=>i.next(s)),A(()=>i.complete()),m(s=>P({ref:e},s)))}).pipe(qe(ie))}function wa(e,t){let r=H(()=>B([Ko(e),et(t)])).pipe(m(([{x:o,y:n},i])=>{let{width:s,height:a}=le(e);return{x:o-i.x+s/2,y:n-i.y+a/2}}));return vt(e).pipe(w(o=>r.pipe(m(n=>({active:o,offset:n})),ue(+!o||1/0))))}function xn(e,t,{target$:r}){let[o,n]=Array.from(e.children);return H(()=>{let i=new x,s=i.pipe(ee(),oe(!0));return i.subscribe({next({offset:a}){e.style.setProperty("--md-tooltip-x",`${a.x}px`),e.style.setProperty("--md-tooltip-y",`${a.y}px`)},complete(){e.style.removeProperty("--md-tooltip-x"),e.style.removeProperty("--md-tooltip-y")}}),yt(e).pipe(j(s)).subscribe(a=>{e.toggleAttribute("data-md-visible",a)}),L(i.pipe(v(({active:a})=>a)),i.pipe(ye(250),v(({active:a})=>!a))).subscribe({next({active:a}){a?e.prepend(o):o.remove()},complete(){e.prepend(o)}}),i.pipe(Le(16,ge)).subscribe(({active:a})=>{o.classList.toggle("md-tooltip--active",a)}),i.pipe(_t(125,ge),v(()=>!!e.offsetParent),m(()=>e.offsetParent.getBoundingClientRect()),m(({x:a})=>a)).subscribe({next(a){a?e.style.setProperty("--md-tooltip-0",`${-a}px`):e.style.removeProperty("--md-tooltip-0")},complete(){e.style.removeProperty("--md-tooltip-0")}}),h(n,"click").pipe(j(s),v(a=>!(a.metaKey||a.ctrlKey))).subscribe(a=>{a.stopPropagation(),a.preventDefault()}),h(n,"mousedown").pipe(j(s),ae(i)).subscribe(([a,{active:c}])=>{var p;if(a.button!==0||a.metaKey||a.ctrlKey)a.preventDefault();else if(c){a.preventDefault();let l=e.parentElement.closest(".md-annotation");l instanceof HTMLElement?l.focus():(p=Ie())==null||p.blur()}}),r.pipe(j(s),v(a=>a===o),Qe(125)).subscribe(()=>e.focus()),wa(e,t).pipe(T(a=>i.next(a)),A(()=>i.complete()),m(a=>P({ref:e},a)))})}function Ta(e){return e.tagName==="CODE"?W(".c, .c1, .cm",e):[e]}function Sa(e){let t=[];for(let r of Ta(e)){let o=[],n=document.createNodeIterator(r,NodeFilter.SHOW_TEXT);for(let i=n.nextNode();i;i=n.nextNode())o.push(i);for(let i of o){let s;for(;s=/(\(\d+\))(!)?/.exec(i.textContent);){let[,a,c]=s;if(typeof c=="undefined"){let p=i.splitText(s.index);i=p.splitText(a.length),t.push(p)}else{i.textContent=a,t.push(i);break}}}}return t}function yn(e,t){t.append(...Array.from(e.childNodes))}function fr(e,t,{target$:r,print$:o}){let n=t.closest("[id]"),i=n==null?void 0:n.id,s=new Map;for(let a of Sa(t)){let[,c]=a.textContent.match(/\((\d+)\)/);ce(`:scope > li:nth-child(${c})`,e)&&(s.set(c,un(c,i)),a.replaceWith(s.get(c)))}return s.size===0?M:H(()=>{let a=new x,c=a.pipe(ee(),oe(!0)),p=[];for(let[l,f]of s)p.push([U(".md-typeset",f),U(`:scope > li:nth-child(${l})`,e)]);return o.pipe(j(c)).subscribe(l=>{e.hidden=!l,e.classList.toggle("md-annotation-list",l);for(let[f,u]of p)l?yn(f,u):yn(u,f)}),L(...[...s].map(([,l])=>xn(l,t,{target$:r}))).pipe(A(()=>a.complete()),de())})}function En(e){if(e.nextElementSibling){let t=e.nextElementSibling;if(t.tagName==="OL")return t;if(t.tagName==="P"&&!t.children.length)return En(t)}}function wn(e,t){return H(()=>{let r=En(e);return typeof r!="undefined"?fr(r,e,t):M})}var Tn=jt(Kr());var Oa=0;function Sn(e){if(e.nextElementSibling){let t=e.nextElementSibling;if(t.tagName==="OL")return t;if(t.tagName==="P"&&!t.children.length)return Sn(t)}}function Ma(e){return Se(e).pipe(m(({width:t})=>({scrollable:xt(e).width>t})),te("scrollable"))}function On(e,t){let{matches:r}=matchMedia("(hover)"),o=H(()=>{let n=new x,i=n.pipe(Rr(1));n.subscribe(({scrollable:c})=>{c&&r?e.setAttribute("tabindex","0"):e.removeAttribute("tabindex")});let s=[];if(Tn.default.isSupported()&&(e.closest(".copy")||G("content.code.copy")&&!e.closest(".no-copy"))){let c=e.closest("pre");c.id=`__code_${Oa++}`;let p=dn(c.id);c.insertBefore(p,e),G("content.tooltips")&&s.push(Be(p))}let a=e.closest(".highlight");if(a instanceof HTMLElement){let c=Sn(a);if(typeof c!="undefined"&&(a.classList.contains("annotate")||G("content.code.annotate"))){let p=fr(c,e,t);s.push(Se(a).pipe(j(i),m(({width:l,height:f})=>l&&f),X(),w(l=>l?p:M)))}}return Ma(e).pipe(T(c=>n.next(c)),A(()=>n.complete()),m(c=>P({ref:e},c)),Re(...s))});return G("content.lazy")?yt(e).pipe(v(n=>n),ue(1),w(()=>o)):o}function La(e,{target$:t,print$:r}){let o=!0;return L(t.pipe(m(n=>n.closest("details:not([open])")),v(n=>e===n),m(()=>({action:"open",reveal:!0}))),r.pipe(v(n=>n||!o),T(()=>o=e.open),m(n=>({action:n?"open":"close"}))))}function Mn(e,t){return H(()=>{let r=new x;return r.subscribe(({action:o,reveal:n})=>{e.toggleAttribute("open",o==="open"),n&&e.scrollIntoView()}),La(e,t).pipe(T(o=>r.next(o)),A(()=>r.complete()),m(o=>P({ref:e},o)))})}var Ln=".node circle,.node ellipse,.node path,.node polygon,.node rect{fill:var(--md-mermaid-node-bg-color);stroke:var(--md-mermaid-node-fg-color)}marker{fill:var(--md-mermaid-edge-color)!important}.edgeLabel .label rect{fill:#0000}.label{color:var(--md-mermaid-label-fg-color);font-family:var(--md-mermaid-font-family)}.label foreignObject{line-height:normal;overflow:visible}.label div .edgeLabel{color:var(--md-mermaid-label-fg-color)}.edgeLabel,.edgeLabel rect,.label div .edgeLabel{background-color:var(--md-mermaid-label-bg-color)}.edgeLabel,.edgeLabel rect{fill:var(--md-mermaid-label-bg-color);color:var(--md-mermaid-edge-color)}.edgePath .path,.flowchart-link{stroke:var(--md-mermaid-edge-color);stroke-width:.05rem}.edgePath .arrowheadPath{fill:var(--md-mermaid-edge-color);stroke:none}.cluster rect{fill:var(--md-default-fg-color--lightest);stroke:var(--md-default-fg-color--lighter)}.cluster span{color:var(--md-mermaid-label-fg-color);font-family:var(--md-mermaid-font-family)}g #flowchart-circleEnd,g #flowchart-circleStart,g #flowchart-crossEnd,g #flowchart-crossStart,g #flowchart-pointEnd,g #flowchart-pointStart{stroke:none}g.classGroup line,g.classGroup rect{fill:var(--md-mermaid-node-bg-color);stroke:var(--md-mermaid-node-fg-color)}g.classGroup text{fill:var(--md-mermaid-label-fg-color);font-family:var(--md-mermaid-font-family)}.classLabel .box{fill:var(--md-mermaid-label-bg-color);background-color:var(--md-mermaid-label-bg-color);opacity:1}.classLabel .label{fill:var(--md-mermaid-label-fg-color);font-family:var(--md-mermaid-font-family)}.node .divider{stroke:var(--md-mermaid-node-fg-color)}.relation{stroke:var(--md-mermaid-edge-color)}.cardinality{fill:var(--md-mermaid-label-fg-color);font-family:var(--md-mermaid-font-family)}.cardinality text{fill:inherit!important}defs #classDiagram-compositionEnd,defs #classDiagram-compositionStart,defs #classDiagram-dependencyEnd,defs #classDiagram-dependencyStart,defs #classDiagram-extensionEnd,defs #classDiagram-extensionStart{fill:var(--md-mermaid-edge-color)!important;stroke:var(--md-mermaid-edge-color)!important}defs #classDiagram-aggregationEnd,defs #classDiagram-aggregationStart{fill:var(--md-mermaid-label-bg-color)!important;stroke:var(--md-mermaid-edge-color)!important}g.stateGroup rect{fill:var(--md-mermaid-node-bg-color);stroke:var(--md-mermaid-node-fg-color)}g.stateGroup .state-title{fill:var(--md-mermaid-label-fg-color)!important;font-family:var(--md-mermaid-font-family)}g.stateGroup .composit{fill:var(--md-mermaid-label-bg-color)}.nodeLabel{color:var(--md-mermaid-label-fg-color);font-family:var(--md-mermaid-font-family)}.node circle.state-end,.node circle.state-start,.start-state{fill:var(--md-mermaid-edge-color);stroke:none}.end-state-inner,.end-state-outer{fill:var(--md-mermaid-edge-color)}.end-state-inner,.node circle.state-end{stroke:var(--md-mermaid-label-bg-color)}.transition{stroke:var(--md-mermaid-edge-color)}[id^=state-fork] rect,[id^=state-join] rect{fill:var(--md-mermaid-edge-color)!important;stroke:none!important}.statediagram-cluster.statediagram-cluster .inner{fill:var(--md-default-bg-color)}.statediagram-cluster rect{fill:var(--md-mermaid-node-bg-color);stroke:var(--md-mermaid-node-fg-color)}.statediagram-state rect.divider{fill:var(--md-default-fg-color--lightest);stroke:var(--md-default-fg-color--lighter)}defs #statediagram-barbEnd{stroke:var(--md-mermaid-edge-color)}.attributeBoxEven,.attributeBoxOdd{fill:var(--md-mermaid-node-bg-color);stroke:var(--md-mermaid-node-fg-color)}.entityBox{fill:var(--md-mermaid-label-bg-color);stroke:var(--md-mermaid-node-fg-color)}.entityLabel{fill:var(--md-mermaid-label-fg-color);font-family:var(--md-mermaid-font-family)}.relationshipLabelBox{fill:var(--md-mermaid-label-bg-color);fill-opacity:1;background-color:var(--md-mermaid-label-bg-color);opacity:1}.relationshipLabel{fill:var(--md-mermaid-label-fg-color)}.relationshipLine{stroke:var(--md-mermaid-edge-color)}defs #ONE_OR_MORE_END *,defs #ONE_OR_MORE_START *,defs #ONLY_ONE_END *,defs #ONLY_ONE_START *,defs #ZERO_OR_MORE_END *,defs #ZERO_OR_MORE_START *,defs #ZERO_OR_ONE_END *,defs #ZERO_OR_ONE_START *{stroke:var(--md-mermaid-edge-color)!important}defs #ZERO_OR_MORE_END circle,defs #ZERO_OR_MORE_START circle{fill:var(--md-mermaid-label-bg-color)}.actor{fill:var(--md-mermaid-sequence-actor-bg-color);stroke:var(--md-mermaid-sequence-actor-border-color)}text.actor>tspan{fill:var(--md-mermaid-sequence-actor-fg-color);font-family:var(--md-mermaid-font-family)}line{stroke:var(--md-mermaid-sequence-actor-line-color)}.actor-man circle,.actor-man line{fill:var(--md-mermaid-sequence-actorman-bg-color);stroke:var(--md-mermaid-sequence-actorman-line-color)}.messageLine0,.messageLine1{stroke:var(--md-mermaid-sequence-message-line-color)}.note{fill:var(--md-mermaid-sequence-note-bg-color);stroke:var(--md-mermaid-sequence-note-border-color)}.loopText,.loopText>tspan,.messageText,.noteText>tspan{stroke:none;font-family:var(--md-mermaid-font-family)!important}.messageText{fill:var(--md-mermaid-sequence-message-fg-color)}.loopText,.loopText>tspan{fill:var(--md-mermaid-sequence-loop-fg-color)}.noteText>tspan{fill:var(--md-mermaid-sequence-note-fg-color)}#arrowhead path{fill:var(--md-mermaid-sequence-message-line-color);stroke:none}.loopLine{fill:var(--md-mermaid-sequence-loop-bg-color);stroke:var(--md-mermaid-sequence-loop-border-color)}.labelBox{fill:var(--md-mermaid-sequence-label-bg-color);stroke:none}.labelText,.labelText>span{fill:var(--md-mermaid-sequence-label-fg-color);font-family:var(--md-mermaid-font-family)}.sequenceNumber{fill:var(--md-mermaid-sequence-number-fg-color)}rect.rect{fill:var(--md-mermaid-sequence-box-bg-color);stroke:none}rect.rect+text.text{fill:var(--md-mermaid-sequence-box-fg-color)}defs #sequencenumber{fill:var(--md-mermaid-sequence-number-bg-color)!important}";var Qr,Aa=0;function Ca(){return typeof mermaid=="undefined"||mermaid instanceof Element?gt("https://unpkg.com/mermaid@10.6.1/dist/mermaid.min.js"):R(void 0)}function _n(e){return e.classList.remove("mermaid"),Qr||(Qr=Ca().pipe(T(()=>mermaid.initialize({startOnLoad:!1,themeCSS:Ln,sequence:{actorFontSize:"16px",messageFontSize:"16px",noteFontSize:"16px"}})),m(()=>{}),Z(1))),Qr.subscribe(()=>no(this,null,function*(){e.classList.add("mermaid");let t=`__mermaid_${Aa++}`,r=S("div",{class:"mermaid"}),o=e.textContent,{svg:n,fn:i}=yield mermaid.render(t,o),s=r.attachShadow({mode:"closed"});s.innerHTML=n,e.replaceWith(r),i==null||i(s)})),Qr.pipe(m(()=>({ref:e})))}var An=S("table");function Cn(e){return e.replaceWith(An),An.replaceWith(vn(e)),R({ref:e})}function ka(e){let t=e.find(r=>r.checked)||e[0];return L(...e.map(r=>h(r,"change").pipe(m(()=>U(`label[for="${r.id}"]`))))).pipe(q(U(`label[for="${t.id}"]`)),m(r=>({active:r})))}function kn(e,{viewport$:t,target$:r}){let o=U(".tabbed-labels",e),n=W(":scope > input",e),i=zr("prev");e.append(i);let s=zr("next");return e.append(s),H(()=>{let a=new x,c=a.pipe(ee(),oe(!0));B([a,Se(e)]).pipe(j(c),Le(1,ge)).subscribe({next([{active:p},l]){let f=Ue(p),{width:u}=le(p);e.style.setProperty("--md-indicator-x",`${f.x}px`),e.style.setProperty("--md-indicator-width",`${u}px`);let d=ir(o);(f.xd.x+l.width)&&o.scrollTo({left:Math.max(0,f.x-16),behavior:"smooth"})},complete(){e.style.removeProperty("--md-indicator-x"),e.style.removeProperty("--md-indicator-width")}}),B([et(o),Se(o)]).pipe(j(c)).subscribe(([p,l])=>{let f=xt(o);i.hidden=p.x<16,s.hidden=p.x>f.width-l.width-16}),L(h(i,"click").pipe(m(()=>-1)),h(s,"click").pipe(m(()=>1))).pipe(j(c)).subscribe(p=>{let{width:l}=le(o);o.scrollBy({left:l*p,behavior:"smooth"})}),r.pipe(j(c),v(p=>n.includes(p))).subscribe(p=>p.click()),o.classList.add("tabbed-labels--linked");for(let p of n){let l=U(`label[for="${p.id}"]`);l.replaceChildren(S("a",{href:`#${l.htmlFor}`,tabIndex:-1},...Array.from(l.childNodes))),h(l.firstElementChild,"click").pipe(j(c),v(f=>!(f.metaKey||f.ctrlKey)),T(f=>{f.preventDefault(),f.stopPropagation()})).subscribe(()=>{history.replaceState({},"",`#${l.htmlFor}`),l.click()})}return G("content.tabs.link")&&a.pipe(Ee(1),ae(t)).subscribe(([{active:p},{offset:l}])=>{let f=p.innerText.trim();if(p.hasAttribute("data-md-switching"))p.removeAttribute("data-md-switching");else{let u=e.offsetTop-l.y;for(let y of W("[data-tabs]"))for(let b of W(":scope > input",y)){let D=U(`label[for="${b.id}"]`);if(D!==p&&D.innerText.trim()===f){D.setAttribute("data-md-switching",""),b.click();break}}window.scrollTo({top:e.offsetTop-u});let d=__md_get("__tabs")||[];__md_set("__tabs",[...new Set([f,...d])])}}),a.pipe(j(c)).subscribe(()=>{for(let p of W("audio, video",e))p.pause()}),ka(n).pipe(T(p=>a.next(p)),A(()=>a.complete()),m(p=>P({ref:e},p)))}).pipe(qe(ie))}function Hn(e,{viewport$:t,target$:r,print$:o}){return L(...W(".annotate:not(.highlight)",e).map(n=>wn(n,{target$:r,print$:o})),...W("pre:not(.mermaid) > code",e).map(n=>On(n,{target$:r,print$:o})),...W("pre.mermaid",e).map(n=>_n(n)),...W("table:not([class])",e).map(n=>Cn(n)),...W("details",e).map(n=>Mn(n,{target$:r,print$:o})),...W("[data-tabs]",e).map(n=>kn(n,{viewport$:t,target$:r})),...W("[title]",e).filter(()=>G("content.tooltips")).map(n=>Be(n)))}function Ha(e,{alert$:t}){return t.pipe(w(r=>L(R(!0),R(!1).pipe(Qe(2e3))).pipe(m(o=>({message:r,active:o})))))}function $n(e,t){let r=U(".md-typeset",e);return H(()=>{let o=new x;return o.subscribe(({message:n,active:i})=>{e.classList.toggle("md-dialog--active",i),r.textContent=n}),Ha(e,t).pipe(T(n=>o.next(n)),A(()=>o.complete()),m(n=>P({ref:e},n)))})}function $a({viewport$:e}){if(!G("header.autohide"))return R(!1);let t=e.pipe(m(({offset:{y:n}})=>n),Ce(2,1),m(([n,i])=>[nMath.abs(i-n.y)>100),m(([,[n]])=>n),X()),o=Ne("search");return B([e,o]).pipe(m(([{offset:n},i])=>n.y>400&&!i),X(),w(n=>n?r:R(!1)),q(!1))}function Pn(e,t){return H(()=>B([Se(e),$a(t)])).pipe(m(([{height:r},o])=>({height:r,hidden:o})),X((r,o)=>r.height===o.height&&r.hidden===o.hidden),Z(1))}function Rn(e,{header$:t,main$:r}){return H(()=>{let o=new x,n=o.pipe(ee(),oe(!0));o.pipe(te("active"),Ze(t)).subscribe(([{active:s},{hidden:a}])=>{e.classList.toggle("md-header--shadow",s&&!a),e.hidden=a});let i=fe(W("[title]",e)).pipe(v(()=>G("content.tooltips")),re(s=>Be(s)));return r.subscribe(o),t.pipe(j(n),m(s=>P({ref:e},s)),Re(i.pipe(j(n))))})}function Pa(e,{viewport$:t,header$:r}){return mr(e,{viewport$:t,header$:r}).pipe(m(({offset:{y:o}})=>{let{height:n}=le(e);return{active:o>=n}}),te("active"))}function In(e,t){return H(()=>{let r=new x;r.subscribe({next({active:n}){e.classList.toggle("md-header__title--active",n)},complete(){e.classList.remove("md-header__title--active")}});let o=ce(".md-content h1");return typeof o=="undefined"?M:Pa(o,t).pipe(T(n=>r.next(n)),A(()=>r.complete()),m(n=>P({ref:e},n)))})}function Fn(e,{viewport$:t,header$:r}){let o=r.pipe(m(({height:i})=>i),X()),n=o.pipe(w(()=>Se(e).pipe(m(({height:i})=>({top:e.offsetTop,bottom:e.offsetTop+i})),te("bottom"))));return B([o,n,t]).pipe(m(([i,{top:s,bottom:a},{offset:{y:c},size:{height:p}}])=>(p=Math.max(0,p-Math.max(0,s-c,i)-Math.max(0,p+c-a)),{offset:s-i,height:p,active:s-i<=c})),X((i,s)=>i.offset===s.offset&&i.height===s.height&&i.active===s.active))}function Ra(e){let t=__md_get("__palette")||{index:e.findIndex(o=>matchMedia(o.getAttribute("data-md-color-media")).matches)},r=Math.max(0,Math.min(t.index,e.length-1));return R(...e).pipe(re(o=>h(o,"change").pipe(m(()=>o))),q(e[r]),m(o=>({index:e.indexOf(o),color:{media:o.getAttribute("data-md-color-media"),scheme:o.getAttribute("data-md-color-scheme"),primary:o.getAttribute("data-md-color-primary"),accent:o.getAttribute("data-md-color-accent")}})),Z(1))}function jn(e){let t=W("input",e),r=S("meta",{name:"theme-color"});document.head.appendChild(r);let o=S("meta",{name:"color-scheme"});document.head.appendChild(o);let n=At("(prefers-color-scheme: light)");return H(()=>{let i=new x;return i.subscribe(s=>{if(document.body.setAttribute("data-md-color-switching",""),s.color.media==="(prefers-color-scheme)"){let a=matchMedia("(prefers-color-scheme: light)"),c=document.querySelector(a.matches?"[data-md-color-media='(prefers-color-scheme: light)']":"[data-md-color-media='(prefers-color-scheme: dark)']");s.color.scheme=c.getAttribute("data-md-color-scheme"),s.color.primary=c.getAttribute("data-md-color-primary"),s.color.accent=c.getAttribute("data-md-color-accent")}for(let[a,c]of Object.entries(s.color))document.body.setAttribute(`data-md-color-${a}`,c);for(let a=0;a{let s=Oe("header"),a=window.getComputedStyle(s);return o.content=a.colorScheme,a.backgroundColor.match(/\d+/g).map(c=>(+c).toString(16).padStart(2,"0")).join("")})).subscribe(s=>r.content=`#${s}`),i.pipe(Me(ie)).subscribe(()=>{document.body.removeAttribute("data-md-color-switching")}),Ra(t).pipe(j(n.pipe(Ee(1))),at(),T(s=>i.next(s)),A(()=>i.complete()),m(s=>P({ref:e},s)))})}function Wn(e,{progress$:t}){return H(()=>{let r=new x;return r.subscribe(({value:o})=>{e.style.setProperty("--md-progress-value",`${o}`)}),t.pipe(T(o=>r.next({value:o})),A(()=>r.complete()),m(o=>({ref:e,value:o})))})}var Yr=jt(Kr());function Ia(e){e.setAttribute("data-md-copying","");let t=e.closest("[data-copy]"),r=t?t.getAttribute("data-copy"):e.innerText;return e.removeAttribute("data-md-copying"),r.trimEnd()}function Un({alert$:e}){Yr.default.isSupported()&&new I(t=>{new Yr.default("[data-clipboard-target], [data-clipboard-text]",{text:r=>r.getAttribute("data-clipboard-text")||Ia(U(r.getAttribute("data-clipboard-target")))}).on("success",r=>t.next(r))}).pipe(T(t=>{t.trigger.focus()}),m(()=>we("clipboard.copied"))).subscribe(e)}function Fa(e){if(e.length<2)return[""];let[t,r]=[...e].sort((n,i)=>n.length-i.length).map(n=>n.replace(/[^/]+$/,"")),o=0;if(t===r)o=t.length;else for(;t.charCodeAt(o)===r.charCodeAt(o);)o++;return e.map(n=>n.replace(t.slice(0,o),""))}function ur(e){let t=__md_get("__sitemap",sessionStorage,e);if(t)return R(t);{let r=he();return on(new URL("sitemap.xml",e||r.base)).pipe(m(o=>Fa(W("loc",o).map(n=>n.textContent))),xe(()=>M),$e([]),T(o=>__md_set("__sitemap",o,sessionStorage,e)))}}function Nn(e){let t=ce("[rel=canonical]",e);typeof t!="undefined"&&(t.href=t.href.replace("//localhost:","//127.0.0.1:"));let r=new Map;for(let o of W(":scope > *",e)){let n=o.outerHTML;for(let i of["href","src"]){let s=o.getAttribute(i);if(s===null)continue;let a=new URL(s,t==null?void 0:t.href),c=o.cloneNode();c.setAttribute(i,`${a}`),n=c.outerHTML;break}r.set(n,o)}return r}function Dn({location$:e,viewport$:t,progress$:r}){let o=he();if(location.protocol==="file:")return M;let n=ur().pipe(m(l=>l.map(f=>`${new URL(f,o.base)}`))),i=h(document.body,"click").pipe(ae(n),w(([l,f])=>{if(!(l.target instanceof Element))return M;let u=l.target.closest("a");if(u===null)return M;if(u.target||l.metaKey||l.ctrlKey)return M;let d=new URL(u.href);return d.search=d.hash="",f.includes(`${d}`)?(l.preventDefault(),R(new URL(u.href))):M}),de());i.pipe(ue(1)).subscribe(()=>{let l=ce("link[rel=icon]");typeof l!="undefined"&&(l.href=l.href)}),h(window,"beforeunload").subscribe(()=>{history.scrollRestoration="auto"}),i.pipe(ae(t)).subscribe(([l,{offset:f}])=>{history.scrollRestoration="manual",history.replaceState(f,""),history.pushState(null,"",l)}),i.subscribe(e);let s=e.pipe(q(me()),te("pathname"),Ee(1),w(l=>lr(l,{progress$:r}).pipe(xe(()=>(st(l,!0),M))))),a=new DOMParser,c=s.pipe(w(l=>l.text()),w(l=>{let f=a.parseFromString(l,"text/html");for(let b of["[data-md-component=announce]","[data-md-component=container]","[data-md-component=header-topic]","[data-md-component=outdated]","[data-md-component=logo]","[data-md-component=skip]",...G("navigation.tabs.sticky")?["[data-md-component=tabs]"]:[]]){let D=ce(b),Q=ce(b,f);typeof D!="undefined"&&typeof Q!="undefined"&&D.replaceWith(Q)}let u=Nn(document.head),d=Nn(f.head);for(let[b,D]of d)D.getAttribute("rel")==="stylesheet"||D.hasAttribute("src")||(u.has(b)?u.delete(b):document.head.appendChild(D));for(let b of u.values())b.getAttribute("rel")==="stylesheet"||b.hasAttribute("src")||b.remove();let y=Oe("container");return We(W("script",y)).pipe(w(b=>{let D=f.createElement("script");if(b.src){for(let Q of b.getAttributeNames())D.setAttribute(Q,b.getAttribute(Q));return b.replaceWith(D),new I(Q=>{D.onload=()=>Q.complete()})}else return D.textContent=b.textContent,b.replaceWith(D),M}),ee(),oe(f))}),de());return h(window,"popstate").pipe(m(me)).subscribe(e),e.pipe(q(me()),Ce(2,1),v(([l,f])=>l.pathname===f.pathname&&l.hash!==f.hash),m(([,l])=>l)).subscribe(l=>{var f,u;history.state!==null||!l.hash?window.scrollTo(0,(u=(f=history.state)==null?void 0:f.y)!=null?u:0):(history.scrollRestoration="auto",pr(l.hash),history.scrollRestoration="manual")}),e.pipe(Ir(i),q(me()),Ce(2,1),v(([l,f])=>l.pathname===f.pathname&&l.hash===f.hash),m(([,l])=>l)).subscribe(l=>{history.scrollRestoration="auto",pr(l.hash),history.scrollRestoration="manual",history.back()}),c.pipe(ae(e)).subscribe(([,l])=>{var f,u;history.state!==null||!l.hash?window.scrollTo(0,(u=(f=history.state)==null?void 0:f.y)!=null?u:0):pr(l.hash)}),t.pipe(te("offset"),ye(100)).subscribe(({offset:l})=>{history.replaceState(l,"")}),c}var qn=jt(zn());function Kn(e){let t=e.separator.split("|").map(n=>n.replace(/(\(\?[!=<][^)]+\))/g,"").length===0?"\uFFFD":n).join("|"),r=new RegExp(t,"img"),o=(n,i,s)=>`${i}${s} `;return n=>{n=n.replace(/[\s*+\-:~^]+/g," ").trim();let i=new RegExp(`(^|${e.separator}|)(${n.replace(/[|\\{}()[\]^$+*?.-]/g,"\\$&").replace(r,"|")})`,"img");return s=>(0,qn.default)(s).replace(i,o).replace(/<\/mark>(\s+)]*>/img,"$1")}}function Ht(e){return e.type===1}function dr(e){return e.type===3}function Qn(e,t){let r=ln(e);return L(R(location.protocol!=="file:"),Ne("search")).pipe(Pe(o=>o),w(()=>t)).subscribe(({config:o,docs:n})=>r.next({type:0,data:{config:o,docs:n,options:{suggest:G("search.suggest")}}})),r}function Yn({document$:e}){let t=he(),r=De(new URL("../versions.json",t.base)).pipe(xe(()=>M)),o=r.pipe(m(n=>{let[,i]=t.base.match(/([^/]+)\/?$/);return n.find(({version:s,aliases:a})=>s===i||a.includes(i))||n[0]}));r.pipe(m(n=>new Map(n.map(i=>[`${new URL(`../${i.version}/`,t.base)}`,i]))),w(n=>h(document.body,"click").pipe(v(i=>!i.metaKey&&!i.ctrlKey),ae(o),w(([i,s])=>{if(i.target instanceof Element){let a=i.target.closest("a");if(a&&!a.target&&n.has(a.href)){let c=a.href;return!i.target.closest(".md-version")&&n.get(c)===s?M:(i.preventDefault(),R(c))}}return M}),w(i=>{let{version:s}=n.get(i);return ur(new URL(i)).pipe(m(a=>{let p=me().href.replace(t.base,"");return a.includes(p.split("#")[0])?new URL(`../${s}/${p}`,t.base):new URL(i)}))})))).subscribe(n=>st(n,!0)),B([r,o]).subscribe(([n,i])=>{U(".md-header__topic").appendChild(gn(n,i))}),e.pipe(w(()=>o)).subscribe(n=>{var s;let i=__md_get("__outdated",sessionStorage);if(i===null){i=!0;let a=((s=t.version)==null?void 0:s.default)||"latest";Array.isArray(a)||(a=[a]);e:for(let c of a)for(let p of n.aliases.concat(n.version))if(new RegExp(c,"i").test(p)){i=!1;break e}__md_set("__outdated",i,sessionStorage)}if(i)for(let a of ne("outdated"))a.hidden=!1})}function Da(e,{worker$:t}){let{searchParams:r}=me();r.has("q")&&(Ye("search",!0),e.value=r.get("q"),e.focus(),Ne("search").pipe(Pe(i=>!i)).subscribe(()=>{let i=me();i.searchParams.delete("q"),history.replaceState({},"",`${i}`)}));let o=vt(e),n=L(t.pipe(Pe(Ht)),h(e,"keyup"),o).pipe(m(()=>e.value),X());return B([n,o]).pipe(m(([i,s])=>({value:i,focus:s})),Z(1))}function Bn(e,{worker$:t}){let r=new x,o=r.pipe(ee(),oe(!0));B([t.pipe(Pe(Ht)),r],(i,s)=>s).pipe(te("value")).subscribe(({value:i})=>t.next({type:2,data:i})),r.pipe(te("focus")).subscribe(({focus:i})=>{i&&Ye("search",i)}),h(e.form,"reset").pipe(j(o)).subscribe(()=>e.focus());let n=U("header [for=__search]");return h(n,"click").subscribe(()=>e.focus()),Da(e,{worker$:t}).pipe(T(i=>r.next(i)),A(()=>r.complete()),m(i=>P({ref:e},i)),Z(1))}function Gn(e,{worker$:t,query$:r}){let o=new x,n=Go(e.parentElement).pipe(v(Boolean)),i=e.parentElement,s=U(":scope > :first-child",e),a=U(":scope > :last-child",e);Ne("search").subscribe(l=>a.setAttribute("role",l?"list":"presentation")),o.pipe(ae(r),Wr(t.pipe(Pe(Ht)))).subscribe(([{items:l},{value:f}])=>{switch(l.length){case 0:s.textContent=f.length?we("search.result.none"):we("search.result.placeholder");break;case 1:s.textContent=we("search.result.one");break;default:let u=ar(l.length);s.textContent=we("search.result.other",u)}});let c=o.pipe(T(()=>a.innerHTML=""),w(({items:l})=>L(R(...l.slice(0,10)),R(...l.slice(10)).pipe(Ce(4),Nr(n),w(([f])=>f)))),m(hn),de());return c.subscribe(l=>a.appendChild(l)),c.pipe(re(l=>{let f=ce("details",l);return typeof f=="undefined"?M:h(f,"toggle").pipe(j(o),m(()=>f))})).subscribe(l=>{l.open===!1&&l.offsetTop<=i.scrollTop&&i.scrollTo({top:l.offsetTop})}),t.pipe(v(dr),m(({data:l})=>l)).pipe(T(l=>o.next(l)),A(()=>o.complete()),m(l=>P({ref:e},l)))}function Va(e,{query$:t}){return t.pipe(m(({value:r})=>{let o=me();return o.hash="",r=r.replace(/\s+/g,"+").replace(/&/g,"%26").replace(/=/g,"%3D"),o.search=`q=${r}`,{url:o}}))}function Jn(e,t){let r=new x,o=r.pipe(ee(),oe(!0));return r.subscribe(({url:n})=>{e.setAttribute("data-clipboard-text",e.href),e.href=`${n}`}),h(e,"click").pipe(j(o)).subscribe(n=>n.preventDefault()),Va(e,t).pipe(T(n=>r.next(n)),A(()=>r.complete()),m(n=>P({ref:e},n)))}function Xn(e,{worker$:t,keyboard$:r}){let o=new x,n=Oe("search-query"),i=L(h(n,"keydown"),h(n,"focus")).pipe(Me(ie),m(()=>n.value),X());return o.pipe(Ze(i),m(([{suggest:a},c])=>{let p=c.split(/([\s-]+)/);if(a!=null&&a.length&&p[p.length-1]){let l=a[a.length-1];l.startsWith(p[p.length-1])&&(p[p.length-1]=l)}else p.length=0;return p})).subscribe(a=>e.innerHTML=a.join("").replace(/\s/g," ")),r.pipe(v(({mode:a})=>a==="search")).subscribe(a=>{switch(a.type){case"ArrowRight":e.innerText.length&&n.selectionStart===n.value.length&&(n.value=e.innerText);break}}),t.pipe(v(dr),m(({data:a})=>a)).pipe(T(a=>o.next(a)),A(()=>o.complete()),m(()=>({ref:e})))}function Zn(e,{index$:t,keyboard$:r}){let o=he();try{let n=Qn(o.search,t),i=Oe("search-query",e),s=Oe("search-result",e);h(e,"click").pipe(v(({target:c})=>c instanceof Element&&!!c.closest("a"))).subscribe(()=>Ye("search",!1)),r.pipe(v(({mode:c})=>c==="search")).subscribe(c=>{let p=Ie();switch(c.type){case"Enter":if(p===i){let l=new Map;for(let f of W(":first-child [href]",s)){let u=f.firstElementChild;l.set(f,parseFloat(u.getAttribute("data-md-score")))}if(l.size){let[[f]]=[...l].sort(([,u],[,d])=>d-u);f.click()}c.claim()}break;case"Escape":case"Tab":Ye("search",!1),i.blur();break;case"ArrowUp":case"ArrowDown":if(typeof p=="undefined")i.focus();else{let l=[i,...W(":not(details) > [href], summary, details[open] [href]",s)],f=Math.max(0,(Math.max(0,l.indexOf(p))+l.length+(c.type==="ArrowUp"?-1:1))%l.length);l[f].focus()}c.claim();break;default:i!==Ie()&&i.focus()}}),r.pipe(v(({mode:c})=>c==="global")).subscribe(c=>{switch(c.type){case"f":case"s":case"/":i.focus(),i.select(),c.claim();break}});let a=Bn(i,{worker$:n});return L(a,Gn(s,{worker$:n,query$:a})).pipe(Re(...ne("search-share",e).map(c=>Jn(c,{query$:a})),...ne("search-suggest",e).map(c=>Xn(c,{worker$:n,keyboard$:r}))))}catch(n){return e.hidden=!0,Ke}}function ei(e,{index$:t,location$:r}){return B([t,r.pipe(q(me()),v(o=>!!o.searchParams.get("h")))]).pipe(m(([o,n])=>Kn(o.config)(n.searchParams.get("h"))),m(o=>{var s;let n=new Map,i=document.createNodeIterator(e,NodeFilter.SHOW_TEXT);for(let a=i.nextNode();a;a=i.nextNode())if((s=a.parentElement)!=null&&s.offsetHeight){let c=a.textContent,p=o(c);p.length>c.length&&n.set(a,p)}for(let[a,c]of n){let{childNodes:p}=S("span",null,c);a.replaceWith(...Array.from(p))}return{ref:e,nodes:n}}))}function za(e,{viewport$:t,main$:r}){let o=e.closest(".md-grid"),n=o.offsetTop-o.parentElement.offsetTop;return B([r,t]).pipe(m(([{offset:i,height:s},{offset:{y:a}}])=>(s=s+Math.min(n,Math.max(0,a-i))-n,{height:s,locked:a>=i+n})),X((i,s)=>i.height===s.height&&i.locked===s.locked))}function Br(e,o){var n=o,{header$:t}=n,r=oo(n,["header$"]);let i=U(".md-sidebar__scrollwrap",e),{y:s}=Ue(i);return H(()=>{let a=new x,c=a.pipe(ee(),oe(!0)),p=a.pipe(Le(0,ge));return p.pipe(ae(t)).subscribe({next([{height:l},{height:f}]){i.style.height=`${l-2*s}px`,e.style.top=`${f}px`},complete(){i.style.height="",e.style.top=""}}),p.pipe(Pe()).subscribe(()=>{for(let l of W(".md-nav__link--active[href]",e)){if(!l.clientHeight)continue;let f=l.closest(".md-sidebar__scrollwrap");if(typeof f!="undefined"){let u=l.offsetTop-f.offsetTop,{height:d}=le(f);f.scrollTo({top:u-d/2})}}}),fe(W("label[tabindex]",e)).pipe(re(l=>h(l,"click").pipe(Me(ie),m(()=>l),j(c)))).subscribe(l=>{let f=U(`[id="${l.htmlFor}"]`);U(`[aria-labelledby="${l.id}"]`).setAttribute("aria-expanded",`${f.checked}`)}),za(e,r).pipe(T(l=>a.next(l)),A(()=>a.complete()),m(l=>P({ref:e},l)))})}function ti(e,t){if(typeof t!="undefined"){let r=`https://api.github.com/repos/${e}/${t}`;return Lt(De(`${r}/releases/latest`).pipe(xe(()=>M),m(o=>({version:o.tag_name})),$e({})),De(r).pipe(xe(()=>M),m(o=>({stars:o.stargazers_count,forks:o.forks_count})),$e({}))).pipe(m(([o,n])=>P(P({},o),n)))}else{let r=`https://api.github.com/users/${e}`;return De(r).pipe(m(o=>({repositories:o.public_repos})),$e({}))}}function ri(e,t){let r=`https://${e}/api/v4/projects/${encodeURIComponent(t)}`;return De(r).pipe(xe(()=>M),m(({star_count:o,forks_count:n})=>({stars:o,forks:n})),$e({}))}function oi(e){let t=e.match(/^.+github\.com\/([^/]+)\/?([^/]+)?/i);if(t){let[,r,o]=t;return ti(r,o)}if(t=e.match(/^.+?([^/]*gitlab[^/]+)\/(.+?)\/?$/i),t){let[,r,o]=t;return ri(r,o)}return M}var qa;function Ka(e){return qa||(qa=H(()=>{let t=__md_get("__source",sessionStorage);if(t)return R(t);if(ne("consent").length){let o=__md_get("__consent");if(!(o&&o.github))return M}return oi(e.href).pipe(T(o=>__md_set("__source",o,sessionStorage)))}).pipe(xe(()=>M),v(t=>Object.keys(t).length>0),m(t=>({facts:t})),Z(1)))}function ni(e){let t=U(":scope > :last-child",e);return H(()=>{let r=new x;return r.subscribe(({facts:o})=>{t.appendChild(bn(o)),t.classList.add("md-source__repository--active")}),Ka(e).pipe(T(o=>r.next(o)),A(()=>r.complete()),m(o=>P({ref:e},o)))})}function Qa(e,{viewport$:t,header$:r}){return Se(document.body).pipe(w(()=>mr(e,{header$:r,viewport$:t})),m(({offset:{y:o}})=>({hidden:o>=10})),te("hidden"))}function ii(e,t){return H(()=>{let r=new x;return r.subscribe({next({hidden:o}){e.hidden=o},complete(){e.hidden=!1}}),(G("navigation.tabs.sticky")?R({hidden:!1}):Qa(e,t)).pipe(T(o=>r.next(o)),A(()=>r.complete()),m(o=>P({ref:e},o)))})}function Ya(e,{viewport$:t,header$:r}){let o=new Map,n=W("[href^=\\#]",e);for(let a of n){let c=decodeURIComponent(a.hash.substring(1)),p=ce(`[id="${c}"]`);typeof p!="undefined"&&o.set(a,p)}let i=r.pipe(te("height"),m(({height:a})=>{let c=Oe("main"),p=U(":scope > :first-child",c);return a+.8*(p.offsetTop-c.offsetTop)}),de());return Se(document.body).pipe(te("height"),w(a=>H(()=>{let c=[];return R([...o].reduce((p,[l,f])=>{for(;c.length&&o.get(c[c.length-1]).tagName>=f.tagName;)c.pop();let u=f.offsetTop;for(;!u&&f.parentElement;)f=f.parentElement,u=f.offsetTop;let d=f.offsetParent;for(;d;d=d.offsetParent)u+=d.offsetTop;return p.set([...c=[...c,l]].reverse(),u)},new Map))}).pipe(m(c=>new Map([...c].sort(([,p],[,l])=>p-l))),Ze(i),w(([c,p])=>t.pipe(Fr(([l,f],{offset:{y:u},size:d})=>{let y=u+d.height>=Math.floor(a.height);for(;f.length;){let[,b]=f[0];if(b-p=u&&!y)f=[l.pop(),...f];else break}return[l,f]},[[],[...c]]),X((l,f)=>l[0]===f[0]&&l[1]===f[1])))))).pipe(m(([a,c])=>({prev:a.map(([p])=>p),next:c.map(([p])=>p)})),q({prev:[],next:[]}),Ce(2,1),m(([a,c])=>a.prev.length{let i=new x,s=i.pipe(ee(),oe(!0));if(i.subscribe(({prev:a,next:c})=>{for(let[p]of c)p.classList.remove("md-nav__link--passed"),p.classList.remove("md-nav__link--active");for(let[p,[l]]of a.entries())l.classList.add("md-nav__link--passed"),l.classList.toggle("md-nav__link--active",p===a.length-1)}),G("toc.follow")){let a=L(t.pipe(ye(1),m(()=>{})),t.pipe(ye(250),m(()=>"smooth")));i.pipe(v(({prev:c})=>c.length>0),Ze(o.pipe(Me(ie))),ae(a)).subscribe(([[{prev:c}],p])=>{let[l]=c[c.length-1];if(l.offsetHeight){let f=sr(l);if(typeof f!="undefined"){let u=l.offsetTop-f.offsetTop,{height:d}=le(f);f.scrollTo({top:u-d/2,behavior:p})}}})}return G("navigation.tracking")&&t.pipe(j(s),te("offset"),ye(250),Ee(1),j(n.pipe(Ee(1))),at({delay:250}),ae(i)).subscribe(([,{prev:a}])=>{let c=me(),p=a[a.length-1];if(p&&p.length){let[l]=p,{hash:f}=new URL(l.href);c.hash!==f&&(c.hash=f,history.replaceState({},"",`${c}`))}else c.hash="",history.replaceState({},"",`${c}`)}),Ya(e,{viewport$:t,header$:r}).pipe(T(a=>i.next(a)),A(()=>i.complete()),m(a=>P({ref:e},a)))})}function Ba(e,{viewport$:t,main$:r,target$:o}){let n=t.pipe(m(({offset:{y:s}})=>s),Ce(2,1),m(([s,a])=>s>a&&a>0),X()),i=r.pipe(m(({active:s})=>s));return B([i,n]).pipe(m(([s,a])=>!(s&&a)),X(),j(o.pipe(Ee(1))),oe(!0),at({delay:250}),m(s=>({hidden:s})))}function si(e,{viewport$:t,header$:r,main$:o,target$:n}){let i=new x,s=i.pipe(ee(),oe(!0));return i.subscribe({next({hidden:a}){e.hidden=a,a?(e.setAttribute("tabindex","-1"),e.blur()):e.removeAttribute("tabindex")},complete(){e.style.top="",e.hidden=!0,e.removeAttribute("tabindex")}}),r.pipe(j(s),te("height")).subscribe(({height:a})=>{e.style.top=`${a+16}px`}),h(e,"click").subscribe(a=>{a.preventDefault(),window.scrollTo({top:0})}),Ba(e,{viewport$:t,main$:o,target$:n}).pipe(T(a=>i.next(a)),A(()=>i.complete()),m(a=>P({ref:e},a)))}function ci({document$:e}){e.pipe(w(()=>W(".md-ellipsis")),re(t=>yt(t).pipe(j(e.pipe(Ee(1))),v(r=>r),m(()=>t),ue(1))),v(t=>t.offsetWidth{let r=t.innerText,o=t.closest("a")||t;return o.title=r,Be(o).pipe(j(e.pipe(Ee(1))),A(()=>o.removeAttribute("title")))})).subscribe(),e.pipe(w(()=>W(".md-status")),re(t=>Be(t))).subscribe()}function pi({document$:e,tablet$:t}){e.pipe(w(()=>W(".md-toggle--indeterminate")),T(r=>{r.indeterminate=!0,r.checked=!1}),re(r=>h(r,"change").pipe(Ur(()=>r.classList.contains("md-toggle--indeterminate")),m(()=>r))),ae(t)).subscribe(([r,o])=>{r.classList.remove("md-toggle--indeterminate"),o&&(r.checked=!1)})}function Ga(){return/(iPad|iPhone|iPod)/.test(navigator.userAgent)}function li({document$:e}){e.pipe(w(()=>W("[data-md-scrollfix]")),T(t=>t.removeAttribute("data-md-scrollfix")),v(Ga),re(t=>h(t,"touchstart").pipe(m(()=>t)))).subscribe(t=>{let r=t.scrollTop;r===0?t.scrollTop=1:r+t.offsetHeight===t.scrollHeight&&(t.scrollTop=r-1)})}function mi({viewport$:e,tablet$:t}){B([Ne("search"),t]).pipe(m(([r,o])=>r&&!o),w(r=>R(r).pipe(Qe(r?400:100))),ae(e)).subscribe(([r,{offset:{y:o}}])=>{if(r)document.body.setAttribute("data-md-scrolllock",""),document.body.style.top=`-${o}px`;else{let n=-1*parseInt(document.body.style.top,10);document.body.removeAttribute("data-md-scrolllock"),document.body.style.top="",n&&window.scrollTo(0,n)}})}Object.entries||(Object.entries=function(e){let t=[];for(let r of Object.keys(e))t.push([r,e[r]]);return t});Object.values||(Object.values=function(e){let t=[];for(let r of Object.keys(e))t.push(e[r]);return t});typeof Element!="undefined"&&(Element.prototype.scrollTo||(Element.prototype.scrollTo=function(e,t){typeof e=="object"?(this.scrollLeft=e.left,this.scrollTop=e.top):(this.scrollLeft=e,this.scrollTop=t)}),Element.prototype.replaceWith||(Element.prototype.replaceWith=function(...e){let t=this.parentNode;if(t){e.length===0&&t.removeChild(this);for(let r=e.length-1;r>=0;r--){let o=e[r];typeof o=="string"?o=document.createTextNode(o):o.parentNode&&o.parentNode.removeChild(o),r?t.insertBefore(this.previousSibling,o):t.replaceChild(o,this)}}}));function Ja(){return location.protocol==="file:"?gt(`${new URL("search/search_index.js",Gr.base)}`).pipe(m(()=>__index),Z(1)):De(new URL("search/search_index.json",Gr.base))}document.documentElement.classList.remove("no-js");document.documentElement.classList.add("js");var rt=zo(),Pt=Zo(),wt=tn(Pt),Jr=Xo(),_e=pn(),hr=At("(min-width: 960px)"),ui=At("(min-width: 1220px)"),di=rn(),Gr=he(),hi=document.forms.namedItem("search")?Ja():Ke,Xr=new x;Un({alert$:Xr});var Zr=new x;G("navigation.instant")&&Dn({location$:Pt,viewport$:_e,progress$:Zr}).subscribe(rt);var fi;((fi=Gr.version)==null?void 0:fi.provider)==="mike"&&Yn({document$:rt});L(Pt,wt).pipe(Qe(125)).subscribe(()=>{Ye("drawer",!1),Ye("search",!1)});Jr.pipe(v(({mode:e})=>e==="global")).subscribe(e=>{switch(e.type){case"p":case",":let t=ce("link[rel=prev]");typeof t!="undefined"&&st(t);break;case"n":case".":let r=ce("link[rel=next]");typeof r!="undefined"&&st(r);break;case"Enter":let o=Ie();o instanceof HTMLLabelElement&&o.click()}});ci({document$:rt});pi({document$:rt,tablet$:hr});li({document$:rt});mi({viewport$:_e,tablet$:hr});var tt=Pn(Oe("header"),{viewport$:_e}),$t=rt.pipe(m(()=>Oe("main")),w(e=>Fn(e,{viewport$:_e,header$:tt})),Z(1)),Xa=L(...ne("consent").map(e=>fn(e,{target$:wt})),...ne("dialog").map(e=>$n(e,{alert$:Xr})),...ne("header").map(e=>Rn(e,{viewport$:_e,header$:tt,main$:$t})),...ne("palette").map(e=>jn(e)),...ne("progress").map(e=>Wn(e,{progress$:Zr})),...ne("search").map(e=>Zn(e,{index$:hi,keyboard$:Jr})),...ne("source").map(e=>ni(e))),Za=H(()=>L(...ne("announce").map(e=>mn(e)),...ne("content").map(e=>Hn(e,{viewport$:_e,target$:wt,print$:di})),...ne("content").map(e=>G("search.highlight")?ei(e,{index$:hi,location$:Pt}):M),...ne("header-title").map(e=>In(e,{viewport$:_e,header$:tt})),...ne("sidebar").map(e=>e.getAttribute("data-md-type")==="navigation"?Dr(ui,()=>Br(e,{viewport$:_e,header$:tt,main$:$t})):Dr(hr,()=>Br(e,{viewport$:_e,header$:tt,main$:$t}))),...ne("tabs").map(e=>ii(e,{viewport$:_e,header$:tt})),...ne("toc").map(e=>ai(e,{viewport$:_e,header$:tt,main$:$t,target$:wt})),...ne("top").map(e=>si(e,{viewport$:_e,header$:tt,main$:$t,target$:wt})))),bi=rt.pipe(w(()=>Za),Re(Xa),Z(1));bi.subscribe();window.document$=rt;window.location$=Pt;window.target$=wt;window.keyboard$=Jr;window.viewport$=_e;window.tablet$=hr;window.screen$=ui;window.print$=di;window.alert$=Xr;window.progress$=Zr;window.component$=bi;})();
+//# sourceMappingURL=bundle.7389ff0e.min.js.map
+
diff --git a/assets/javascripts/bundle.7389ff0e.min.js.map b/assets/javascripts/bundle.7389ff0e.min.js.map
new file mode 100644
index 0000000..dbee324
--- /dev/null
+++ b/assets/javascripts/bundle.7389ff0e.min.js.map
@@ -0,0 +1,7 @@
+{
+ "version": 3,
+ "sources": ["node_modules/focus-visible/dist/focus-visible.js", "node_modules/clipboard/dist/clipboard.js", "node_modules/escape-html/index.js", "src/templates/assets/javascripts/bundle.ts", "node_modules/rxjs/node_modules/tslib/tslib.es6.js", "node_modules/rxjs/src/internal/util/isFunction.ts", "node_modules/rxjs/src/internal/util/createErrorClass.ts", "node_modules/rxjs/src/internal/util/UnsubscriptionError.ts", "node_modules/rxjs/src/internal/util/arrRemove.ts", "node_modules/rxjs/src/internal/Subscription.ts", "node_modules/rxjs/src/internal/config.ts", "node_modules/rxjs/src/internal/scheduler/timeoutProvider.ts", "node_modules/rxjs/src/internal/util/reportUnhandledError.ts", "node_modules/rxjs/src/internal/util/noop.ts", "node_modules/rxjs/src/internal/NotificationFactories.ts", "node_modules/rxjs/src/internal/util/errorContext.ts", "node_modules/rxjs/src/internal/Subscriber.ts", "node_modules/rxjs/src/internal/symbol/observable.ts", "node_modules/rxjs/src/internal/util/identity.ts", "node_modules/rxjs/src/internal/util/pipe.ts", "node_modules/rxjs/src/internal/Observable.ts", "node_modules/rxjs/src/internal/util/lift.ts", "node_modules/rxjs/src/internal/operators/OperatorSubscriber.ts", "node_modules/rxjs/src/internal/scheduler/animationFrameProvider.ts", "node_modules/rxjs/src/internal/util/ObjectUnsubscribedError.ts", "node_modules/rxjs/src/internal/Subject.ts", "node_modules/rxjs/src/internal/scheduler/dateTimestampProvider.ts", "node_modules/rxjs/src/internal/ReplaySubject.ts", "node_modules/rxjs/src/internal/scheduler/Action.ts", "node_modules/rxjs/src/internal/scheduler/intervalProvider.ts", "node_modules/rxjs/src/internal/scheduler/AsyncAction.ts", "node_modules/rxjs/src/internal/Scheduler.ts", "node_modules/rxjs/src/internal/scheduler/AsyncScheduler.ts", "node_modules/rxjs/src/internal/scheduler/async.ts", "node_modules/rxjs/src/internal/scheduler/AnimationFrameAction.ts", "node_modules/rxjs/src/internal/scheduler/AnimationFrameScheduler.ts", "node_modules/rxjs/src/internal/scheduler/animationFrame.ts", "node_modules/rxjs/src/internal/observable/empty.ts", "node_modules/rxjs/src/internal/util/isScheduler.ts", "node_modules/rxjs/src/internal/util/args.ts", "node_modules/rxjs/src/internal/util/isArrayLike.ts", "node_modules/rxjs/src/internal/util/isPromise.ts", "node_modules/rxjs/src/internal/util/isInteropObservable.ts", "node_modules/rxjs/src/internal/util/isAsyncIterable.ts", "node_modules/rxjs/src/internal/util/throwUnobservableError.ts", "node_modules/rxjs/src/internal/symbol/iterator.ts", "node_modules/rxjs/src/internal/util/isIterable.ts", "node_modules/rxjs/src/internal/util/isReadableStreamLike.ts", "node_modules/rxjs/src/internal/observable/innerFrom.ts", "node_modules/rxjs/src/internal/util/executeSchedule.ts", "node_modules/rxjs/src/internal/operators/observeOn.ts", "node_modules/rxjs/src/internal/operators/subscribeOn.ts", "node_modules/rxjs/src/internal/scheduled/scheduleObservable.ts", "node_modules/rxjs/src/internal/scheduled/schedulePromise.ts", "node_modules/rxjs/src/internal/scheduled/scheduleArray.ts", "node_modules/rxjs/src/internal/scheduled/scheduleIterable.ts", "node_modules/rxjs/src/internal/scheduled/scheduleAsyncIterable.ts", "node_modules/rxjs/src/internal/scheduled/scheduleReadableStreamLike.ts", "node_modules/rxjs/src/internal/scheduled/scheduled.ts", "node_modules/rxjs/src/internal/observable/from.ts", "node_modules/rxjs/src/internal/observable/of.ts", "node_modules/rxjs/src/internal/observable/throwError.ts", "node_modules/rxjs/src/internal/util/EmptyError.ts", "node_modules/rxjs/src/internal/util/isDate.ts", "node_modules/rxjs/src/internal/operators/map.ts", "node_modules/rxjs/src/internal/util/mapOneOrManyArgs.ts", "node_modules/rxjs/src/internal/util/argsArgArrayOrObject.ts", "node_modules/rxjs/src/internal/util/createObject.ts", "node_modules/rxjs/src/internal/observable/combineLatest.ts", "node_modules/rxjs/src/internal/operators/mergeInternals.ts", "node_modules/rxjs/src/internal/operators/mergeMap.ts", "node_modules/rxjs/src/internal/operators/mergeAll.ts", "node_modules/rxjs/src/internal/operators/concatAll.ts", "node_modules/rxjs/src/internal/observable/concat.ts", "node_modules/rxjs/src/internal/observable/defer.ts", "node_modules/rxjs/src/internal/observable/fromEvent.ts", "node_modules/rxjs/src/internal/observable/fromEventPattern.ts", "node_modules/rxjs/src/internal/observable/timer.ts", "node_modules/rxjs/src/internal/observable/merge.ts", "node_modules/rxjs/src/internal/observable/never.ts", "node_modules/rxjs/src/internal/util/argsOrArgArray.ts", "node_modules/rxjs/src/internal/operators/filter.ts", "node_modules/rxjs/src/internal/observable/zip.ts", "node_modules/rxjs/src/internal/operators/audit.ts", "node_modules/rxjs/src/internal/operators/auditTime.ts", "node_modules/rxjs/src/internal/operators/bufferCount.ts", "node_modules/rxjs/src/internal/operators/catchError.ts", "node_modules/rxjs/src/internal/operators/scanInternals.ts", "node_modules/rxjs/src/internal/operators/combineLatest.ts", "node_modules/rxjs/src/internal/operators/combineLatestWith.ts", "node_modules/rxjs/src/internal/operators/debounceTime.ts", "node_modules/rxjs/src/internal/operators/defaultIfEmpty.ts", "node_modules/rxjs/src/internal/operators/take.ts", "node_modules/rxjs/src/internal/operators/ignoreElements.ts", "node_modules/rxjs/src/internal/operators/mapTo.ts", "node_modules/rxjs/src/internal/operators/delayWhen.ts", "node_modules/rxjs/src/internal/operators/delay.ts", "node_modules/rxjs/src/internal/operators/distinctUntilChanged.ts", "node_modules/rxjs/src/internal/operators/distinctUntilKeyChanged.ts", "node_modules/rxjs/src/internal/operators/throwIfEmpty.ts", "node_modules/rxjs/src/internal/operators/endWith.ts", "node_modules/rxjs/src/internal/operators/finalize.ts", "node_modules/rxjs/src/internal/operators/first.ts", "node_modules/rxjs/src/internal/operators/takeLast.ts", "node_modules/rxjs/src/internal/operators/merge.ts", "node_modules/rxjs/src/internal/operators/mergeWith.ts", "node_modules/rxjs/src/internal/operators/repeat.ts", "node_modules/rxjs/src/internal/operators/sample.ts", "node_modules/rxjs/src/internal/operators/scan.ts", "node_modules/rxjs/src/internal/operators/share.ts", "node_modules/rxjs/src/internal/operators/shareReplay.ts", "node_modules/rxjs/src/internal/operators/skip.ts", "node_modules/rxjs/src/internal/operators/skipUntil.ts", "node_modules/rxjs/src/internal/operators/startWith.ts", "node_modules/rxjs/src/internal/operators/switchMap.ts", "node_modules/rxjs/src/internal/operators/takeUntil.ts", "node_modules/rxjs/src/internal/operators/takeWhile.ts", "node_modules/rxjs/src/internal/operators/tap.ts", "node_modules/rxjs/src/internal/operators/throttle.ts", "node_modules/rxjs/src/internal/operators/throttleTime.ts", "node_modules/rxjs/src/internal/operators/withLatestFrom.ts", "node_modules/rxjs/src/internal/operators/zip.ts", "node_modules/rxjs/src/internal/operators/zipWith.ts", "src/templates/assets/javascripts/browser/document/index.ts", "src/templates/assets/javascripts/browser/element/_/index.ts", "src/templates/assets/javascripts/browser/element/focus/index.ts", "src/templates/assets/javascripts/browser/element/hover/index.ts", "src/templates/assets/javascripts/browser/element/offset/_/index.ts", "src/templates/assets/javascripts/browser/element/offset/content/index.ts", "src/templates/assets/javascripts/utilities/h/index.ts", "src/templates/assets/javascripts/utilities/round/index.ts", "src/templates/assets/javascripts/browser/script/index.ts", "src/templates/assets/javascripts/browser/element/size/_/index.ts", "src/templates/assets/javascripts/browser/element/size/content/index.ts", "src/templates/assets/javascripts/browser/element/visibility/index.ts", "src/templates/assets/javascripts/browser/toggle/index.ts", "src/templates/assets/javascripts/browser/keyboard/index.ts", "src/templates/assets/javascripts/browser/location/_/index.ts", "src/templates/assets/javascripts/browser/location/hash/index.ts", "src/templates/assets/javascripts/browser/media/index.ts", "src/templates/assets/javascripts/browser/request/index.ts", "src/templates/assets/javascripts/browser/viewport/offset/index.ts", "src/templates/assets/javascripts/browser/viewport/size/index.ts", "src/templates/assets/javascripts/browser/viewport/_/index.ts", "src/templates/assets/javascripts/browser/viewport/at/index.ts", "src/templates/assets/javascripts/browser/worker/index.ts", "src/templates/assets/javascripts/_/index.ts", "src/templates/assets/javascripts/components/_/index.ts", "src/templates/assets/javascripts/components/announce/index.ts", "src/templates/assets/javascripts/components/consent/index.ts", "src/templates/assets/javascripts/templates/tooltip/index.tsx", "src/templates/assets/javascripts/templates/annotation/index.tsx", "src/templates/assets/javascripts/templates/clipboard/index.tsx", "src/templates/assets/javascripts/templates/search/index.tsx", "src/templates/assets/javascripts/templates/source/index.tsx", "src/templates/assets/javascripts/templates/tabbed/index.tsx", "src/templates/assets/javascripts/templates/table/index.tsx", "src/templates/assets/javascripts/templates/version/index.tsx", "src/templates/assets/javascripts/components/tooltip/index.ts", "src/templates/assets/javascripts/components/content/annotation/_/index.ts", "src/templates/assets/javascripts/components/content/annotation/list/index.ts", "src/templates/assets/javascripts/components/content/annotation/block/index.ts", "src/templates/assets/javascripts/components/content/code/_/index.ts", "src/templates/assets/javascripts/components/content/details/index.ts", "src/templates/assets/javascripts/components/content/mermaid/index.css", "src/templates/assets/javascripts/components/content/mermaid/index.ts", "src/templates/assets/javascripts/components/content/table/index.ts", "src/templates/assets/javascripts/components/content/tabs/index.ts", "src/templates/assets/javascripts/components/content/_/index.ts", "src/templates/assets/javascripts/components/dialog/index.ts", "src/templates/assets/javascripts/components/header/_/index.ts", "src/templates/assets/javascripts/components/header/title/index.ts", "src/templates/assets/javascripts/components/main/index.ts", "src/templates/assets/javascripts/components/palette/index.ts", "src/templates/assets/javascripts/components/progress/index.ts", "src/templates/assets/javascripts/integrations/clipboard/index.ts", "src/templates/assets/javascripts/integrations/sitemap/index.ts", "src/templates/assets/javascripts/integrations/instant/index.ts", "src/templates/assets/javascripts/integrations/search/highlighter/index.ts", "src/templates/assets/javascripts/integrations/search/worker/message/index.ts", "src/templates/assets/javascripts/integrations/search/worker/_/index.ts", "src/templates/assets/javascripts/integrations/version/index.ts", "src/templates/assets/javascripts/components/search/query/index.ts", "src/templates/assets/javascripts/components/search/result/index.ts", "src/templates/assets/javascripts/components/search/share/index.ts", "src/templates/assets/javascripts/components/search/suggest/index.ts", "src/templates/assets/javascripts/components/search/_/index.ts", "src/templates/assets/javascripts/components/search/highlight/index.ts", "src/templates/assets/javascripts/components/sidebar/index.ts", "src/templates/assets/javascripts/components/source/facts/github/index.ts", "src/templates/assets/javascripts/components/source/facts/gitlab/index.ts", "src/templates/assets/javascripts/components/source/facts/_/index.ts", "src/templates/assets/javascripts/components/source/_/index.ts", "src/templates/assets/javascripts/components/tabs/index.ts", "src/templates/assets/javascripts/components/toc/index.ts", "src/templates/assets/javascripts/components/top/index.ts", "src/templates/assets/javascripts/patches/ellipsis/index.ts", "src/templates/assets/javascripts/patches/indeterminate/index.ts", "src/templates/assets/javascripts/patches/scrollfix/index.ts", "src/templates/assets/javascripts/patches/scrolllock/index.ts", "src/templates/assets/javascripts/polyfills/index.ts"],
+ "sourcesContent": ["(function (global, factory) {\n typeof exports === 'object' && typeof module !== 'undefined' ? factory() :\n typeof define === 'function' && define.amd ? define(factory) :\n (factory());\n}(this, (function () { 'use strict';\n\n /**\n * Applies the :focus-visible polyfill at the given scope.\n * A scope in this case is either the top-level Document or a Shadow Root.\n *\n * @param {(Document|ShadowRoot)} scope\n * @see https://github.com/WICG/focus-visible\n */\n function applyFocusVisiblePolyfill(scope) {\n var hadKeyboardEvent = true;\n var hadFocusVisibleRecently = false;\n var hadFocusVisibleRecentlyTimeout = null;\n\n var inputTypesAllowlist = {\n text: true,\n search: true,\n url: true,\n tel: true,\n email: true,\n password: true,\n number: true,\n date: true,\n month: true,\n week: true,\n time: true,\n datetime: true,\n 'datetime-local': true\n };\n\n /**\n * Helper function for legacy browsers and iframes which sometimes focus\n * elements like document, body, and non-interactive SVG.\n * @param {Element} el\n */\n function isValidFocusTarget(el) {\n if (\n el &&\n el !== document &&\n el.nodeName !== 'HTML' &&\n el.nodeName !== 'BODY' &&\n 'classList' in el &&\n 'contains' in el.classList\n ) {\n return true;\n }\n return false;\n }\n\n /**\n * Computes whether the given element should automatically trigger the\n * `focus-visible` class being added, i.e. whether it should always match\n * `:focus-visible` when focused.\n * @param {Element} el\n * @return {boolean}\n */\n function focusTriggersKeyboardModality(el) {\n var type = el.type;\n var tagName = el.tagName;\n\n if (tagName === 'INPUT' && inputTypesAllowlist[type] && !el.readOnly) {\n return true;\n }\n\n if (tagName === 'TEXTAREA' && !el.readOnly) {\n return true;\n }\n\n if (el.isContentEditable) {\n return true;\n }\n\n return false;\n }\n\n /**\n * Add the `focus-visible` class to the given element if it was not added by\n * the author.\n * @param {Element} el\n */\n function addFocusVisibleClass(el) {\n if (el.classList.contains('focus-visible')) {\n return;\n }\n el.classList.add('focus-visible');\n el.setAttribute('data-focus-visible-added', '');\n }\n\n /**\n * Remove the `focus-visible` class from the given element if it was not\n * originally added by the author.\n * @param {Element} el\n */\n function removeFocusVisibleClass(el) {\n if (!el.hasAttribute('data-focus-visible-added')) {\n return;\n }\n el.classList.remove('focus-visible');\n el.removeAttribute('data-focus-visible-added');\n }\n\n /**\n * If the most recent user interaction was via the keyboard;\n * and the key press did not include a meta, alt/option, or control key;\n * then the modality is keyboard. Otherwise, the modality is not keyboard.\n * Apply `focus-visible` to any current active element and keep track\n * of our keyboard modality state with `hadKeyboardEvent`.\n * @param {KeyboardEvent} e\n */\n function onKeyDown(e) {\n if (e.metaKey || e.altKey || e.ctrlKey) {\n return;\n }\n\n if (isValidFocusTarget(scope.activeElement)) {\n addFocusVisibleClass(scope.activeElement);\n }\n\n hadKeyboardEvent = true;\n }\n\n /**\n * If at any point a user clicks with a pointing device, ensure that we change\n * the modality away from keyboard.\n * This avoids the situation where a user presses a key on an already focused\n * element, and then clicks on a different element, focusing it with a\n * pointing device, while we still think we're in keyboard modality.\n * @param {Event} e\n */\n function onPointerDown(e) {\n hadKeyboardEvent = false;\n }\n\n /**\n * On `focus`, add the `focus-visible` class to the target if:\n * - the target received focus as a result of keyboard navigation, or\n * - the event target is an element that will likely require interaction\n * via the keyboard (e.g. a text box)\n * @param {Event} e\n */\n function onFocus(e) {\n // Prevent IE from focusing the document or HTML element.\n if (!isValidFocusTarget(e.target)) {\n return;\n }\n\n if (hadKeyboardEvent || focusTriggersKeyboardModality(e.target)) {\n addFocusVisibleClass(e.target);\n }\n }\n\n /**\n * On `blur`, remove the `focus-visible` class from the target.\n * @param {Event} e\n */\n function onBlur(e) {\n if (!isValidFocusTarget(e.target)) {\n return;\n }\n\n if (\n e.target.classList.contains('focus-visible') ||\n e.target.hasAttribute('data-focus-visible-added')\n ) {\n // To detect a tab/window switch, we look for a blur event followed\n // rapidly by a visibility change.\n // If we don't see a visibility change within 100ms, it's probably a\n // regular focus change.\n hadFocusVisibleRecently = true;\n window.clearTimeout(hadFocusVisibleRecentlyTimeout);\n hadFocusVisibleRecentlyTimeout = window.setTimeout(function() {\n hadFocusVisibleRecently = false;\n }, 100);\n removeFocusVisibleClass(e.target);\n }\n }\n\n /**\n * If the user changes tabs, keep track of whether or not the previously\n * focused element had .focus-visible.\n * @param {Event} e\n */\n function onVisibilityChange(e) {\n if (document.visibilityState === 'hidden') {\n // If the tab becomes active again, the browser will handle calling focus\n // on the element (Safari actually calls it twice).\n // If this tab change caused a blur on an element with focus-visible,\n // re-apply the class when the user switches back to the tab.\n if (hadFocusVisibleRecently) {\n hadKeyboardEvent = true;\n }\n addInitialPointerMoveListeners();\n }\n }\n\n /**\n * Add a group of listeners to detect usage of any pointing devices.\n * These listeners will be added when the polyfill first loads, and anytime\n * the window is blurred, so that they are active when the window regains\n * focus.\n */\n function addInitialPointerMoveListeners() {\n document.addEventListener('mousemove', onInitialPointerMove);\n document.addEventListener('mousedown', onInitialPointerMove);\n document.addEventListener('mouseup', onInitialPointerMove);\n document.addEventListener('pointermove', onInitialPointerMove);\n document.addEventListener('pointerdown', onInitialPointerMove);\n document.addEventListener('pointerup', onInitialPointerMove);\n document.addEventListener('touchmove', onInitialPointerMove);\n document.addEventListener('touchstart', onInitialPointerMove);\n document.addEventListener('touchend', onInitialPointerMove);\n }\n\n function removeInitialPointerMoveListeners() {\n document.removeEventListener('mousemove', onInitialPointerMove);\n document.removeEventListener('mousedown', onInitialPointerMove);\n document.removeEventListener('mouseup', onInitialPointerMove);\n document.removeEventListener('pointermove', onInitialPointerMove);\n document.removeEventListener('pointerdown', onInitialPointerMove);\n document.removeEventListener('pointerup', onInitialPointerMove);\n document.removeEventListener('touchmove', onInitialPointerMove);\n document.removeEventListener('touchstart', onInitialPointerMove);\n document.removeEventListener('touchend', onInitialPointerMove);\n }\n\n /**\n * When the polfyill first loads, assume the user is in keyboard modality.\n * If any event is received from a pointing device (e.g. mouse, pointer,\n * touch), turn off keyboard modality.\n * This accounts for situations where focus enters the page from the URL bar.\n * @param {Event} e\n */\n function onInitialPointerMove(e) {\n // Work around a Safari quirk that fires a mousemove on whenever the\n // window blurs, even if you're tabbing out of the page. \u00AF\\_(\u30C4)_/\u00AF\n if (e.target.nodeName && e.target.nodeName.toLowerCase() === 'html') {\n return;\n }\n\n hadKeyboardEvent = false;\n removeInitialPointerMoveListeners();\n }\n\n // For some kinds of state, we are interested in changes at the global scope\n // only. For example, global pointer input, global key presses and global\n // visibility change should affect the state at every scope:\n document.addEventListener('keydown', onKeyDown, true);\n document.addEventListener('mousedown', onPointerDown, true);\n document.addEventListener('pointerdown', onPointerDown, true);\n document.addEventListener('touchstart', onPointerDown, true);\n document.addEventListener('visibilitychange', onVisibilityChange, true);\n\n addInitialPointerMoveListeners();\n\n // For focus and blur, we specifically care about state changes in the local\n // scope. This is because focus / blur events that originate from within a\n // shadow root are not re-dispatched from the host element if it was already\n // the active element in its own scope:\n scope.addEventListener('focus', onFocus, true);\n scope.addEventListener('blur', onBlur, true);\n\n // We detect that a node is a ShadowRoot by ensuring that it is a\n // DocumentFragment and also has a host property. This check covers native\n // implementation and polyfill implementation transparently. If we only cared\n // about the native implementation, we could just check if the scope was\n // an instance of a ShadowRoot.\n if (scope.nodeType === Node.DOCUMENT_FRAGMENT_NODE && scope.host) {\n // Since a ShadowRoot is a special kind of DocumentFragment, it does not\n // have a root element to add a class to. So, we add this attribute to the\n // host element instead:\n scope.host.setAttribute('data-js-focus-visible', '');\n } else if (scope.nodeType === Node.DOCUMENT_NODE) {\n document.documentElement.classList.add('js-focus-visible');\n document.documentElement.setAttribute('data-js-focus-visible', '');\n }\n }\n\n // It is important to wrap all references to global window and document in\n // these checks to support server-side rendering use cases\n // @see https://github.com/WICG/focus-visible/issues/199\n if (typeof window !== 'undefined' && typeof document !== 'undefined') {\n // Make the polyfill helper globally available. This can be used as a signal\n // to interested libraries that wish to coordinate with the polyfill for e.g.,\n // applying the polyfill to a shadow root:\n window.applyFocusVisiblePolyfill = applyFocusVisiblePolyfill;\n\n // Notify interested libraries of the polyfill's presence, in case the\n // polyfill was loaded lazily:\n var event;\n\n try {\n event = new CustomEvent('focus-visible-polyfill-ready');\n } catch (error) {\n // IE11 does not support using CustomEvent as a constructor directly:\n event = document.createEvent('CustomEvent');\n event.initCustomEvent('focus-visible-polyfill-ready', false, false, {});\n }\n\n window.dispatchEvent(event);\n }\n\n if (typeof document !== 'undefined') {\n // Apply the polyfill to the global document, so that no JavaScript\n // coordination is required to use the polyfill in the top-level document:\n applyFocusVisiblePolyfill(document);\n }\n\n})));\n", "/*!\n * clipboard.js v2.0.11\n * https://clipboardjs.com/\n *\n * Licensed MIT \u00A9 Zeno Rocha\n */\n(function webpackUniversalModuleDefinition(root, factory) {\n\tif(typeof exports === 'object' && typeof module === 'object')\n\t\tmodule.exports = factory();\n\telse if(typeof define === 'function' && define.amd)\n\t\tdefine([], factory);\n\telse if(typeof exports === 'object')\n\t\texports[\"ClipboardJS\"] = factory();\n\telse\n\t\troot[\"ClipboardJS\"] = factory();\n})(this, function() {\nreturn /******/ (function() { // webpackBootstrap\n/******/ \tvar __webpack_modules__ = ({\n\n/***/ 686:\n/***/ (function(__unused_webpack_module, __webpack_exports__, __webpack_require__) {\n\n\"use strict\";\n\n// EXPORTS\n__webpack_require__.d(__webpack_exports__, {\n \"default\": function() { return /* binding */ clipboard; }\n});\n\n// EXTERNAL MODULE: ./node_modules/tiny-emitter/index.js\nvar tiny_emitter = __webpack_require__(279);\nvar tiny_emitter_default = /*#__PURE__*/__webpack_require__.n(tiny_emitter);\n// EXTERNAL MODULE: ./node_modules/good-listener/src/listen.js\nvar listen = __webpack_require__(370);\nvar listen_default = /*#__PURE__*/__webpack_require__.n(listen);\n// EXTERNAL MODULE: ./node_modules/select/src/select.js\nvar src_select = __webpack_require__(817);\nvar select_default = /*#__PURE__*/__webpack_require__.n(src_select);\n;// CONCATENATED MODULE: ./src/common/command.js\n/**\n * Executes a given operation type.\n * @param {String} type\n * @return {Boolean}\n */\nfunction command(type) {\n try {\n return document.execCommand(type);\n } catch (err) {\n return false;\n }\n}\n;// CONCATENATED MODULE: ./src/actions/cut.js\n\n\n/**\n * Cut action wrapper.\n * @param {String|HTMLElement} target\n * @return {String}\n */\n\nvar ClipboardActionCut = function ClipboardActionCut(target) {\n var selectedText = select_default()(target);\n command('cut');\n return selectedText;\n};\n\n/* harmony default export */ var actions_cut = (ClipboardActionCut);\n;// CONCATENATED MODULE: ./src/common/create-fake-element.js\n/**\n * Creates a fake textarea element with a value.\n * @param {String} value\n * @return {HTMLElement}\n */\nfunction createFakeElement(value) {\n var isRTL = document.documentElement.getAttribute('dir') === 'rtl';\n var fakeElement = document.createElement('textarea'); // Prevent zooming on iOS\n\n fakeElement.style.fontSize = '12pt'; // Reset box model\n\n fakeElement.style.border = '0';\n fakeElement.style.padding = '0';\n fakeElement.style.margin = '0'; // Move element out of screen horizontally\n\n fakeElement.style.position = 'absolute';\n fakeElement.style[isRTL ? 'right' : 'left'] = '-9999px'; // Move element to the same position vertically\n\n var yPosition = window.pageYOffset || document.documentElement.scrollTop;\n fakeElement.style.top = \"\".concat(yPosition, \"px\");\n fakeElement.setAttribute('readonly', '');\n fakeElement.value = value;\n return fakeElement;\n}\n;// CONCATENATED MODULE: ./src/actions/copy.js\n\n\n\n/**\n * Create fake copy action wrapper using a fake element.\n * @param {String} target\n * @param {Object} options\n * @return {String}\n */\n\nvar fakeCopyAction = function fakeCopyAction(value, options) {\n var fakeElement = createFakeElement(value);\n options.container.appendChild(fakeElement);\n var selectedText = select_default()(fakeElement);\n command('copy');\n fakeElement.remove();\n return selectedText;\n};\n/**\n * Copy action wrapper.\n * @param {String|HTMLElement} target\n * @param {Object} options\n * @return {String}\n */\n\n\nvar ClipboardActionCopy = function ClipboardActionCopy(target) {\n var options = arguments.length > 1 && arguments[1] !== undefined ? arguments[1] : {\n container: document.body\n };\n var selectedText = '';\n\n if (typeof target === 'string') {\n selectedText = fakeCopyAction(target, options);\n } else if (target instanceof HTMLInputElement && !['text', 'search', 'url', 'tel', 'password'].includes(target === null || target === void 0 ? void 0 : target.type)) {\n // If input type doesn't support `setSelectionRange`. Simulate it. https://developer.mozilla.org/en-US/docs/Web/API/HTMLInputElement/setSelectionRange\n selectedText = fakeCopyAction(target.value, options);\n } else {\n selectedText = select_default()(target);\n command('copy');\n }\n\n return selectedText;\n};\n\n/* harmony default export */ var actions_copy = (ClipboardActionCopy);\n;// CONCATENATED MODULE: ./src/actions/default.js\nfunction _typeof(obj) { \"@babel/helpers - typeof\"; if (typeof Symbol === \"function\" && typeof Symbol.iterator === \"symbol\") { _typeof = function _typeof(obj) { return typeof obj; }; } else { _typeof = function _typeof(obj) { return obj && typeof Symbol === \"function\" && obj.constructor === Symbol && obj !== Symbol.prototype ? \"symbol\" : typeof obj; }; } return _typeof(obj); }\n\n\n\n/**\n * Inner function which performs selection from either `text` or `target`\n * properties and then executes copy or cut operations.\n * @param {Object} options\n */\n\nvar ClipboardActionDefault = function ClipboardActionDefault() {\n var options = arguments.length > 0 && arguments[0] !== undefined ? arguments[0] : {};\n // Defines base properties passed from constructor.\n var _options$action = options.action,\n action = _options$action === void 0 ? 'copy' : _options$action,\n container = options.container,\n target = options.target,\n text = options.text; // Sets the `action` to be performed which can be either 'copy' or 'cut'.\n\n if (action !== 'copy' && action !== 'cut') {\n throw new Error('Invalid \"action\" value, use either \"copy\" or \"cut\"');\n } // Sets the `target` property using an element that will be have its content copied.\n\n\n if (target !== undefined) {\n if (target && _typeof(target) === 'object' && target.nodeType === 1) {\n if (action === 'copy' && target.hasAttribute('disabled')) {\n throw new Error('Invalid \"target\" attribute. Please use \"readonly\" instead of \"disabled\" attribute');\n }\n\n if (action === 'cut' && (target.hasAttribute('readonly') || target.hasAttribute('disabled'))) {\n throw new Error('Invalid \"target\" attribute. You can\\'t cut text from elements with \"readonly\" or \"disabled\" attributes');\n }\n } else {\n throw new Error('Invalid \"target\" value, use a valid Element');\n }\n } // Define selection strategy based on `text` property.\n\n\n if (text) {\n return actions_copy(text, {\n container: container\n });\n } // Defines which selection strategy based on `target` property.\n\n\n if (target) {\n return action === 'cut' ? actions_cut(target) : actions_copy(target, {\n container: container\n });\n }\n};\n\n/* harmony default export */ var actions_default = (ClipboardActionDefault);\n;// CONCATENATED MODULE: ./src/clipboard.js\nfunction clipboard_typeof(obj) { \"@babel/helpers - typeof\"; if (typeof Symbol === \"function\" && typeof Symbol.iterator === \"symbol\") { clipboard_typeof = function _typeof(obj) { return typeof obj; }; } else { clipboard_typeof = function _typeof(obj) { return obj && typeof Symbol === \"function\" && obj.constructor === Symbol && obj !== Symbol.prototype ? \"symbol\" : typeof obj; }; } return clipboard_typeof(obj); }\n\nfunction _classCallCheck(instance, Constructor) { if (!(instance instanceof Constructor)) { throw new TypeError(\"Cannot call a class as a function\"); } }\n\nfunction _defineProperties(target, props) { for (var i = 0; i < props.length; i++) { var descriptor = props[i]; descriptor.enumerable = descriptor.enumerable || false; descriptor.configurable = true; if (\"value\" in descriptor) descriptor.writable = true; Object.defineProperty(target, descriptor.key, descriptor); } }\n\nfunction _createClass(Constructor, protoProps, staticProps) { if (protoProps) _defineProperties(Constructor.prototype, protoProps); if (staticProps) _defineProperties(Constructor, staticProps); return Constructor; }\n\nfunction _inherits(subClass, superClass) { if (typeof superClass !== \"function\" && superClass !== null) { throw new TypeError(\"Super expression must either be null or a function\"); } subClass.prototype = Object.create(superClass && superClass.prototype, { constructor: { value: subClass, writable: true, configurable: true } }); if (superClass) _setPrototypeOf(subClass, superClass); }\n\nfunction _setPrototypeOf(o, p) { _setPrototypeOf = Object.setPrototypeOf || function _setPrototypeOf(o, p) { o.__proto__ = p; return o; }; return _setPrototypeOf(o, p); }\n\nfunction _createSuper(Derived) { var hasNativeReflectConstruct = _isNativeReflectConstruct(); return function _createSuperInternal() { var Super = _getPrototypeOf(Derived), result; if (hasNativeReflectConstruct) { var NewTarget = _getPrototypeOf(this).constructor; result = Reflect.construct(Super, arguments, NewTarget); } else { result = Super.apply(this, arguments); } return _possibleConstructorReturn(this, result); }; }\n\nfunction _possibleConstructorReturn(self, call) { if (call && (clipboard_typeof(call) === \"object\" || typeof call === \"function\")) { return call; } return _assertThisInitialized(self); }\n\nfunction _assertThisInitialized(self) { if (self === void 0) { throw new ReferenceError(\"this hasn't been initialised - super() hasn't been called\"); } return self; }\n\nfunction _isNativeReflectConstruct() { if (typeof Reflect === \"undefined\" || !Reflect.construct) return false; if (Reflect.construct.sham) return false; if (typeof Proxy === \"function\") return true; try { Date.prototype.toString.call(Reflect.construct(Date, [], function () {})); return true; } catch (e) { return false; } }\n\nfunction _getPrototypeOf(o) { _getPrototypeOf = Object.setPrototypeOf ? Object.getPrototypeOf : function _getPrototypeOf(o) { return o.__proto__ || Object.getPrototypeOf(o); }; return _getPrototypeOf(o); }\n\n\n\n\n\n\n/**\n * Helper function to retrieve attribute value.\n * @param {String} suffix\n * @param {Element} element\n */\n\nfunction getAttributeValue(suffix, element) {\n var attribute = \"data-clipboard-\".concat(suffix);\n\n if (!element.hasAttribute(attribute)) {\n return;\n }\n\n return element.getAttribute(attribute);\n}\n/**\n * Base class which takes one or more elements, adds event listeners to them,\n * and instantiates a new `ClipboardAction` on each click.\n */\n\n\nvar Clipboard = /*#__PURE__*/function (_Emitter) {\n _inherits(Clipboard, _Emitter);\n\n var _super = _createSuper(Clipboard);\n\n /**\n * @param {String|HTMLElement|HTMLCollection|NodeList} trigger\n * @param {Object} options\n */\n function Clipboard(trigger, options) {\n var _this;\n\n _classCallCheck(this, Clipboard);\n\n _this = _super.call(this);\n\n _this.resolveOptions(options);\n\n _this.listenClick(trigger);\n\n return _this;\n }\n /**\n * Defines if attributes would be resolved using internal setter functions\n * or custom functions that were passed in the constructor.\n * @param {Object} options\n */\n\n\n _createClass(Clipboard, [{\n key: \"resolveOptions\",\n value: function resolveOptions() {\n var options = arguments.length > 0 && arguments[0] !== undefined ? arguments[0] : {};\n this.action = typeof options.action === 'function' ? options.action : this.defaultAction;\n this.target = typeof options.target === 'function' ? options.target : this.defaultTarget;\n this.text = typeof options.text === 'function' ? options.text : this.defaultText;\n this.container = clipboard_typeof(options.container) === 'object' ? options.container : document.body;\n }\n /**\n * Adds a click event listener to the passed trigger.\n * @param {String|HTMLElement|HTMLCollection|NodeList} trigger\n */\n\n }, {\n key: \"listenClick\",\n value: function listenClick(trigger) {\n var _this2 = this;\n\n this.listener = listen_default()(trigger, 'click', function (e) {\n return _this2.onClick(e);\n });\n }\n /**\n * Defines a new `ClipboardAction` on each click event.\n * @param {Event} e\n */\n\n }, {\n key: \"onClick\",\n value: function onClick(e) {\n var trigger = e.delegateTarget || e.currentTarget;\n var action = this.action(trigger) || 'copy';\n var text = actions_default({\n action: action,\n container: this.container,\n target: this.target(trigger),\n text: this.text(trigger)\n }); // Fires an event based on the copy operation result.\n\n this.emit(text ? 'success' : 'error', {\n action: action,\n text: text,\n trigger: trigger,\n clearSelection: function clearSelection() {\n if (trigger) {\n trigger.focus();\n }\n\n window.getSelection().removeAllRanges();\n }\n });\n }\n /**\n * Default `action` lookup function.\n * @param {Element} trigger\n */\n\n }, {\n key: \"defaultAction\",\n value: function defaultAction(trigger) {\n return getAttributeValue('action', trigger);\n }\n /**\n * Default `target` lookup function.\n * @param {Element} trigger\n */\n\n }, {\n key: \"defaultTarget\",\n value: function defaultTarget(trigger) {\n var selector = getAttributeValue('target', trigger);\n\n if (selector) {\n return document.querySelector(selector);\n }\n }\n /**\n * Allow fire programmatically a copy action\n * @param {String|HTMLElement} target\n * @param {Object} options\n * @returns Text copied.\n */\n\n }, {\n key: \"defaultText\",\n\n /**\n * Default `text` lookup function.\n * @param {Element} trigger\n */\n value: function defaultText(trigger) {\n return getAttributeValue('text', trigger);\n }\n /**\n * Destroy lifecycle.\n */\n\n }, {\n key: \"destroy\",\n value: function destroy() {\n this.listener.destroy();\n }\n }], [{\n key: \"copy\",\n value: function copy(target) {\n var options = arguments.length > 1 && arguments[1] !== undefined ? arguments[1] : {\n container: document.body\n };\n return actions_copy(target, options);\n }\n /**\n * Allow fire programmatically a cut action\n * @param {String|HTMLElement} target\n * @returns Text cutted.\n */\n\n }, {\n key: \"cut\",\n value: function cut(target) {\n return actions_cut(target);\n }\n /**\n * Returns the support of the given action, or all actions if no action is\n * given.\n * @param {String} [action]\n */\n\n }, {\n key: \"isSupported\",\n value: function isSupported() {\n var action = arguments.length > 0 && arguments[0] !== undefined ? arguments[0] : ['copy', 'cut'];\n var actions = typeof action === 'string' ? [action] : action;\n var support = !!document.queryCommandSupported;\n actions.forEach(function (action) {\n support = support && !!document.queryCommandSupported(action);\n });\n return support;\n }\n }]);\n\n return Clipboard;\n}((tiny_emitter_default()));\n\n/* harmony default export */ var clipboard = (Clipboard);\n\n/***/ }),\n\n/***/ 828:\n/***/ (function(module) {\n\nvar DOCUMENT_NODE_TYPE = 9;\n\n/**\n * A polyfill for Element.matches()\n */\nif (typeof Element !== 'undefined' && !Element.prototype.matches) {\n var proto = Element.prototype;\n\n proto.matches = proto.matchesSelector ||\n proto.mozMatchesSelector ||\n proto.msMatchesSelector ||\n proto.oMatchesSelector ||\n proto.webkitMatchesSelector;\n}\n\n/**\n * Finds the closest parent that matches a selector.\n *\n * @param {Element} element\n * @param {String} selector\n * @return {Function}\n */\nfunction closest (element, selector) {\n while (element && element.nodeType !== DOCUMENT_NODE_TYPE) {\n if (typeof element.matches === 'function' &&\n element.matches(selector)) {\n return element;\n }\n element = element.parentNode;\n }\n}\n\nmodule.exports = closest;\n\n\n/***/ }),\n\n/***/ 438:\n/***/ (function(module, __unused_webpack_exports, __webpack_require__) {\n\nvar closest = __webpack_require__(828);\n\n/**\n * Delegates event to a selector.\n *\n * @param {Element} element\n * @param {String} selector\n * @param {String} type\n * @param {Function} callback\n * @param {Boolean} useCapture\n * @return {Object}\n */\nfunction _delegate(element, selector, type, callback, useCapture) {\n var listenerFn = listener.apply(this, arguments);\n\n element.addEventListener(type, listenerFn, useCapture);\n\n return {\n destroy: function() {\n element.removeEventListener(type, listenerFn, useCapture);\n }\n }\n}\n\n/**\n * Delegates event to a selector.\n *\n * @param {Element|String|Array} [elements]\n * @param {String} selector\n * @param {String} type\n * @param {Function} callback\n * @param {Boolean} useCapture\n * @return {Object}\n */\nfunction delegate(elements, selector, type, callback, useCapture) {\n // Handle the regular Element usage\n if (typeof elements.addEventListener === 'function') {\n return _delegate.apply(null, arguments);\n }\n\n // Handle Element-less usage, it defaults to global delegation\n if (typeof type === 'function') {\n // Use `document` as the first parameter, then apply arguments\n // This is a short way to .unshift `arguments` without running into deoptimizations\n return _delegate.bind(null, document).apply(null, arguments);\n }\n\n // Handle Selector-based usage\n if (typeof elements === 'string') {\n elements = document.querySelectorAll(elements);\n }\n\n // Handle Array-like based usage\n return Array.prototype.map.call(elements, function (element) {\n return _delegate(element, selector, type, callback, useCapture);\n });\n}\n\n/**\n * Finds closest match and invokes callback.\n *\n * @param {Element} element\n * @param {String} selector\n * @param {String} type\n * @param {Function} callback\n * @return {Function}\n */\nfunction listener(element, selector, type, callback) {\n return function(e) {\n e.delegateTarget = closest(e.target, selector);\n\n if (e.delegateTarget) {\n callback.call(element, e);\n }\n }\n}\n\nmodule.exports = delegate;\n\n\n/***/ }),\n\n/***/ 879:\n/***/ (function(__unused_webpack_module, exports) {\n\n/**\n * Check if argument is a HTML element.\n *\n * @param {Object} value\n * @return {Boolean}\n */\nexports.node = function(value) {\n return value !== undefined\n && value instanceof HTMLElement\n && value.nodeType === 1;\n};\n\n/**\n * Check if argument is a list of HTML elements.\n *\n * @param {Object} value\n * @return {Boolean}\n */\nexports.nodeList = function(value) {\n var type = Object.prototype.toString.call(value);\n\n return value !== undefined\n && (type === '[object NodeList]' || type === '[object HTMLCollection]')\n && ('length' in value)\n && (value.length === 0 || exports.node(value[0]));\n};\n\n/**\n * Check if argument is a string.\n *\n * @param {Object} value\n * @return {Boolean}\n */\nexports.string = function(value) {\n return typeof value === 'string'\n || value instanceof String;\n};\n\n/**\n * Check if argument is a function.\n *\n * @param {Object} value\n * @return {Boolean}\n */\nexports.fn = function(value) {\n var type = Object.prototype.toString.call(value);\n\n return type === '[object Function]';\n};\n\n\n/***/ }),\n\n/***/ 370:\n/***/ (function(module, __unused_webpack_exports, __webpack_require__) {\n\nvar is = __webpack_require__(879);\nvar delegate = __webpack_require__(438);\n\n/**\n * Validates all params and calls the right\n * listener function based on its target type.\n *\n * @param {String|HTMLElement|HTMLCollection|NodeList} target\n * @param {String} type\n * @param {Function} callback\n * @return {Object}\n */\nfunction listen(target, type, callback) {\n if (!target && !type && !callback) {\n throw new Error('Missing required arguments');\n }\n\n if (!is.string(type)) {\n throw new TypeError('Second argument must be a String');\n }\n\n if (!is.fn(callback)) {\n throw new TypeError('Third argument must be a Function');\n }\n\n if (is.node(target)) {\n return listenNode(target, type, callback);\n }\n else if (is.nodeList(target)) {\n return listenNodeList(target, type, callback);\n }\n else if (is.string(target)) {\n return listenSelector(target, type, callback);\n }\n else {\n throw new TypeError('First argument must be a String, HTMLElement, HTMLCollection, or NodeList');\n }\n}\n\n/**\n * Adds an event listener to a HTML element\n * and returns a remove listener function.\n *\n * @param {HTMLElement} node\n * @param {String} type\n * @param {Function} callback\n * @return {Object}\n */\nfunction listenNode(node, type, callback) {\n node.addEventListener(type, callback);\n\n return {\n destroy: function() {\n node.removeEventListener(type, callback);\n }\n }\n}\n\n/**\n * Add an event listener to a list of HTML elements\n * and returns a remove listener function.\n *\n * @param {NodeList|HTMLCollection} nodeList\n * @param {String} type\n * @param {Function} callback\n * @return {Object}\n */\nfunction listenNodeList(nodeList, type, callback) {\n Array.prototype.forEach.call(nodeList, function(node) {\n node.addEventListener(type, callback);\n });\n\n return {\n destroy: function() {\n Array.prototype.forEach.call(nodeList, function(node) {\n node.removeEventListener(type, callback);\n });\n }\n }\n}\n\n/**\n * Add an event listener to a selector\n * and returns a remove listener function.\n *\n * @param {String} selector\n * @param {String} type\n * @param {Function} callback\n * @return {Object}\n */\nfunction listenSelector(selector, type, callback) {\n return delegate(document.body, selector, type, callback);\n}\n\nmodule.exports = listen;\n\n\n/***/ }),\n\n/***/ 817:\n/***/ (function(module) {\n\nfunction select(element) {\n var selectedText;\n\n if (element.nodeName === 'SELECT') {\n element.focus();\n\n selectedText = element.value;\n }\n else if (element.nodeName === 'INPUT' || element.nodeName === 'TEXTAREA') {\n var isReadOnly = element.hasAttribute('readonly');\n\n if (!isReadOnly) {\n element.setAttribute('readonly', '');\n }\n\n element.select();\n element.setSelectionRange(0, element.value.length);\n\n if (!isReadOnly) {\n element.removeAttribute('readonly');\n }\n\n selectedText = element.value;\n }\n else {\n if (element.hasAttribute('contenteditable')) {\n element.focus();\n }\n\n var selection = window.getSelection();\n var range = document.createRange();\n\n range.selectNodeContents(element);\n selection.removeAllRanges();\n selection.addRange(range);\n\n selectedText = selection.toString();\n }\n\n return selectedText;\n}\n\nmodule.exports = select;\n\n\n/***/ }),\n\n/***/ 279:\n/***/ (function(module) {\n\nfunction E () {\n // Keep this empty so it's easier to inherit from\n // (via https://github.com/lipsmack from https://github.com/scottcorgan/tiny-emitter/issues/3)\n}\n\nE.prototype = {\n on: function (name, callback, ctx) {\n var e = this.e || (this.e = {});\n\n (e[name] || (e[name] = [])).push({\n fn: callback,\n ctx: ctx\n });\n\n return this;\n },\n\n once: function (name, callback, ctx) {\n var self = this;\n function listener () {\n self.off(name, listener);\n callback.apply(ctx, arguments);\n };\n\n listener._ = callback\n return this.on(name, listener, ctx);\n },\n\n emit: function (name) {\n var data = [].slice.call(arguments, 1);\n var evtArr = ((this.e || (this.e = {}))[name] || []).slice();\n var i = 0;\n var len = evtArr.length;\n\n for (i; i < len; i++) {\n evtArr[i].fn.apply(evtArr[i].ctx, data);\n }\n\n return this;\n },\n\n off: function (name, callback) {\n var e = this.e || (this.e = {});\n var evts = e[name];\n var liveEvents = [];\n\n if (evts && callback) {\n for (var i = 0, len = evts.length; i < len; i++) {\n if (evts[i].fn !== callback && evts[i].fn._ !== callback)\n liveEvents.push(evts[i]);\n }\n }\n\n // Remove event from queue to prevent memory leak\n // Suggested by https://github.com/lazd\n // Ref: https://github.com/scottcorgan/tiny-emitter/commit/c6ebfaa9bc973b33d110a84a307742b7cf94c953#commitcomment-5024910\n\n (liveEvents.length)\n ? e[name] = liveEvents\n : delete e[name];\n\n return this;\n }\n};\n\nmodule.exports = E;\nmodule.exports.TinyEmitter = E;\n\n\n/***/ })\n\n/******/ \t});\n/************************************************************************/\n/******/ \t// The module cache\n/******/ \tvar __webpack_module_cache__ = {};\n/******/ \t\n/******/ \t// The require function\n/******/ \tfunction __webpack_require__(moduleId) {\n/******/ \t\t// Check if module is in cache\n/******/ \t\tif(__webpack_module_cache__[moduleId]) {\n/******/ \t\t\treturn __webpack_module_cache__[moduleId].exports;\n/******/ \t\t}\n/******/ \t\t// Create a new module (and put it into the cache)\n/******/ \t\tvar module = __webpack_module_cache__[moduleId] = {\n/******/ \t\t\t// no module.id needed\n/******/ \t\t\t// no module.loaded needed\n/******/ \t\t\texports: {}\n/******/ \t\t};\n/******/ \t\n/******/ \t\t// Execute the module function\n/******/ \t\t__webpack_modules__[moduleId](module, module.exports, __webpack_require__);\n/******/ \t\n/******/ \t\t// Return the exports of the module\n/******/ \t\treturn module.exports;\n/******/ \t}\n/******/ \t\n/************************************************************************/\n/******/ \t/* webpack/runtime/compat get default export */\n/******/ \t!function() {\n/******/ \t\t// getDefaultExport function for compatibility with non-harmony modules\n/******/ \t\t__webpack_require__.n = function(module) {\n/******/ \t\t\tvar getter = module && module.__esModule ?\n/******/ \t\t\t\tfunction() { return module['default']; } :\n/******/ \t\t\t\tfunction() { return module; };\n/******/ \t\t\t__webpack_require__.d(getter, { a: getter });\n/******/ \t\t\treturn getter;\n/******/ \t\t};\n/******/ \t}();\n/******/ \t\n/******/ \t/* webpack/runtime/define property getters */\n/******/ \t!function() {\n/******/ \t\t// define getter functions for harmony exports\n/******/ \t\t__webpack_require__.d = function(exports, definition) {\n/******/ \t\t\tfor(var key in definition) {\n/******/ \t\t\t\tif(__webpack_require__.o(definition, key) && !__webpack_require__.o(exports, key)) {\n/******/ \t\t\t\t\tObject.defineProperty(exports, key, { enumerable: true, get: definition[key] });\n/******/ \t\t\t\t}\n/******/ \t\t\t}\n/******/ \t\t};\n/******/ \t}();\n/******/ \t\n/******/ \t/* webpack/runtime/hasOwnProperty shorthand */\n/******/ \t!function() {\n/******/ \t\t__webpack_require__.o = function(obj, prop) { return Object.prototype.hasOwnProperty.call(obj, prop); }\n/******/ \t}();\n/******/ \t\n/************************************************************************/\n/******/ \t// module exports must be returned from runtime so entry inlining is disabled\n/******/ \t// startup\n/******/ \t// Load entry module and return exports\n/******/ \treturn __webpack_require__(686);\n/******/ })()\n.default;\n});", "/*!\n * escape-html\n * Copyright(c) 2012-2013 TJ Holowaychuk\n * Copyright(c) 2015 Andreas Lubbe\n * Copyright(c) 2015 Tiancheng \"Timothy\" Gu\n * MIT Licensed\n */\n\n'use strict';\n\n/**\n * Module variables.\n * @private\n */\n\nvar matchHtmlRegExp = /[\"'&<>]/;\n\n/**\n * Module exports.\n * @public\n */\n\nmodule.exports = escapeHtml;\n\n/**\n * Escape special characters in the given string of html.\n *\n * @param {string} string The string to escape for inserting into HTML\n * @return {string}\n * @public\n */\n\nfunction escapeHtml(string) {\n var str = '' + string;\n var match = matchHtmlRegExp.exec(str);\n\n if (!match) {\n return str;\n }\n\n var escape;\n var html = '';\n var index = 0;\n var lastIndex = 0;\n\n for (index = match.index; index < str.length; index++) {\n switch (str.charCodeAt(index)) {\n case 34: // \"\n escape = '"';\n break;\n case 38: // &\n escape = '&';\n break;\n case 39: // '\n escape = ''';\n break;\n case 60: // <\n escape = '<';\n break;\n case 62: // >\n escape = '>';\n break;\n default:\n continue;\n }\n\n if (lastIndex !== index) {\n html += str.substring(lastIndex, index);\n }\n\n lastIndex = index + 1;\n html += escape;\n }\n\n return lastIndex !== index\n ? html + str.substring(lastIndex, index)\n : html;\n}\n", "/*\n * Copyright (c) 2016-2024 Martin Donath \n *\n * Permission is hereby granted, free of charge, to any person obtaining a copy\n * of this software and associated documentation files (the \"Software\"), to\n * deal in the Software without restriction, including without limitation the\n * rights to use, copy, modify, merge, publish, distribute, sublicense, and/or\n * sell copies of the Software, and to permit persons to whom the Software is\n * furnished to do so, subject to the following conditions:\n *\n * The above copyright notice and this permission notice shall be included in\n * all copies or substantial portions of the Software.\n *\n * THE SOFTWARE IS PROVIDED \"AS IS\", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR\n * IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY,\n * FITNESS FOR A PARTICULAR PURPOSE AND NON-INFRINGEMENT. IN NO EVENT SHALL THE\n * AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER\n * LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING\n * FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS\n * IN THE SOFTWARE.\n */\n\nimport \"focus-visible\"\n\nimport {\n EMPTY,\n NEVER,\n Observable,\n Subject,\n defer,\n delay,\n filter,\n map,\n merge,\n mergeWith,\n shareReplay,\n switchMap\n} from \"rxjs\"\n\nimport { configuration, feature } from \"./_\"\nimport {\n at,\n getActiveElement,\n getOptionalElement,\n requestJSON,\n setLocation,\n setToggle,\n watchDocument,\n watchKeyboard,\n watchLocation,\n watchLocationTarget,\n watchMedia,\n watchPrint,\n watchScript,\n watchViewport\n} from \"./browser\"\nimport {\n getComponentElement,\n getComponentElements,\n mountAnnounce,\n mountBackToTop,\n mountConsent,\n mountContent,\n mountDialog,\n mountHeader,\n mountHeaderTitle,\n mountPalette,\n mountProgress,\n mountSearch,\n mountSearchHiglight,\n mountSidebar,\n mountSource,\n mountTableOfContents,\n mountTabs,\n watchHeader,\n watchMain\n} from \"./components\"\nimport {\n SearchIndex,\n setupClipboardJS,\n setupInstantNavigation,\n setupVersionSelector\n} from \"./integrations\"\nimport {\n patchEllipsis,\n patchIndeterminate,\n patchScrollfix,\n patchScrolllock\n} from \"./patches\"\nimport \"./polyfills\"\n\n/* ----------------------------------------------------------------------------\n * Functions - @todo refactor\n * ------------------------------------------------------------------------- */\n\n/**\n * Fetch search index\n *\n * @returns Search index observable\n */\nfunction fetchSearchIndex(): Observable {\n if (location.protocol === \"file:\") {\n return watchScript(\n `${new URL(\"search/search_index.js\", config.base)}`\n )\n .pipe(\n // @ts-ignore - @todo fix typings\n map(() => __index),\n shareReplay(1)\n )\n } else {\n return requestJSON(\n new URL(\"search/search_index.json\", config.base)\n )\n }\n}\n\n/* ----------------------------------------------------------------------------\n * Application\n * ------------------------------------------------------------------------- */\n\n/* Yay, JavaScript is available */\ndocument.documentElement.classList.remove(\"no-js\")\ndocument.documentElement.classList.add(\"js\")\n\n/* Set up navigation observables and subjects */\nconst document$ = watchDocument()\nconst location$ = watchLocation()\nconst target$ = watchLocationTarget(location$)\nconst keyboard$ = watchKeyboard()\n\n/* Set up media observables */\nconst viewport$ = watchViewport()\nconst tablet$ = watchMedia(\"(min-width: 960px)\")\nconst screen$ = watchMedia(\"(min-width: 1220px)\")\nconst print$ = watchPrint()\n\n/* Retrieve search index, if search is enabled */\nconst config = configuration()\nconst index$ = document.forms.namedItem(\"search\")\n ? fetchSearchIndex()\n : NEVER\n\n/* Set up Clipboard.js integration */\nconst alert$ = new Subject()\nsetupClipboardJS({ alert$ })\n\n/* Set up progress indicator */\nconst progress$ = new Subject()\n\n/* Set up instant navigation, if enabled */\nif (feature(\"navigation.instant\"))\n setupInstantNavigation({ location$, viewport$, progress$ })\n .subscribe(document$)\n\n/* Set up version selector */\nif (config.version?.provider === \"mike\")\n setupVersionSelector({ document$ })\n\n/* Always close drawer and search on navigation */\nmerge(location$, target$)\n .pipe(\n delay(125)\n )\n .subscribe(() => {\n setToggle(\"drawer\", false)\n setToggle(\"search\", false)\n })\n\n/* Set up global keyboard handlers */\nkeyboard$\n .pipe(\n filter(({ mode }) => mode === \"global\")\n )\n .subscribe(key => {\n switch (key.type) {\n\n /* Go to previous page */\n case \"p\":\n case \",\":\n const prev = getOptionalElement(\"link[rel=prev]\")\n if (typeof prev !== \"undefined\")\n setLocation(prev)\n break\n\n /* Go to next page */\n case \"n\":\n case \".\":\n const next = getOptionalElement(\"link[rel=next]\")\n if (typeof next !== \"undefined\")\n setLocation(next)\n break\n\n /* Expand navigation, see https://bit.ly/3ZjG5io */\n case \"Enter\":\n const active = getActiveElement()\n if (active instanceof HTMLLabelElement)\n active.click()\n }\n })\n\n/* Set up patches */\npatchEllipsis({ document$ })\npatchIndeterminate({ document$, tablet$ })\npatchScrollfix({ document$ })\npatchScrolllock({ viewport$, tablet$ })\n\n/* Set up header and main area observable */\nconst header$ = watchHeader(getComponentElement(\"header\"), { viewport$ })\nconst main$ = document$\n .pipe(\n map(() => getComponentElement(\"main\")),\n switchMap(el => watchMain(el, { viewport$, header$ })),\n shareReplay(1)\n )\n\n/* Set up control component observables */\nconst control$ = merge(\n\n /* Consent */\n ...getComponentElements(\"consent\")\n .map(el => mountConsent(el, { target$ })),\n\n /* Dialog */\n ...getComponentElements(\"dialog\")\n .map(el => mountDialog(el, { alert$ })),\n\n /* Header */\n ...getComponentElements(\"header\")\n .map(el => mountHeader(el, { viewport$, header$, main$ })),\n\n /* Color palette */\n ...getComponentElements(\"palette\")\n .map(el => mountPalette(el)),\n\n /* Progress bar */\n ...getComponentElements(\"progress\")\n .map(el => mountProgress(el, { progress$ })),\n\n /* Search */\n ...getComponentElements(\"search\")\n .map(el => mountSearch(el, { index$, keyboard$ })),\n\n /* Repository information */\n ...getComponentElements(\"source\")\n .map(el => mountSource(el))\n)\n\n/* Set up content component observables */\nconst content$ = defer(() => merge(\n\n /* Announcement bar */\n ...getComponentElements(\"announce\")\n .map(el => mountAnnounce(el)),\n\n /* Content */\n ...getComponentElements(\"content\")\n .map(el => mountContent(el, { viewport$, target$, print$ })),\n\n /* Search highlighting */\n ...getComponentElements(\"content\")\n .map(el => feature(\"search.highlight\")\n ? mountSearchHiglight(el, { index$, location$ })\n : EMPTY\n ),\n\n /* Header title */\n ...getComponentElements(\"header-title\")\n .map(el => mountHeaderTitle(el, { viewport$, header$ })),\n\n /* Sidebar */\n ...getComponentElements(\"sidebar\")\n .map(el => el.getAttribute(\"data-md-type\") === \"navigation\"\n ? at(screen$, () => mountSidebar(el, { viewport$, header$, main$ }))\n : at(tablet$, () => mountSidebar(el, { viewport$, header$, main$ }))\n ),\n\n /* Navigation tabs */\n ...getComponentElements(\"tabs\")\n .map(el => mountTabs(el, { viewport$, header$ })),\n\n /* Table of contents */\n ...getComponentElements(\"toc\")\n .map(el => mountTableOfContents(el, {\n viewport$, header$, main$, target$\n })),\n\n /* Back-to-top button */\n ...getComponentElements(\"top\")\n .map(el => mountBackToTop(el, { viewport$, header$, main$, target$ }))\n))\n\n/* Set up component observables */\nconst component$ = document$\n .pipe(\n switchMap(() => content$),\n mergeWith(control$),\n shareReplay(1)\n )\n\n/* Subscribe to all components */\ncomponent$.subscribe()\n\n/* ----------------------------------------------------------------------------\n * Exports\n * ------------------------------------------------------------------------- */\n\nwindow.document$ = document$ /* Document observable */\nwindow.location$ = location$ /* Location subject */\nwindow.target$ = target$ /* Location target observable */\nwindow.keyboard$ = keyboard$ /* Keyboard observable */\nwindow.viewport$ = viewport$ /* Viewport observable */\nwindow.tablet$ = tablet$ /* Media tablet observable */\nwindow.screen$ = screen$ /* Media screen observable */\nwindow.print$ = print$ /* Media print observable */\nwindow.alert$ = alert$ /* Alert subject */\nwindow.progress$ = progress$ /* Progress indicator subject */\nwindow.component$ = component$ /* Component observable */\n", "/*! *****************************************************************************\r\nCopyright (c) Microsoft Corporation.\r\n\r\nPermission to use, copy, modify, and/or distribute this software for any\r\npurpose with or without fee is hereby granted.\r\n\r\nTHE SOFTWARE IS PROVIDED \"AS IS\" AND THE AUTHOR DISCLAIMS ALL WARRANTIES WITH\r\nREGARD TO THIS SOFTWARE INCLUDING ALL IMPLIED WARRANTIES OF MERCHANTABILITY\r\nAND FITNESS. IN NO EVENT SHALL THE AUTHOR BE LIABLE FOR ANY SPECIAL, DIRECT,\r\nINDIRECT, OR CONSEQUENTIAL DAMAGES OR ANY DAMAGES WHATSOEVER RESULTING FROM\r\nLOSS OF USE, DATA OR PROFITS, WHETHER IN AN ACTION OF CONTRACT, NEGLIGENCE OR\r\nOTHER TORTIOUS ACTION, ARISING OUT OF OR IN CONNECTION WITH THE USE OR\r\nPERFORMANCE OF THIS SOFTWARE.\r\n***************************************************************************** */\r\n/* global Reflect, Promise */\r\n\r\nvar extendStatics = function(d, b) {\r\n extendStatics = Object.setPrototypeOf ||\r\n ({ __proto__: [] } instanceof Array && function (d, b) { d.__proto__ = b; }) ||\r\n function (d, b) { for (var p in b) if (Object.prototype.hasOwnProperty.call(b, p)) d[p] = b[p]; };\r\n return extendStatics(d, b);\r\n};\r\n\r\nexport function __extends(d, b) {\r\n if (typeof b !== \"function\" && b !== null)\r\n throw new TypeError(\"Class extends value \" + String(b) + \" is not a constructor or null\");\r\n extendStatics(d, b);\r\n function __() { this.constructor = d; }\r\n d.prototype = b === null ? Object.create(b) : (__.prototype = b.prototype, new __());\r\n}\r\n\r\nexport var __assign = function() {\r\n __assign = Object.assign || function __assign(t) {\r\n for (var s, i = 1, n = arguments.length; i < n; i++) {\r\n s = arguments[i];\r\n for (var p in s) if (Object.prototype.hasOwnProperty.call(s, p)) t[p] = s[p];\r\n }\r\n return t;\r\n }\r\n return __assign.apply(this, arguments);\r\n}\r\n\r\nexport function __rest(s, e) {\r\n var t = {};\r\n for (var p in s) if (Object.prototype.hasOwnProperty.call(s, p) && e.indexOf(p) < 0)\r\n t[p] = s[p];\r\n if (s != null && typeof Object.getOwnPropertySymbols === \"function\")\r\n for (var i = 0, p = Object.getOwnPropertySymbols(s); i < p.length; i++) {\r\n if (e.indexOf(p[i]) < 0 && Object.prototype.propertyIsEnumerable.call(s, p[i]))\r\n t[p[i]] = s[p[i]];\r\n }\r\n return t;\r\n}\r\n\r\nexport function __decorate(decorators, target, key, desc) {\r\n var c = arguments.length, r = c < 3 ? target : desc === null ? desc = Object.getOwnPropertyDescriptor(target, key) : desc, d;\r\n if (typeof Reflect === \"object\" && typeof Reflect.decorate === \"function\") r = Reflect.decorate(decorators, target, key, desc);\r\n else for (var i = decorators.length - 1; i >= 0; i--) if (d = decorators[i]) r = (c < 3 ? d(r) : c > 3 ? d(target, key, r) : d(target, key)) || r;\r\n return c > 3 && r && Object.defineProperty(target, key, r), r;\r\n}\r\n\r\nexport function __param(paramIndex, decorator) {\r\n return function (target, key) { decorator(target, key, paramIndex); }\r\n}\r\n\r\nexport function __metadata(metadataKey, metadataValue) {\r\n if (typeof Reflect === \"object\" && typeof Reflect.metadata === \"function\") return Reflect.metadata(metadataKey, metadataValue);\r\n}\r\n\r\nexport function __awaiter(thisArg, _arguments, P, generator) {\r\n function adopt(value) { return value instanceof P ? value : new P(function (resolve) { resolve(value); }); }\r\n return new (P || (P = Promise))(function (resolve, reject) {\r\n function fulfilled(value) { try { step(generator.next(value)); } catch (e) { reject(e); } }\r\n function rejected(value) { try { step(generator[\"throw\"](value)); } catch (e) { reject(e); } }\r\n function step(result) { result.done ? resolve(result.value) : adopt(result.value).then(fulfilled, rejected); }\r\n step((generator = generator.apply(thisArg, _arguments || [])).next());\r\n });\r\n}\r\n\r\nexport function __generator(thisArg, body) {\r\n var _ = { label: 0, sent: function() { if (t[0] & 1) throw t[1]; return t[1]; }, trys: [], ops: [] }, f, y, t, g;\r\n return g = { next: verb(0), \"throw\": verb(1), \"return\": verb(2) }, typeof Symbol === \"function\" && (g[Symbol.iterator] = function() { return this; }), g;\r\n function verb(n) { return function (v) { return step([n, v]); }; }\r\n function step(op) {\r\n if (f) throw new TypeError(\"Generator is already executing.\");\r\n while (_) try {\r\n if (f = 1, y && (t = op[0] & 2 ? y[\"return\"] : op[0] ? y[\"throw\"] || ((t = y[\"return\"]) && t.call(y), 0) : y.next) && !(t = t.call(y, op[1])).done) return t;\r\n if (y = 0, t) op = [op[0] & 2, t.value];\r\n switch (op[0]) {\r\n case 0: case 1: t = op; break;\r\n case 4: _.label++; return { value: op[1], done: false };\r\n case 5: _.label++; y = op[1]; op = [0]; continue;\r\n case 7: op = _.ops.pop(); _.trys.pop(); continue;\r\n default:\r\n if (!(t = _.trys, t = t.length > 0 && t[t.length - 1]) && (op[0] === 6 || op[0] === 2)) { _ = 0; continue; }\r\n if (op[0] === 3 && (!t || (op[1] > t[0] && op[1] < t[3]))) { _.label = op[1]; break; }\r\n if (op[0] === 6 && _.label < t[1]) { _.label = t[1]; t = op; break; }\r\n if (t && _.label < t[2]) { _.label = t[2]; _.ops.push(op); break; }\r\n if (t[2]) _.ops.pop();\r\n _.trys.pop(); continue;\r\n }\r\n op = body.call(thisArg, _);\r\n } catch (e) { op = [6, e]; y = 0; } finally { f = t = 0; }\r\n if (op[0] & 5) throw op[1]; return { value: op[0] ? op[1] : void 0, done: true };\r\n }\r\n}\r\n\r\nexport var __createBinding = Object.create ? (function(o, m, k, k2) {\r\n if (k2 === undefined) k2 = k;\r\n Object.defineProperty(o, k2, { enumerable: true, get: function() { return m[k]; } });\r\n}) : (function(o, m, k, k2) {\r\n if (k2 === undefined) k2 = k;\r\n o[k2] = m[k];\r\n});\r\n\r\nexport function __exportStar(m, o) {\r\n for (var p in m) if (p !== \"default\" && !Object.prototype.hasOwnProperty.call(o, p)) __createBinding(o, m, p);\r\n}\r\n\r\nexport function __values(o) {\r\n var s = typeof Symbol === \"function\" && Symbol.iterator, m = s && o[s], i = 0;\r\n if (m) return m.call(o);\r\n if (o && typeof o.length === \"number\") return {\r\n next: function () {\r\n if (o && i >= o.length) o = void 0;\r\n return { value: o && o[i++], done: !o };\r\n }\r\n };\r\n throw new TypeError(s ? \"Object is not iterable.\" : \"Symbol.iterator is not defined.\");\r\n}\r\n\r\nexport function __read(o, n) {\r\n var m = typeof Symbol === \"function\" && o[Symbol.iterator];\r\n if (!m) return o;\r\n var i = m.call(o), r, ar = [], e;\r\n try {\r\n while ((n === void 0 || n-- > 0) && !(r = i.next()).done) ar.push(r.value);\r\n }\r\n catch (error) { e = { error: error }; }\r\n finally {\r\n try {\r\n if (r && !r.done && (m = i[\"return\"])) m.call(i);\r\n }\r\n finally { if (e) throw e.error; }\r\n }\r\n return ar;\r\n}\r\n\r\n/** @deprecated */\r\nexport function __spread() {\r\n for (var ar = [], i = 0; i < arguments.length; i++)\r\n ar = ar.concat(__read(arguments[i]));\r\n return ar;\r\n}\r\n\r\n/** @deprecated */\r\nexport function __spreadArrays() {\r\n for (var s = 0, i = 0, il = arguments.length; i < il; i++) s += arguments[i].length;\r\n for (var r = Array(s), k = 0, i = 0; i < il; i++)\r\n for (var a = arguments[i], j = 0, jl = a.length; j < jl; j++, k++)\r\n r[k] = a[j];\r\n return r;\r\n}\r\n\r\nexport function __spreadArray(to, from, pack) {\r\n if (pack || arguments.length === 2) for (var i = 0, l = from.length, ar; i < l; i++) {\r\n if (ar || !(i in from)) {\r\n if (!ar) ar = Array.prototype.slice.call(from, 0, i);\r\n ar[i] = from[i];\r\n }\r\n }\r\n return to.concat(ar || Array.prototype.slice.call(from));\r\n}\r\n\r\nexport function __await(v) {\r\n return this instanceof __await ? (this.v = v, this) : new __await(v);\r\n}\r\n\r\nexport function __asyncGenerator(thisArg, _arguments, generator) {\r\n if (!Symbol.asyncIterator) throw new TypeError(\"Symbol.asyncIterator is not defined.\");\r\n var g = generator.apply(thisArg, _arguments || []), i, q = [];\r\n return i = {}, verb(\"next\"), verb(\"throw\"), verb(\"return\"), i[Symbol.asyncIterator] = function () { return this; }, i;\r\n function verb(n) { if (g[n]) i[n] = function (v) { return new Promise(function (a, b) { q.push([n, v, a, b]) > 1 || resume(n, v); }); }; }\r\n function resume(n, v) { try { step(g[n](v)); } catch (e) { settle(q[0][3], e); } }\r\n function step(r) { r.value instanceof __await ? Promise.resolve(r.value.v).then(fulfill, reject) : settle(q[0][2], r); }\r\n function fulfill(value) { resume(\"next\", value); }\r\n function reject(value) { resume(\"throw\", value); }\r\n function settle(f, v) { if (f(v), q.shift(), q.length) resume(q[0][0], q[0][1]); }\r\n}\r\n\r\nexport function __asyncDelegator(o) {\r\n var i, p;\r\n return i = {}, verb(\"next\"), verb(\"throw\", function (e) { throw e; }), verb(\"return\"), i[Symbol.iterator] = function () { return this; }, i;\r\n function verb(n, f) { i[n] = o[n] ? function (v) { return (p = !p) ? { value: __await(o[n](v)), done: n === \"return\" } : f ? f(v) : v; } : f; }\r\n}\r\n\r\nexport function __asyncValues(o) {\r\n if (!Symbol.asyncIterator) throw new TypeError(\"Symbol.asyncIterator is not defined.\");\r\n var m = o[Symbol.asyncIterator], i;\r\n return m ? m.call(o) : (o = typeof __values === \"function\" ? __values(o) : o[Symbol.iterator](), i = {}, verb(\"next\"), verb(\"throw\"), verb(\"return\"), i[Symbol.asyncIterator] = function () { return this; }, i);\r\n function verb(n) { i[n] = o[n] && function (v) { return new Promise(function (resolve, reject) { v = o[n](v), settle(resolve, reject, v.done, v.value); }); }; }\r\n function settle(resolve, reject, d, v) { Promise.resolve(v).then(function(v) { resolve({ value: v, done: d }); }, reject); }\r\n}\r\n\r\nexport function __makeTemplateObject(cooked, raw) {\r\n if (Object.defineProperty) { Object.defineProperty(cooked, \"raw\", { value: raw }); } else { cooked.raw = raw; }\r\n return cooked;\r\n};\r\n\r\nvar __setModuleDefault = Object.create ? (function(o, v) {\r\n Object.defineProperty(o, \"default\", { enumerable: true, value: v });\r\n}) : function(o, v) {\r\n o[\"default\"] = v;\r\n};\r\n\r\nexport function __importStar(mod) {\r\n if (mod && mod.__esModule) return mod;\r\n var result = {};\r\n if (mod != null) for (var k in mod) if (k !== \"default\" && Object.prototype.hasOwnProperty.call(mod, k)) __createBinding(result, mod, k);\r\n __setModuleDefault(result, mod);\r\n return result;\r\n}\r\n\r\nexport function __importDefault(mod) {\r\n return (mod && mod.__esModule) ? mod : { default: mod };\r\n}\r\n\r\nexport function __classPrivateFieldGet(receiver, state, kind, f) {\r\n if (kind === \"a\" && !f) throw new TypeError(\"Private accessor was defined without a getter\");\r\n if (typeof state === \"function\" ? receiver !== state || !f : !state.has(receiver)) throw new TypeError(\"Cannot read private member from an object whose class did not declare it\");\r\n return kind === \"m\" ? f : kind === \"a\" ? f.call(receiver) : f ? f.value : state.get(receiver);\r\n}\r\n\r\nexport function __classPrivateFieldSet(receiver, state, value, kind, f) {\r\n if (kind === \"m\") throw new TypeError(\"Private method is not writable\");\r\n if (kind === \"a\" && !f) throw new TypeError(\"Private accessor was defined without a setter\");\r\n if (typeof state === \"function\" ? receiver !== state || !f : !state.has(receiver)) throw new TypeError(\"Cannot write private member to an object whose class did not declare it\");\r\n return (kind === \"a\" ? f.call(receiver, value) : f ? f.value = value : state.set(receiver, value)), value;\r\n}\r\n", "/**\n * Returns true if the object is a function.\n * @param value The value to check\n */\nexport function isFunction(value: any): value is (...args: any[]) => any {\n return typeof value === 'function';\n}\n", "/**\n * Used to create Error subclasses until the community moves away from ES5.\n *\n * This is because compiling from TypeScript down to ES5 has issues with subclassing Errors\n * as well as other built-in types: https://github.com/Microsoft/TypeScript/issues/12123\n *\n * @param createImpl A factory function to create the actual constructor implementation. The returned\n * function should be a named function that calls `_super` internally.\n */\nexport function createErrorClass(createImpl: (_super: any) => any): T {\n const _super = (instance: any) => {\n Error.call(instance);\n instance.stack = new Error().stack;\n };\n\n const ctorFunc = createImpl(_super);\n ctorFunc.prototype = Object.create(Error.prototype);\n ctorFunc.prototype.constructor = ctorFunc;\n return ctorFunc;\n}\n", "import { createErrorClass } from './createErrorClass';\n\nexport interface UnsubscriptionError extends Error {\n readonly errors: any[];\n}\n\nexport interface UnsubscriptionErrorCtor {\n /**\n * @deprecated Internal implementation detail. Do not construct error instances.\n * Cannot be tagged as internal: https://github.com/ReactiveX/rxjs/issues/6269\n */\n new (errors: any[]): UnsubscriptionError;\n}\n\n/**\n * An error thrown when one or more errors have occurred during the\n * `unsubscribe` of a {@link Subscription}.\n */\nexport const UnsubscriptionError: UnsubscriptionErrorCtor = createErrorClass(\n (_super) =>\n function UnsubscriptionErrorImpl(this: any, errors: (Error | string)[]) {\n _super(this);\n this.message = errors\n ? `${errors.length} errors occurred during unsubscription:\n${errors.map((err, i) => `${i + 1}) ${err.toString()}`).join('\\n ')}`\n : '';\n this.name = 'UnsubscriptionError';\n this.errors = errors;\n }\n);\n", "/**\n * Removes an item from an array, mutating it.\n * @param arr The array to remove the item from\n * @param item The item to remove\n */\nexport function arrRemove(arr: T[] | undefined | null, item: T) {\n if (arr) {\n const index = arr.indexOf(item);\n 0 <= index && arr.splice(index, 1);\n }\n}\n", "import { isFunction } from './util/isFunction';\nimport { UnsubscriptionError } from './util/UnsubscriptionError';\nimport { SubscriptionLike, TeardownLogic, Unsubscribable } from './types';\nimport { arrRemove } from './util/arrRemove';\n\n/**\n * Represents a disposable resource, such as the execution of an Observable. A\n * Subscription has one important method, `unsubscribe`, that takes no argument\n * and just disposes the resource held by the subscription.\n *\n * Additionally, subscriptions may be grouped together through the `add()`\n * method, which will attach a child Subscription to the current Subscription.\n * When a Subscription is unsubscribed, all its children (and its grandchildren)\n * will be unsubscribed as well.\n *\n * @class Subscription\n */\nexport class Subscription implements SubscriptionLike {\n /** @nocollapse */\n public static EMPTY = (() => {\n const empty = new Subscription();\n empty.closed = true;\n return empty;\n })();\n\n /**\n * A flag to indicate whether this Subscription has already been unsubscribed.\n */\n public closed = false;\n\n private _parentage: Subscription[] | Subscription | null = null;\n\n /**\n * The list of registered finalizers to execute upon unsubscription. Adding and removing from this\n * list occurs in the {@link #add} and {@link #remove} methods.\n */\n private _finalizers: Exclude[] | null = null;\n\n /**\n * @param initialTeardown A function executed first as part of the finalization\n * process that is kicked off when {@link #unsubscribe} is called.\n */\n constructor(private initialTeardown?: () => void) {}\n\n /**\n * Disposes the resources held by the subscription. May, for instance, cancel\n * an ongoing Observable execution or cancel any other type of work that\n * started when the Subscription was created.\n * @return {void}\n */\n unsubscribe(): void {\n let errors: any[] | undefined;\n\n if (!this.closed) {\n this.closed = true;\n\n // Remove this from it's parents.\n const { _parentage } = this;\n if (_parentage) {\n this._parentage = null;\n if (Array.isArray(_parentage)) {\n for (const parent of _parentage) {\n parent.remove(this);\n }\n } else {\n _parentage.remove(this);\n }\n }\n\n const { initialTeardown: initialFinalizer } = this;\n if (isFunction(initialFinalizer)) {\n try {\n initialFinalizer();\n } catch (e) {\n errors = e instanceof UnsubscriptionError ? e.errors : [e];\n }\n }\n\n const { _finalizers } = this;\n if (_finalizers) {\n this._finalizers = null;\n for (const finalizer of _finalizers) {\n try {\n execFinalizer(finalizer);\n } catch (err) {\n errors = errors ?? [];\n if (err instanceof UnsubscriptionError) {\n errors = [...errors, ...err.errors];\n } else {\n errors.push(err);\n }\n }\n }\n }\n\n if (errors) {\n throw new UnsubscriptionError(errors);\n }\n }\n }\n\n /**\n * Adds a finalizer to this subscription, so that finalization will be unsubscribed/called\n * when this subscription is unsubscribed. If this subscription is already {@link #closed},\n * because it has already been unsubscribed, then whatever finalizer is passed to it\n * will automatically be executed (unless the finalizer itself is also a closed subscription).\n *\n * Closed Subscriptions cannot be added as finalizers to any subscription. Adding a closed\n * subscription to a any subscription will result in no operation. (A noop).\n *\n * Adding a subscription to itself, or adding `null` or `undefined` will not perform any\n * operation at all. (A noop).\n *\n * `Subscription` instances that are added to this instance will automatically remove themselves\n * if they are unsubscribed. Functions and {@link Unsubscribable} objects that you wish to remove\n * will need to be removed manually with {@link #remove}\n *\n * @param teardown The finalization logic to add to this subscription.\n */\n add(teardown: TeardownLogic): void {\n // Only add the finalizer if it's not undefined\n // and don't add a subscription to itself.\n if (teardown && teardown !== this) {\n if (this.closed) {\n // If this subscription is already closed,\n // execute whatever finalizer is handed to it automatically.\n execFinalizer(teardown);\n } else {\n if (teardown instanceof Subscription) {\n // We don't add closed subscriptions, and we don't add the same subscription\n // twice. Subscription unsubscribe is idempotent.\n if (teardown.closed || teardown._hasParent(this)) {\n return;\n }\n teardown._addParent(this);\n }\n (this._finalizers = this._finalizers ?? []).push(teardown);\n }\n }\n }\n\n /**\n * Checks to see if a this subscription already has a particular parent.\n * This will signal that this subscription has already been added to the parent in question.\n * @param parent the parent to check for\n */\n private _hasParent(parent: Subscription) {\n const { _parentage } = this;\n return _parentage === parent || (Array.isArray(_parentage) && _parentage.includes(parent));\n }\n\n /**\n * Adds a parent to this subscription so it can be removed from the parent if it\n * unsubscribes on it's own.\n *\n * NOTE: THIS ASSUMES THAT {@link _hasParent} HAS ALREADY BEEN CHECKED.\n * @param parent The parent subscription to add\n */\n private _addParent(parent: Subscription) {\n const { _parentage } = this;\n this._parentage = Array.isArray(_parentage) ? (_parentage.push(parent), _parentage) : _parentage ? [_parentage, parent] : parent;\n }\n\n /**\n * Called on a child when it is removed via {@link #remove}.\n * @param parent The parent to remove\n */\n private _removeParent(parent: Subscription) {\n const { _parentage } = this;\n if (_parentage === parent) {\n this._parentage = null;\n } else if (Array.isArray(_parentage)) {\n arrRemove(_parentage, parent);\n }\n }\n\n /**\n * Removes a finalizer from this subscription that was previously added with the {@link #add} method.\n *\n * Note that `Subscription` instances, when unsubscribed, will automatically remove themselves\n * from every other `Subscription` they have been added to. This means that using the `remove` method\n * is not a common thing and should be used thoughtfully.\n *\n * If you add the same finalizer instance of a function or an unsubscribable object to a `Subscription` instance\n * more than once, you will need to call `remove` the same number of times to remove all instances.\n *\n * All finalizer instances are removed to free up memory upon unsubscription.\n *\n * @param teardown The finalizer to remove from this subscription\n */\n remove(teardown: Exclude): void {\n const { _finalizers } = this;\n _finalizers && arrRemove(_finalizers, teardown);\n\n if (teardown instanceof Subscription) {\n teardown._removeParent(this);\n }\n }\n}\n\nexport const EMPTY_SUBSCRIPTION = Subscription.EMPTY;\n\nexport function isSubscription(value: any): value is Subscription {\n return (\n value instanceof Subscription ||\n (value && 'closed' in value && isFunction(value.remove) && isFunction(value.add) && isFunction(value.unsubscribe))\n );\n}\n\nfunction execFinalizer(finalizer: Unsubscribable | (() => void)) {\n if (isFunction(finalizer)) {\n finalizer();\n } else {\n finalizer.unsubscribe();\n }\n}\n", "import { Subscriber } from './Subscriber';\nimport { ObservableNotification } from './types';\n\n/**\n * The {@link GlobalConfig} object for RxJS. It is used to configure things\n * like how to react on unhandled errors.\n */\nexport const config: GlobalConfig = {\n onUnhandledError: null,\n onStoppedNotification: null,\n Promise: undefined,\n useDeprecatedSynchronousErrorHandling: false,\n useDeprecatedNextContext: false,\n};\n\n/**\n * The global configuration object for RxJS, used to configure things\n * like how to react on unhandled errors. Accessible via {@link config}\n * object.\n */\nexport interface GlobalConfig {\n /**\n * A registration point for unhandled errors from RxJS. These are errors that\n * cannot were not handled by consuming code in the usual subscription path. For\n * example, if you have this configured, and you subscribe to an observable without\n * providing an error handler, errors from that subscription will end up here. This\n * will _always_ be called asynchronously on another job in the runtime. This is because\n * we do not want errors thrown in this user-configured handler to interfere with the\n * behavior of the library.\n */\n onUnhandledError: ((err: any) => void) | null;\n\n /**\n * A registration point for notifications that cannot be sent to subscribers because they\n * have completed, errored or have been explicitly unsubscribed. By default, next, complete\n * and error notifications sent to stopped subscribers are noops. However, sometimes callers\n * might want a different behavior. For example, with sources that attempt to report errors\n * to stopped subscribers, a caller can configure RxJS to throw an unhandled error instead.\n * This will _always_ be called asynchronously on another job in the runtime. This is because\n * we do not want errors thrown in this user-configured handler to interfere with the\n * behavior of the library.\n */\n onStoppedNotification: ((notification: ObservableNotification, subscriber: Subscriber) => void) | null;\n\n /**\n * The promise constructor used by default for {@link Observable#toPromise toPromise} and {@link Observable#forEach forEach}\n * methods.\n *\n * @deprecated As of version 8, RxJS will no longer support this sort of injection of a\n * Promise constructor. If you need a Promise implementation other than native promises,\n * please polyfill/patch Promise as you see appropriate. Will be removed in v8.\n */\n Promise?: PromiseConstructorLike;\n\n /**\n * If true, turns on synchronous error rethrowing, which is a deprecated behavior\n * in v6 and higher. This behavior enables bad patterns like wrapping a subscribe\n * call in a try/catch block. It also enables producer interference, a nasty bug\n * where a multicast can be broken for all observers by a downstream consumer with\n * an unhandled error. DO NOT USE THIS FLAG UNLESS IT'S NEEDED TO BUY TIME\n * FOR MIGRATION REASONS.\n *\n * @deprecated As of version 8, RxJS will no longer support synchronous throwing\n * of unhandled errors. All errors will be thrown on a separate call stack to prevent bad\n * behaviors described above. Will be removed in v8.\n */\n useDeprecatedSynchronousErrorHandling: boolean;\n\n /**\n * If true, enables an as-of-yet undocumented feature from v5: The ability to access\n * `unsubscribe()` via `this` context in `next` functions created in observers passed\n * to `subscribe`.\n *\n * This is being removed because the performance was severely problematic, and it could also cause\n * issues when types other than POJOs are passed to subscribe as subscribers, as they will likely have\n * their `this` context overwritten.\n *\n * @deprecated As of version 8, RxJS will no longer support altering the\n * context of next functions provided as part of an observer to Subscribe. Instead,\n * you will have access to a subscription or a signal or token that will allow you to do things like\n * unsubscribe and test closed status. Will be removed in v8.\n */\n useDeprecatedNextContext: boolean;\n}\n", "import type { TimerHandle } from './timerHandle';\ntype SetTimeoutFunction = (handler: () => void, timeout?: number, ...args: any[]) => TimerHandle;\ntype ClearTimeoutFunction = (handle: TimerHandle) => void;\n\ninterface TimeoutProvider {\n setTimeout: SetTimeoutFunction;\n clearTimeout: ClearTimeoutFunction;\n delegate:\n | {\n setTimeout: SetTimeoutFunction;\n clearTimeout: ClearTimeoutFunction;\n }\n | undefined;\n}\n\nexport const timeoutProvider: TimeoutProvider = {\n // When accessing the delegate, use the variable rather than `this` so that\n // the functions can be called without being bound to the provider.\n setTimeout(handler: () => void, timeout?: number, ...args) {\n const { delegate } = timeoutProvider;\n if (delegate?.setTimeout) {\n return delegate.setTimeout(handler, timeout, ...args);\n }\n return setTimeout(handler, timeout, ...args);\n },\n clearTimeout(handle) {\n const { delegate } = timeoutProvider;\n return (delegate?.clearTimeout || clearTimeout)(handle as any);\n },\n delegate: undefined,\n};\n", "import { config } from '../config';\nimport { timeoutProvider } from '../scheduler/timeoutProvider';\n\n/**\n * Handles an error on another job either with the user-configured {@link onUnhandledError},\n * or by throwing it on that new job so it can be picked up by `window.onerror`, `process.on('error')`, etc.\n *\n * This should be called whenever there is an error that is out-of-band with the subscription\n * or when an error hits a terminal boundary of the subscription and no error handler was provided.\n *\n * @param err the error to report\n */\nexport function reportUnhandledError(err: any) {\n timeoutProvider.setTimeout(() => {\n const { onUnhandledError } = config;\n if (onUnhandledError) {\n // Execute the user-configured error handler.\n onUnhandledError(err);\n } else {\n // Throw so it is picked up by the runtime's uncaught error mechanism.\n throw err;\n }\n });\n}\n", "/* tslint:disable:no-empty */\nexport function noop() { }\n", "import { CompleteNotification, NextNotification, ErrorNotification } from './types';\n\n/**\n * A completion object optimized for memory use and created to be the\n * same \"shape\" as other notifications in v8.\n * @internal\n */\nexport const COMPLETE_NOTIFICATION = (() => createNotification('C', undefined, undefined) as CompleteNotification)();\n\n/**\n * Internal use only. Creates an optimized error notification that is the same \"shape\"\n * as other notifications.\n * @internal\n */\nexport function errorNotification(error: any): ErrorNotification {\n return createNotification('E', undefined, error) as any;\n}\n\n/**\n * Internal use only. Creates an optimized next notification that is the same \"shape\"\n * as other notifications.\n * @internal\n */\nexport function nextNotification(value: T) {\n return createNotification('N', value, undefined) as NextNotification;\n}\n\n/**\n * Ensures that all notifications created internally have the same \"shape\" in v8.\n *\n * TODO: This is only exported to support a crazy legacy test in `groupBy`.\n * @internal\n */\nexport function createNotification(kind: 'N' | 'E' | 'C', value: any, error: any) {\n return {\n kind,\n value,\n error,\n };\n}\n", "import { config } from '../config';\n\nlet context: { errorThrown: boolean; error: any } | null = null;\n\n/**\n * Handles dealing with errors for super-gross mode. Creates a context, in which\n * any synchronously thrown errors will be passed to {@link captureError}. Which\n * will record the error such that it will be rethrown after the call back is complete.\n * TODO: Remove in v8\n * @param cb An immediately executed function.\n */\nexport function errorContext(cb: () => void) {\n if (config.useDeprecatedSynchronousErrorHandling) {\n const isRoot = !context;\n if (isRoot) {\n context = { errorThrown: false, error: null };\n }\n cb();\n if (isRoot) {\n const { errorThrown, error } = context!;\n context = null;\n if (errorThrown) {\n throw error;\n }\n }\n } else {\n // This is the general non-deprecated path for everyone that\n // isn't crazy enough to use super-gross mode (useDeprecatedSynchronousErrorHandling)\n cb();\n }\n}\n\n/**\n * Captures errors only in super-gross mode.\n * @param err the error to capture\n */\nexport function captureError(err: any) {\n if (config.useDeprecatedSynchronousErrorHandling && context) {\n context.errorThrown = true;\n context.error = err;\n }\n}\n", "import { isFunction } from './util/isFunction';\nimport { Observer, ObservableNotification } from './types';\nimport { isSubscription, Subscription } from './Subscription';\nimport { config } from './config';\nimport { reportUnhandledError } from './util/reportUnhandledError';\nimport { noop } from './util/noop';\nimport { nextNotification, errorNotification, COMPLETE_NOTIFICATION } from './NotificationFactories';\nimport { timeoutProvider } from './scheduler/timeoutProvider';\nimport { captureError } from './util/errorContext';\n\n/**\n * Implements the {@link Observer} interface and extends the\n * {@link Subscription} class. While the {@link Observer} is the public API for\n * consuming the values of an {@link Observable}, all Observers get converted to\n * a Subscriber, in order to provide Subscription-like capabilities such as\n * `unsubscribe`. Subscriber is a common type in RxJS, and crucial for\n * implementing operators, but it is rarely used as a public API.\n *\n * @class Subscriber\n */\nexport class Subscriber extends Subscription implements Observer {\n /**\n * A static factory for a Subscriber, given a (potentially partial) definition\n * of an Observer.\n * @param next The `next` callback of an Observer.\n * @param error The `error` callback of an\n * Observer.\n * @param complete The `complete` callback of an\n * Observer.\n * @return A Subscriber wrapping the (partially defined)\n * Observer represented by the given arguments.\n * @nocollapse\n * @deprecated Do not use. Will be removed in v8. There is no replacement for this\n * method, and there is no reason to be creating instances of `Subscriber` directly.\n * If you have a specific use case, please file an issue.\n */\n static create(next?: (x?: T) => void, error?: (e?: any) => void, complete?: () => void): Subscriber {\n return new SafeSubscriber(next, error, complete);\n }\n\n /** @deprecated Internal implementation detail, do not use directly. Will be made internal in v8. */\n protected isStopped: boolean = false;\n /** @deprecated Internal implementation detail, do not use directly. Will be made internal in v8. */\n protected destination: Subscriber | Observer; // this `any` is the escape hatch to erase extra type param (e.g. R)\n\n /**\n * @deprecated Internal implementation detail, do not use directly. Will be made internal in v8.\n * There is no reason to directly create an instance of Subscriber. This type is exported for typings reasons.\n */\n constructor(destination?: Subscriber | Observer) {\n super();\n if (destination) {\n this.destination = destination;\n // Automatically chain subscriptions together here.\n // if destination is a Subscription, then it is a Subscriber.\n if (isSubscription(destination)) {\n destination.add(this);\n }\n } else {\n this.destination = EMPTY_OBSERVER;\n }\n }\n\n /**\n * The {@link Observer} callback to receive notifications of type `next` from\n * the Observable, with a value. The Observable may call this method 0 or more\n * times.\n * @param {T} [value] The `next` value.\n * @return {void}\n */\n next(value?: T): void {\n if (this.isStopped) {\n handleStoppedNotification(nextNotification(value), this);\n } else {\n this._next(value!);\n }\n }\n\n /**\n * The {@link Observer} callback to receive notifications of type `error` from\n * the Observable, with an attached `Error`. Notifies the Observer that\n * the Observable has experienced an error condition.\n * @param {any} [err] The `error` exception.\n * @return {void}\n */\n error(err?: any): void {\n if (this.isStopped) {\n handleStoppedNotification(errorNotification(err), this);\n } else {\n this.isStopped = true;\n this._error(err);\n }\n }\n\n /**\n * The {@link Observer} callback to receive a valueless notification of type\n * `complete` from the Observable. Notifies the Observer that the Observable\n * has finished sending push-based notifications.\n * @return {void}\n */\n complete(): void {\n if (this.isStopped) {\n handleStoppedNotification(COMPLETE_NOTIFICATION, this);\n } else {\n this.isStopped = true;\n this._complete();\n }\n }\n\n unsubscribe(): void {\n if (!this.closed) {\n this.isStopped = true;\n super.unsubscribe();\n this.destination = null!;\n }\n }\n\n protected _next(value: T): void {\n this.destination.next(value);\n }\n\n protected _error(err: any): void {\n try {\n this.destination.error(err);\n } finally {\n this.unsubscribe();\n }\n }\n\n protected _complete(): void {\n try {\n this.destination.complete();\n } finally {\n this.unsubscribe();\n }\n }\n}\n\n/**\n * This bind is captured here because we want to be able to have\n * compatibility with monoid libraries that tend to use a method named\n * `bind`. In particular, a library called Monio requires this.\n */\nconst _bind = Function.prototype.bind;\n\nfunction bind any>(fn: Fn, thisArg: any): Fn {\n return _bind.call(fn, thisArg);\n}\n\n/**\n * Internal optimization only, DO NOT EXPOSE.\n * @internal\n */\nclass ConsumerObserver implements Observer {\n constructor(private partialObserver: Partial>) {}\n\n next(value: T): void {\n const { partialObserver } = this;\n if (partialObserver.next) {\n try {\n partialObserver.next(value);\n } catch (error) {\n handleUnhandledError(error);\n }\n }\n }\n\n error(err: any): void {\n const { partialObserver } = this;\n if (partialObserver.error) {\n try {\n partialObserver.error(err);\n } catch (error) {\n handleUnhandledError(error);\n }\n } else {\n handleUnhandledError(err);\n }\n }\n\n complete(): void {\n const { partialObserver } = this;\n if (partialObserver.complete) {\n try {\n partialObserver.complete();\n } catch (error) {\n handleUnhandledError(error);\n }\n }\n }\n}\n\nexport class SafeSubscriber extends Subscriber {\n constructor(\n observerOrNext?: Partial> | ((value: T) => void) | null,\n error?: ((e?: any) => void) | null,\n complete?: (() => void) | null\n ) {\n super();\n\n let partialObserver: Partial>;\n if (isFunction(observerOrNext) || !observerOrNext) {\n // The first argument is a function, not an observer. The next\n // two arguments *could* be observers, or they could be empty.\n partialObserver = {\n next: (observerOrNext ?? undefined) as (((value: T) => void) | undefined),\n error: error ?? undefined,\n complete: complete ?? undefined,\n };\n } else {\n // The first argument is a partial observer.\n let context: any;\n if (this && config.useDeprecatedNextContext) {\n // This is a deprecated path that made `this.unsubscribe()` available in\n // next handler functions passed to subscribe. This only exists behind a flag\n // now, as it is *very* slow.\n context = Object.create(observerOrNext);\n context.unsubscribe = () => this.unsubscribe();\n partialObserver = {\n next: observerOrNext.next && bind(observerOrNext.next, context),\n error: observerOrNext.error && bind(observerOrNext.error, context),\n complete: observerOrNext.complete && bind(observerOrNext.complete, context),\n };\n } else {\n // The \"normal\" path. Just use the partial observer directly.\n partialObserver = observerOrNext;\n }\n }\n\n // Wrap the partial observer to ensure it's a full observer, and\n // make sure proper error handling is accounted for.\n this.destination = new ConsumerObserver(partialObserver);\n }\n}\n\nfunction handleUnhandledError(error: any) {\n if (config.useDeprecatedSynchronousErrorHandling) {\n captureError(error);\n } else {\n // Ideal path, we report this as an unhandled error,\n // which is thrown on a new call stack.\n reportUnhandledError(error);\n }\n}\n\n/**\n * An error handler used when no error handler was supplied\n * to the SafeSubscriber -- meaning no error handler was supplied\n * do the `subscribe` call on our observable.\n * @param err The error to handle\n */\nfunction defaultErrorHandler(err: any) {\n throw err;\n}\n\n/**\n * A handler for notifications that cannot be sent to a stopped subscriber.\n * @param notification The notification being sent\n * @param subscriber The stopped subscriber\n */\nfunction handleStoppedNotification(notification: ObservableNotification, subscriber: Subscriber) {\n const { onStoppedNotification } = config;\n onStoppedNotification && timeoutProvider.setTimeout(() => onStoppedNotification(notification, subscriber));\n}\n\n/**\n * The observer used as a stub for subscriptions where the user did not\n * pass any arguments to `subscribe`. Comes with the default error handling\n * behavior.\n */\nexport const EMPTY_OBSERVER: Readonly> & { closed: true } = {\n closed: true,\n next: noop,\n error: defaultErrorHandler,\n complete: noop,\n};\n", "/**\n * Symbol.observable or a string \"@@observable\". Used for interop\n *\n * @deprecated We will no longer be exporting this symbol in upcoming versions of RxJS.\n * Instead polyfill and use Symbol.observable directly *or* use https://www.npmjs.com/package/symbol-observable\n */\nexport const observable: string | symbol = (() => (typeof Symbol === 'function' && Symbol.observable) || '@@observable')();\n", "/**\n * This function takes one parameter and just returns it. Simply put,\n * this is like `(x: T): T => x`.\n *\n * ## Examples\n *\n * This is useful in some cases when using things like `mergeMap`\n *\n * ```ts\n * import { interval, take, map, range, mergeMap, identity } from 'rxjs';\n *\n * const source$ = interval(1000).pipe(take(5));\n *\n * const result$ = source$.pipe(\n * map(i => range(i)),\n * mergeMap(identity) // same as mergeMap(x => x)\n * );\n *\n * result$.subscribe({\n * next: console.log\n * });\n * ```\n *\n * Or when you want to selectively apply an operator\n *\n * ```ts\n * import { interval, take, identity } from 'rxjs';\n *\n * const shouldLimit = () => Math.random() < 0.5;\n *\n * const source$ = interval(1000);\n *\n * const result$ = source$.pipe(shouldLimit() ? take(5) : identity);\n *\n * result$.subscribe({\n * next: console.log\n * });\n * ```\n *\n * @param x Any value that is returned by this function\n * @returns The value passed as the first parameter to this function\n */\nexport function identity(x: T): T {\n return x;\n}\n", "import { identity } from './identity';\nimport { UnaryFunction } from '../types';\n\nexport function pipe(): typeof identity;\nexport function pipe(fn1: UnaryFunction): UnaryFunction;\nexport function pipe(fn1: UnaryFunction, fn2: UnaryFunction): UnaryFunction;\nexport function pipe(fn1: UnaryFunction, fn2: UnaryFunction, fn3: UnaryFunction): UnaryFunction;\nexport function pipe(\n fn1: UnaryFunction,\n fn2: UnaryFunction,\n fn3: UnaryFunction,\n fn4: UnaryFunction\n): UnaryFunction;\nexport function pipe(\n fn1: UnaryFunction,\n fn2: UnaryFunction,\n fn3: UnaryFunction,\n fn4: UnaryFunction,\n fn5: UnaryFunction\n): UnaryFunction;\nexport function pipe(\n fn1: UnaryFunction,\n fn2: UnaryFunction,\n fn3: UnaryFunction,\n fn4: UnaryFunction,\n fn5: UnaryFunction,\n fn6: UnaryFunction\n): UnaryFunction;\nexport function pipe(\n fn1: UnaryFunction,\n fn2: UnaryFunction,\n fn3: UnaryFunction,\n fn4: UnaryFunction,\n fn5: UnaryFunction,\n fn6: UnaryFunction,\n fn7: UnaryFunction\n): UnaryFunction;\nexport function pipe(\n fn1: UnaryFunction,\n fn2: UnaryFunction,\n fn3: UnaryFunction,\n fn4: UnaryFunction,\n fn5: UnaryFunction,\n fn6: UnaryFunction,\n fn7: UnaryFunction,\n fn8: UnaryFunction\n): UnaryFunction;\nexport function pipe(\n fn1: UnaryFunction,\n fn2: UnaryFunction,\n fn3: UnaryFunction,\n fn4: UnaryFunction,\n fn5: UnaryFunction,\n fn6: UnaryFunction,\n fn7: UnaryFunction,\n fn8: UnaryFunction,\n fn9: UnaryFunction\n): UnaryFunction;\nexport function pipe(\n fn1: UnaryFunction,\n fn2: UnaryFunction,\n fn3: UnaryFunction,\n fn4: UnaryFunction,\n fn5: UnaryFunction,\n fn6: UnaryFunction,\n fn7: UnaryFunction,\n fn8: UnaryFunction,\n fn9: UnaryFunction,\n ...fns: UnaryFunction[]\n): UnaryFunction;\n\n/**\n * pipe() can be called on one or more functions, each of which can take one argument (\"UnaryFunction\")\n * and uses it to return a value.\n * It returns a function that takes one argument, passes it to the first UnaryFunction, and then\n * passes the result to the next one, passes that result to the next one, and so on. \n */\nexport function pipe(...fns: Array>): UnaryFunction {\n return pipeFromArray(fns);\n}\n\n/** @internal */\nexport function pipeFromArray(fns: Array>): UnaryFunction {\n if (fns.length === 0) {\n return identity as UnaryFunction;\n }\n\n if (fns.length === 1) {\n return fns[0];\n }\n\n return function piped(input: T): R {\n return fns.reduce((prev: any, fn: UnaryFunction) => fn(prev), input as any);\n };\n}\n", "import { Operator } from './Operator';\nimport { SafeSubscriber, Subscriber } from './Subscriber';\nimport { isSubscription, Subscription } from './Subscription';\nimport { TeardownLogic, OperatorFunction, Subscribable, Observer } from './types';\nimport { observable as Symbol_observable } from './symbol/observable';\nimport { pipeFromArray } from './util/pipe';\nimport { config } from './config';\nimport { isFunction } from './util/isFunction';\nimport { errorContext } from './util/errorContext';\n\n/**\n * A representation of any set of values over any amount of time. This is the most basic building block\n * of RxJS.\n *\n * @class Observable\n */\nexport class Observable implements Subscribable {\n /**\n * @deprecated Internal implementation detail, do not use directly. Will be made internal in v8.\n */\n source: Observable | undefined;\n\n /**\n * @deprecated Internal implementation detail, do not use directly. Will be made internal in v8.\n */\n operator: Operator | undefined;\n\n /**\n * @constructor\n * @param {Function} subscribe the function that is called when the Observable is\n * initially subscribed to. This function is given a Subscriber, to which new values\n * can be `next`ed, or an `error` method can be called to raise an error, or\n * `complete` can be called to notify of a successful completion.\n */\n constructor(subscribe?: (this: Observable, subscriber: Subscriber) => TeardownLogic) {\n if (subscribe) {\n this._subscribe = subscribe;\n }\n }\n\n // HACK: Since TypeScript inherits static properties too, we have to\n // fight against TypeScript here so Subject can have a different static create signature\n /**\n * Creates a new Observable by calling the Observable constructor\n * @owner Observable\n * @method create\n * @param {Function} subscribe? the subscriber function to be passed to the Observable constructor\n * @return {Observable} a new observable\n * @nocollapse\n * @deprecated Use `new Observable()` instead. Will be removed in v8.\n */\n static create: (...args: any[]) => any = (subscribe?: (subscriber: Subscriber) => TeardownLogic) => {\n return new Observable(subscribe);\n };\n\n /**\n * Creates a new Observable, with this Observable instance as the source, and the passed\n * operator defined as the new observable's operator.\n * @method lift\n * @param operator the operator defining the operation to take on the observable\n * @return a new observable with the Operator applied\n * @deprecated Internal implementation detail, do not use directly. Will be made internal in v8.\n * If you have implemented an operator using `lift`, it is recommended that you create an\n * operator by simply returning `new Observable()` directly. See \"Creating new operators from\n * scratch\" section here: https://rxjs.dev/guide/operators\n */\n lift(operator?: Operator): Observable {\n const observable = new Observable();\n observable.source = this;\n observable.operator = operator;\n return observable;\n }\n\n subscribe(observerOrNext?: Partial> | ((value: T) => void)): Subscription;\n /** @deprecated Instead of passing separate callback arguments, use an observer argument. Signatures taking separate callback arguments will be removed in v8. Details: https://rxjs.dev/deprecations/subscribe-arguments */\n subscribe(next?: ((value: T) => void) | null, error?: ((error: any) => void) | null, complete?: (() => void) | null): Subscription;\n /**\n * Invokes an execution of an Observable and registers Observer handlers for notifications it will emit.\n *\n * Use it when you have all these Observables, but still nothing is happening. \n *\n * `subscribe` is not a regular operator, but a method that calls Observable's internal `subscribe` function. It\n * might be for example a function that you passed to Observable's constructor, but most of the time it is\n * a library implementation, which defines what will be emitted by an Observable, and when it be will emitted. This means\n * that calling `subscribe` is actually the moment when Observable starts its work, not when it is created, as it is often\n * the thought.\n *\n * Apart from starting the execution of an Observable, this method allows you to listen for values\n * that an Observable emits, as well as for when it completes or errors. You can achieve this in two\n * of the following ways.\n *\n * The first way is creating an object that implements {@link Observer} interface. It should have methods\n * defined by that interface, but note that it should be just a regular JavaScript object, which you can create\n * yourself in any way you want (ES6 class, classic function constructor, object literal etc.). In particular, do\n * not attempt to use any RxJS implementation details to create Observers - you don't need them. Remember also\n * that your object does not have to implement all methods. If you find yourself creating a method that doesn't\n * do anything, you can simply omit it. Note however, if the `error` method is not provided and an error happens,\n * it will be thrown asynchronously. Errors thrown asynchronously cannot be caught using `try`/`catch`. Instead,\n * use the {@link onUnhandledError} configuration option or use a runtime handler (like `window.onerror` or\n * `process.on('error)`) to be notified of unhandled errors. Because of this, it's recommended that you provide\n * an `error` method to avoid missing thrown errors.\n *\n * The second way is to give up on Observer object altogether and simply provide callback functions in place of its methods.\n * This means you can provide three functions as arguments to `subscribe`, where the first function is equivalent\n * of a `next` method, the second of an `error` method and the third of a `complete` method. Just as in case of an Observer,\n * if you do not need to listen for something, you can omit a function by passing `undefined` or `null`,\n * since `subscribe` recognizes these functions by where they were placed in function call. When it comes\n * to the `error` function, as with an Observer, if not provided, errors emitted by an Observable will be thrown asynchronously.\n *\n * You can, however, subscribe with no parameters at all. This may be the case where you're not interested in terminal events\n * and you also handled emissions internally by using operators (e.g. using `tap`).\n *\n * Whichever style of calling `subscribe` you use, in both cases it returns a Subscription object.\n * This object allows you to call `unsubscribe` on it, which in turn will stop the work that an Observable does and will clean\n * up all resources that an Observable used. Note that cancelling a subscription will not call `complete` callback\n * provided to `subscribe` function, which is reserved for a regular completion signal that comes from an Observable.\n *\n * Remember that callbacks provided to `subscribe` are not guaranteed to be called asynchronously.\n * It is an Observable itself that decides when these functions will be called. For example {@link of}\n * by default emits all its values synchronously. Always check documentation for how given Observable\n * will behave when subscribed and if its default behavior can be modified with a `scheduler`.\n *\n * #### Examples\n *\n * Subscribe with an {@link guide/observer Observer}\n *\n * ```ts\n * import { of } from 'rxjs';\n *\n * const sumObserver = {\n * sum: 0,\n * next(value) {\n * console.log('Adding: ' + value);\n * this.sum = this.sum + value;\n * },\n * error() {\n * // We actually could just remove this method,\n * // since we do not really care about errors right now.\n * },\n * complete() {\n * console.log('Sum equals: ' + this.sum);\n * }\n * };\n *\n * of(1, 2, 3) // Synchronously emits 1, 2, 3 and then completes.\n * .subscribe(sumObserver);\n *\n * // Logs:\n * // 'Adding: 1'\n * // 'Adding: 2'\n * // 'Adding: 3'\n * // 'Sum equals: 6'\n * ```\n *\n * Subscribe with functions ({@link deprecations/subscribe-arguments deprecated})\n *\n * ```ts\n * import { of } from 'rxjs'\n *\n * let sum = 0;\n *\n * of(1, 2, 3).subscribe(\n * value => {\n * console.log('Adding: ' + value);\n * sum = sum + value;\n * },\n * undefined,\n * () => console.log('Sum equals: ' + sum)\n * );\n *\n * // Logs:\n * // 'Adding: 1'\n * // 'Adding: 2'\n * // 'Adding: 3'\n * // 'Sum equals: 6'\n * ```\n *\n * Cancel a subscription\n *\n * ```ts\n * import { interval } from 'rxjs';\n *\n * const subscription = interval(1000).subscribe({\n * next(num) {\n * console.log(num)\n * },\n * complete() {\n * // Will not be called, even when cancelling subscription.\n * console.log('completed!');\n * }\n * });\n *\n * setTimeout(() => {\n * subscription.unsubscribe();\n * console.log('unsubscribed!');\n * }, 2500);\n *\n * // Logs:\n * // 0 after 1s\n * // 1 after 2s\n * // 'unsubscribed!' after 2.5s\n * ```\n *\n * @param {Observer|Function} observerOrNext (optional) Either an observer with methods to be called,\n * or the first of three possible handlers, which is the handler for each value emitted from the subscribed\n * Observable.\n * @param {Function} error (optional) A handler for a terminal event resulting from an error. If no error handler is provided,\n * the error will be thrown asynchronously as unhandled.\n * @param {Function} complete (optional) A handler for a terminal event resulting from successful completion.\n * @return {Subscription} a subscription reference to the registered handlers\n * @method subscribe\n */\n subscribe(\n observerOrNext?: Partial> | ((value: T) => void) | null,\n error?: ((error: any) => void) | null,\n complete?: (() => void) | null\n ): Subscription {\n const subscriber = isSubscriber(observerOrNext) ? observerOrNext : new SafeSubscriber(observerOrNext, error, complete);\n\n errorContext(() => {\n const { operator, source } = this;\n subscriber.add(\n operator\n ? // We're dealing with a subscription in the\n // operator chain to one of our lifted operators.\n operator.call(subscriber, source)\n : source\n ? // If `source` has a value, but `operator` does not, something that\n // had intimate knowledge of our API, like our `Subject`, must have\n // set it. We're going to just call `_subscribe` directly.\n this._subscribe(subscriber)\n : // In all other cases, we're likely wrapping a user-provided initializer\n // function, so we need to catch errors and handle them appropriately.\n this._trySubscribe(subscriber)\n );\n });\n\n return subscriber;\n }\n\n /** @internal */\n protected _trySubscribe(sink: Subscriber): TeardownLogic {\n try {\n return this._subscribe(sink);\n } catch (err) {\n // We don't need to return anything in this case,\n // because it's just going to try to `add()` to a subscription\n // above.\n sink.error(err);\n }\n }\n\n /**\n * Used as a NON-CANCELLABLE means of subscribing to an observable, for use with\n * APIs that expect promises, like `async/await`. You cannot unsubscribe from this.\n *\n * **WARNING**: Only use this with observables you *know* will complete. If the source\n * observable does not complete, you will end up with a promise that is hung up, and\n * potentially all of the state of an async function hanging out in memory. To avoid\n * this situation, look into adding something like {@link timeout}, {@link take},\n * {@link takeWhile}, or {@link takeUntil} amongst others.\n *\n * #### Example\n *\n * ```ts\n * import { interval, take } from 'rxjs';\n *\n * const source$ = interval(1000).pipe(take(4));\n *\n * async function getTotal() {\n * let total = 0;\n *\n * await source$.forEach(value => {\n * total += value;\n * console.log('observable -> ' + value);\n * });\n *\n * return total;\n * }\n *\n * getTotal().then(\n * total => console.log('Total: ' + total)\n * );\n *\n * // Expected:\n * // 'observable -> 0'\n * // 'observable -> 1'\n * // 'observable -> 2'\n * // 'observable -> 3'\n * // 'Total: 6'\n * ```\n *\n * @param next a handler for each value emitted by the observable\n * @return a promise that either resolves on observable completion or\n * rejects with the handled error\n */\n forEach(next: (value: T) => void): Promise;\n\n /**\n * @param next a handler for each value emitted by the observable\n * @param promiseCtor a constructor function used to instantiate the Promise\n * @return a promise that either resolves on observable completion or\n * rejects with the handled error\n * @deprecated Passing a Promise constructor will no longer be available\n * in upcoming versions of RxJS. This is because it adds weight to the library, for very\n * little benefit. If you need this functionality, it is recommended that you either\n * polyfill Promise, or you create an adapter to convert the returned native promise\n * to whatever promise implementation you wanted. Will be removed in v8.\n */\n forEach(next: (value: T) => void, promiseCtor: PromiseConstructorLike): Promise;\n\n forEach(next: (value: T) => void, promiseCtor?: PromiseConstructorLike): Promise {\n promiseCtor = getPromiseCtor(promiseCtor);\n\n return new promiseCtor((resolve, reject) => {\n const subscriber = new SafeSubscriber({\n next: (value) => {\n try {\n next(value);\n } catch (err) {\n reject(err);\n subscriber.unsubscribe();\n }\n },\n error: reject,\n complete: resolve,\n });\n this.subscribe(subscriber);\n }) as Promise;\n }\n\n /** @internal */\n protected _subscribe(subscriber: Subscriber): TeardownLogic {\n return this.source?.subscribe(subscriber);\n }\n\n /**\n * An interop point defined by the es7-observable spec https://github.com/zenparsing/es-observable\n * @method Symbol.observable\n * @return {Observable} this instance of the observable\n */\n [Symbol_observable]() {\n return this;\n }\n\n /* tslint:disable:max-line-length */\n pipe(): Observable;\n pipe(op1: OperatorFunction): Observable;\n pipe (op1: OperatorFunction, op2: OperatorFunction): Observable;\n pipe(op1: OperatorFunction, op2: OperatorFunction, op3: OperatorFunction): Observable;\n pipe(\n op1: OperatorFunction,\n op2: OperatorFunction,\n op3: OperatorFunction,\n op4: OperatorFunction\n ): Observable;\n pipe(\n op1: OperatorFunction,\n op2: OperatorFunction,\n op3: OperatorFunction,\n op4: OperatorFunction,\n op5: OperatorFunction\n ): Observable;\n pipe(\n op1: OperatorFunction,\n op2: OperatorFunction,\n op3: OperatorFunction,\n op4: OperatorFunction,\n op5: OperatorFunction,\n op6: OperatorFunction\n ): Observable;\n pipe(\n op1: OperatorFunction,\n op2: OperatorFunction,\n op3: OperatorFunction,\n op4: OperatorFunction,\n op5: OperatorFunction,\n op6: OperatorFunction,\n op7: OperatorFunction\n ): Observable;\n pipe(\n op1: OperatorFunction,\n op2: OperatorFunction,\n op3: OperatorFunction,\n op4: OperatorFunction,\n op5: OperatorFunction,\n op6: OperatorFunction,\n op7: OperatorFunction,\n op8: OperatorFunction\n ): Observable;\n pipe(\n op1: OperatorFunction,\n op2: OperatorFunction,\n op3: OperatorFunction,\n op4: OperatorFunction,\n op5: OperatorFunction,\n op6: OperatorFunction,\n op7: OperatorFunction,\n op8: OperatorFunction,\n op9: OperatorFunction\n ): Observable;\n pipe(\n op1: OperatorFunction,\n op2: OperatorFunction,\n op3: OperatorFunction,\n op4: OperatorFunction,\n op5: OperatorFunction,\n op6: OperatorFunction,\n op7: OperatorFunction,\n op8: OperatorFunction,\n op9: OperatorFunction,\n ...operations: OperatorFunction[]\n ): Observable;\n /* tslint:enable:max-line-length */\n\n /**\n * Used to stitch together functional operators into a chain.\n * @method pipe\n * @return {Observable} the Observable result of all of the operators having\n * been called in the order they were passed in.\n *\n * ## Example\n *\n * ```ts\n * import { interval, filter, map, scan } from 'rxjs';\n *\n * interval(1000)\n * .pipe(\n * filter(x => x % 2 === 0),\n * map(x => x + x),\n * scan((acc, x) => acc + x)\n * )\n * .subscribe(x => console.log(x));\n * ```\n */\n pipe(...operations: OperatorFunction[]): Observable {\n return pipeFromArray(operations)(this);\n }\n\n /* tslint:disable:max-line-length */\n /** @deprecated Replaced with {@link firstValueFrom} and {@link lastValueFrom}. Will be removed in v8. Details: https://rxjs.dev/deprecations/to-promise */\n toPromise(): Promise;\n /** @deprecated Replaced with {@link firstValueFrom} and {@link lastValueFrom}. Will be removed in v8. Details: https://rxjs.dev/deprecations/to-promise */\n toPromise(PromiseCtor: typeof Promise): Promise;\n /** @deprecated Replaced with {@link firstValueFrom} and {@link lastValueFrom}. Will be removed in v8. Details: https://rxjs.dev/deprecations/to-promise */\n toPromise(PromiseCtor: PromiseConstructorLike): Promise;\n /* tslint:enable:max-line-length */\n\n /**\n * Subscribe to this Observable and get a Promise resolving on\n * `complete` with the last emission (if any).\n *\n * **WARNING**: Only use this with observables you *know* will complete. If the source\n * observable does not complete, you will end up with a promise that is hung up, and\n * potentially all of the state of an async function hanging out in memory. To avoid\n * this situation, look into adding something like {@link timeout}, {@link take},\n * {@link takeWhile}, or {@link takeUntil} amongst others.\n *\n * @method toPromise\n * @param [promiseCtor] a constructor function used to instantiate\n * the Promise\n * @return A Promise that resolves with the last value emit, or\n * rejects on an error. If there were no emissions, Promise\n * resolves with undefined.\n * @deprecated Replaced with {@link firstValueFrom} and {@link lastValueFrom}. Will be removed in v8. Details: https://rxjs.dev/deprecations/to-promise\n */\n toPromise(promiseCtor?: PromiseConstructorLike): Promise {\n promiseCtor = getPromiseCtor(promiseCtor);\n\n return new promiseCtor((resolve, reject) => {\n let value: T | undefined;\n this.subscribe(\n (x: T) => (value = x),\n (err: any) => reject(err),\n () => resolve(value)\n );\n }) as Promise;\n }\n}\n\n/**\n * Decides between a passed promise constructor from consuming code,\n * A default configured promise constructor, and the native promise\n * constructor and returns it. If nothing can be found, it will throw\n * an error.\n * @param promiseCtor The optional promise constructor to passed by consuming code\n */\nfunction getPromiseCtor(promiseCtor: PromiseConstructorLike | undefined) {\n return promiseCtor ?? config.Promise ?? Promise;\n}\n\nfunction isObserver(value: any): value is Observer {\n return value && isFunction(value.next) && isFunction(value.error) && isFunction(value.complete);\n}\n\nfunction isSubscriber(value: any): value is Subscriber {\n return (value && value instanceof Subscriber) || (isObserver(value) && isSubscription(value));\n}\n", "import { Observable } from '../Observable';\nimport { Subscriber } from '../Subscriber';\nimport { OperatorFunction } from '../types';\nimport { isFunction } from './isFunction';\n\n/**\n * Used to determine if an object is an Observable with a lift function.\n */\nexport function hasLift(source: any): source is { lift: InstanceType['lift'] } {\n return isFunction(source?.lift);\n}\n\n/**\n * Creates an `OperatorFunction`. Used to define operators throughout the library in a concise way.\n * @param init The logic to connect the liftedSource to the subscriber at the moment of subscription.\n */\nexport function operate(\n init: (liftedSource: Observable, subscriber: Subscriber) => (() => void) | void\n): OperatorFunction {\n return (source: Observable) => {\n if (hasLift(source)) {\n return source.lift(function (this: Subscriber, liftedSource: Observable