changeset 0:3b461dc9568b draft default tip

Uploaded
author metaboflow_cam
date Mon, 09 Aug 2021 09:41:22 +0000
parents
children
files ionflow/ionflow.R ionflow/ionflow.xml ionflow/ionflow_funcs.R ionflow/macros.xml ionflow/test-data/Dataset_IonFlow_Ionome_KO_short.csv
diffstat 5 files changed, 4586 insertions(+), 0 deletions(-) [+]
line wrap: on
line diff
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/ionflow/ionflow.R	Mon Aug 09 09:41:22 2021 +0000
@@ -0,0 +1,384 @@
+#' wl-07-06-2021, Mon: The fourth version: based on Jacopo's new changes in 
+#' 'ionflow_funcs.R' and new pipeline 'tutorial_galaxy_ionflow.R'
+#' wl-08-06-2021, Tue: finalise
+
+## ==== General settings ====
+rm(list = ls(all = T))
+
+#' flag for command-line use or not. If false, only for debug interactively.
+com_f <- T
+
+#' galaxy will stop even if R has warning message
+options(warn = -1) #' disable R warning. Turn back: options(warn=0)
+
+#' ------------------------------------------------------------------------
+#' Setup R error handling to go to stderr
+#' options( show.error.messages=F, error = function () {
+#'   cat( geterrmessage(), file=stderr() )
+#'   q( "no", 1, F )
+#' })
+
+#' we need that to not crash galaxy with an UTF8 error on German LC settings.
+loc <- Sys.setlocale("LC_MESSAGES", "en_US.UTF-8")
+
+#' wl-28-08-2018, Tue: Convert a string separated by comma into character vector
+str_vec <- function(x) {
+  x <- unlist(strsplit(x, ","))
+  x <- gsub("^[ \t]+|[ \t]+$", "", x) #' trim white spaces
+}
+
+pkgs <- c("optparse", "reshape2", "plyr", "dplyr", "tidyr", "ggplot2",
+          "ggrepel", "corrplot", "gplots", "network", "sna", "GGally",
+          "org.Sc.sgd.db","org.Hs.eg.db","GO.db", "GOstats", "KEGG.db",
+          "pheatmap")
+suppressPackageStartupMessages(invisible(lapply(pkgs, library,
+                                                character.only = TRUE)))
+
+## ==== Command line or interactive setting ====
+if (com_f) {
+
+  func <- function() {
+    argv <- commandArgs(trailingOnly = FALSE)
+    path <- sub("--file=", "", argv[grep("--file=", argv)])
+  }
+  #' prog_name <- basename(func())
+  tool_dir <- paste0(dirname(func()), "/")
+
+  option_list <-
+    list(
+      make_option(c("-v", "--verbose"),
+        action = "store_true", default = TRUE,
+        help = "Print extra output [default]"
+      ),
+      make_option(c("-q", "--quietly"),
+        action = "store_false",
+        dest = "verbose", help = "Print little output"
+      ),
+
+      #' Data pre-processing
+      make_option("--ion_file", type = "character",
+                  help = "ion concentration file in tabular format"),
+      make_option("--var_id", type = "integer", default = 1,
+                  help = "Column index of variable"),
+      make_option("--batch_id", type = "integer", default = 3,
+                  help = "Column index of batch ID"),
+      make_option("--data_id", type = "integer", default = 5,
+                  help = "Start column index of data matrix"),
+      make_option("--method_norm", type = "character", default = "median",
+                  help = "Batch correction methods.  Support: median,
+                          median+std and none"),
+      make_option("--batch_control", type = "character", default = "yes",
+                  help = "Use control lines for batch correction or not"),
+      make_option("--control_lines", type = "character", default = "BY4741",
+                  help = "Batch control lines"),
+      make_option("--control_use", type = "character", default = "all",
+                  help = "Select lines used for batch correction control.
+                          Three selection: control, all and control.out"),
+      make_option("--method_outliers", type = "character",
+                  default = "log.FC.dist",
+                  help = "Outlier detection method. Currently support:
+                          mad, IQR, log.FC.dist and none."),
+      make_option("--thres_outl", type = "double", default = 3.0,
+                  help = "Outlier detection threshold"),
+      make_option("--stand_method", type = "character", default = "std",
+                  help = "Standardisation method. Currently support:
+                          std, mad and custom."),
+      make_option("--std_file", type = "character",
+                  help = "user predifined std file with respect to ions"),
+      make_option("--thres_symb", type = "double", default = 2.0,
+                  help = "Symbolisation threshold"),
+
+      #' Exploratory analysis
+      make_option("--thres_ion_corr", type = "double", default = 0.15,
+                  help = "Threshold for Ion correlation (0 - 1)"),
+
+      #' Clustering analysis
+      make_option("--min_clust_size", type = "double", default = 10.0,
+                  help = "Minimal cluster size."),
+      make_option("--h_tree", type = "double", default = 0.0,
+                  help = "Cutting height for hierarchical clustering."),
+      make_option("--filter_zero_string", type = "logical", default = TRUE,
+                  help = "Filter the zero string or not"),
+
+      #' Enrichment analysis
+      make_option("--pval", type = "double", default = 0.05,
+                  help = "P-values for enrichment analysis."),
+      make_option("--min_count", type = "double", default = 3.0,
+                  help = "Minimal count number for enrichment analysis."),
+      make_option("--ont", type = "character", default = "BP",
+                  help = "Ontology method: BP, MF and CC."),
+      make_option("--annot_pkg", type = "character", default = "org.Sc.sgd.db",
+                  help = "Annotation package"),
+
+      #' Network analysis
+      make_option("--method_corr", type = "character", default = "cosine",
+                  help = "Similarity measure method. Currently support:
+                          pearson, spearman, kendall, cosine, mahal_cosine,
+                          hybrid_mahal_cosine"),
+      make_option("--thres_corr", type = "double", default = 0.70,
+                  help = "Similarity threshold for network analysis (0 - 1).
+                          Features large than threshold will be kept."),
+
+      #' output: pre-processing
+      make_option("--pre_proc_pdf",
+        type = "character", default = "pre_proc.pdf",
+        help = "Save plots from pre-processing"
+      ),
+      make_option("--df_stats_out",
+        type = "character", default = "df_stats.tsv",
+        help = "Save stats summary of raw, batch corrected and
+                standardised data"
+      ),
+      make_option("--outl_out",
+        type = "character", default = "outl.tsv",
+        help = "Save outliers summary"
+      ),
+      make_option("--data_wide_out",
+        type = "character", default = "data_wide.tsv",
+        help = "Save pre-processed data in wide format"
+      ),
+      make_option("--data_wide_symb_out",
+        type = "character", default = "data_wide_symb.tsv",
+        help = "Save pre-processed data Symbolization in wide format"
+      ),
+
+      #' output: exploratory analysis
+      make_option("--expl_anal_pdf",
+        type = "character", default = "expl_anal.pdf",
+        help = "Save plots from exploratory analysis"
+      ),
+
+      #' output: clustering analysis
+      make_option("--clus_anal_pdf",
+        type = "character", default = "clus_anal.pdf",
+        help = "Save plots from clustering analysis"
+      ),
+
+      #' output: enrichment analysis
+      make_option("--go_en_out",
+        type = "character", default = "go_en.tsv",
+        help = "Save GO enrichment table"
+      ),
+
+      #' output: network analysis
+      make_option("--gene_net_pdf",
+        type = "character", default = "gene_net.pdf",
+        help = "Save plots from gene network"
+      ),
+      make_option("--imbe_out",
+        type = "character", default = "impact_betweenness.tsv",
+        help = "Save impact and betweenness table"
+      )
+    )
+
+  opt <- parse_args(
+    object = OptionParser(option_list = option_list),
+    args = commandArgs(trailingOnly = TRUE)
+  )
+} else {
+  #' tool_dir <- "C:/R_lwc/my_galaxy/ionflow/"
+  tool_dir <- "~/my_galaxy/ionflow/"
+
+  opt <- list(
+
+    #' Input
+    ion_file = paste0(tool_dir, "test-data/Dataset_IonFlow_Ionome_KO_short.csv"),
+    var_id = 1,
+    batch_id = 3,
+    data_id = 5,
+    method_norm = "median",
+    batch_control = "yes",
+    control_lines = "BY4741",
+    control_use = "all",
+    method_outliers = "log.FC.dist",
+    thres_outl = 3.0,
+    stand_method = "std",
+    thres_symb = 2,
+
+    #' Exploratory analysis
+    thres_ion_corr = 0.15,
+
+    #' Clustering analysis
+    min_clust_size = 10.0,
+    h_tree = 0.0,
+    filter_zero_string = TRUE,
+
+    #' Enrichment analysis
+    pval = 0.05,
+    min_count = 3,
+    ont = "BP",
+    annot_pkg =  "org.Sc.sgd.db",
+
+    #' Network analysis
+    method_corr = "cosine",
+    thres_corr = 0.7,
+
+    #' output: pre-processing
+    pre_proc_pdf       = paste0(tool_dir, "test-data/res/pre_proc.pdf"),
+    df_stats_out       = paste0(tool_dir, "test-data/res/df_stats.tsv"),
+    outl_out           = paste0(tool_dir, "test-data/res/outl.tsv"),
+    data_wide_out      = paste0(tool_dir, "test-data/res/data_wide.tsv"),
+    data_wide_symb_out = paste0(tool_dir, "test-data/res/data_wide_symb.tsv"),
+
+    #' output: exploratory analysis
+    expl_anal_pdf = paste0(tool_dir, "test-data/res/expl_anal.pdf"),
+
+    #' output: clustering analysis
+    clus_anal_pdf = paste0(tool_dir, "test-data/res/clus_anal.pdf"),
+
+    #' output: enrichment analysis
+    go_en_out = paste0(tool_dir, "test-data/res/go_en.tsv"),
+
+    #' output: network analysis
+    gene_net_pdf = paste0(tool_dir, "test-data/res/gene_net.pdf"),
+    imbe_out     = paste0(tool_dir, "test-data/res/impact_betweenness.tsv")
+  )
+}
+#' print(opt)
+
+suppressPackageStartupMessages({
+  source(paste0(tool_dir, "ionflow_funcs.R"))
+})
+
+## ==== Data preparation ====
+ion_data <- read.table(opt$ion_file, header = T, sep = ",")
+
+if (opt$batch_control == "yes") {
+  control_lines <- opt$control_line
+} else {
+  control_lines <- NULL
+}
+
+if (opt$stand_method == "custom") { #' if (lenth(opt$std_file) > 0) {
+  stdev <- read.table(opt$std_file, header = T, sep = "\t")
+} else {
+  stdev <- NULL
+}
+
+## ==== Pre-processing ====
+pre <- PreProcessing(data            = ion_data,
+                     var_id          = opt$var_id,
+                     batch_id        = opt$batch_id,
+                     data_id         = opt$data_id,
+                     method_norm     = opt$method_norm,
+                     control_lines   = control_lines,
+                     control_use     = opt$control_use,
+                     method_outliers = opt$method_outliers,
+                     thres_outl      = opt$thres_outl,
+                     stand_method    = opt$stand_method,
+                     stdev           = stdev,
+                     thres_symb      = opt$thres_symb)
+
+#' save plot in pdf
+pdf(file = opt$pre_proc_pdf, onefile = T) # width = 15, height = 10
+plot(pre$plot.hist)
+plot(pre$plot.overview)
+plot(pre$plot.medians)
+plot(pre$plot.CV)
+plot(pre$plot.change.stat)
+plot(pre$plot.change.dir)
+dev.off()
+
+#' combine stats
+df_stats <- list(raw_data = pre$stats.raw.data,
+                 bat_data = pre$stats.batches)
+df_stats <- dplyr::bind_rows(df_stats, .id = "Data_Set")
+row.names(df_stats) = NULL
+
+#' save tables
+write.table(df_stats, file = opt$df_stats_out, sep = "\t", row.names = F)
+write.table(pre$stats.outliers, file = opt$outl_out, sep = "\t",
+            row.names = F)
+write.table(pre$data.line.zscores, file = opt$data_wide_out, sep = "\t",
+            row.names = F)
+write.table(pre$data.line.symb, file = opt$data_wide_symb_out,
+            sep = "\t", row.names = F)
+
+## ==== Exploratory analysis ====
+
+pdf(file = opt$expl_anal_pdf, onefile = T)
+expl <- IonAnalysis(data = pre$data.line.zscores,
+                    thres_ion_corr = opt$thres_ion_corr)
+plot(expl$plot.pca)
+plot(expl$plot.net)
+dev.off()
+
+## ==== Clustering analysis ====
+
+gcl <- ProfileClustering(pre$data.line.symb,
+                         min_clust_size = opt$min_clust_size,
+                         h_tree = opt$h_tree,
+                         filter_zero_string = opt$filter_zero_string)
+
+#' select larger clusters
+cluster_vector <-
+  gcl$clusters.vector[gcl$clusters.vector$Cluster %in%
+                      gcl$tab.clusters.subset$Cluster, ]
+
+#' extract symbolic and z-score prifiles for lines in selected clusters
+symbol_profiles <- pre$data.line.symb
+symbol_profiles$Cluster <-
+  cluster_vector$Cluster[match(symbol_profiles$Line, cluster_vector$Line)]
+
+zscore_profiles <- pre$data.line.zscores
+zscore_profiles$Cluster <-
+  cluster_vector$Cluster[match(zscore_profiles$Line, cluster_vector$Line)]
+
+#' remove lines showing no phenotype
+symbol_profiles <- symbol_profiles[!is.na(symbol_profiles$Cluster),]
+zscore_profiles <- zscore_profiles[!is.na(zscore_profiles$Cluster),]
+
+mat_long <- reshape2::melt(zscore_profiles, id = c("Line", "Cluster"),
+                 variable.name = "Ion", value.name = "zscore")
+
+mat_long$n.genes <-
+  gcl$tab.clusters.subset$Number.of.genes[match(mat_long$Cluster,
+                                                gcl$tab.clusters.subset$Cluster)]
+mat_long$title <- paste0('Cluster ', mat_long$Cluster,' (',
+                         mat_long$n.genes, ' genes)')
+
+p_gcl <-
+  ggplot(data = mat_long, aes(x = Ion, y = zscore, group = Line), color = "gray") +
+  geom_line() +
+  stat_summary(fun.data = "mean_se", color = "red", geom = "line", group = 1) +
+  labs(x = "", y = "z-score") +
+  coord_cartesian(ylim = c(-8, 8)) +
+  facet_wrap(~title) +
+  theme(legend.position = "none",
+        axis.text.x = element_text(angle = 90, hjust = 1),
+        axis.text = element_text(size = 10))
+
+pdf(file = opt$clus_anal_pdf, onefile = T)
+plot(p_gcl)
+dev.off()
+
+## ==== Enrichment analysis ====
+
+ge <- GOEnricher(cluster_vector,
+                 pval = opt$pval,
+                 min_count = opt$min_count,
+                 annot_pkg = opt$annot_pkg,
+                 ont = opt$ont,
+                 gene_uni = as.character(pre$data.line.zscores$Line))
+
+if (nrow(ge$enrichment.summary) > 0) {
+  write.table(ge$enrichment.summary, file = opt$go_en_out, sep = "\t",
+              row.names = FALSE)
+}
+
+## ==== Network analysis ====
+
+gn <- GeneticNetwork(data                 = zscore_profiles,
+                     method_corr          = opt$method_corr,
+                     thres_corr           = opt$thres_corr,
+                     network_modules      = "input",
+                     cluster_vector       = cluster_vector,
+                     cluster_label_vector = NULL)
+
+pdf(file = opt$gene_net_pdf, onefile = T) # width = 15, height = 10
+plot(gn$plot.network)
+plot(gn$plot.impact_betweenness)
+dev.off()
+
+write.table(gn$stats.impact_betweenness, file = opt$imbe_out,
+            sep = "\t", row.names = FALSE)
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/ionflow/ionflow.xml	Mon Aug 09 09:41:22 2021 +0000
@@ -0,0 +1,437 @@
+<!--
+wl-10-08-2020, Mon: commence
+wl-24-08-2020, Mon: first version
+wl-16-11-2020, Mon: second version
+wl-23-03-2021, Tue: third version
+wl-08-06-2021, Tue: fourth version: new stuff from Jacopo
+-->
+
+<tool id="ionfow" name="IonFlow" version="0.4.0">
+  <description>
+    Pipeline for processing and analysis of ionomics data
+  </description>
+  <macros>
+    <import>macros.xml</import>
+  </macros>
+  <expand macro="requirements" />
+  <expand macro="stdio" />
+
+  <!-- =============================================================== -->
+  <command detect_errors="exit_code">
+    <![CDATA[
+
+      Rscript ${__tool_directory__}/ionflow.R
+        ## Input
+        --ion_file '$ion_file'
+        --var_id '$pre.var_id'
+        --batch_id '$pre.batch_id'
+        --data_id '$pre.data_id'
+        --method_norm '$pre.method_norm'
+        --batch_control '$pre.batch.batch_control'
+        #if $pre.batch.batch_control=='yes'
+          --control_lines '$pre.batch.control_lines'
+          --control_use '$pre.batch.control_use'
+        #end if
+        --method_outliers '$pre.method_outliers'
+        --thres_outl '$pre.thres_outl'
+        --stand_method '$pre.stand.stand_method'
+        #if $pre.stand.stand_method=='custom':
+          --std_file '$pre.stand.std_file'
+        #end if
+        --thres_symb '$pre.thres_symb'
+
+        ## Exploratory analysis
+        --thres_ion_corr '$expl.thres_ion_corr'
+
+        ## Clustering analysis
+        --min_clust_size '$clus.min_clust_size'
+        --h_tree '$clus.h_tree'
+        --filter_zero_string '$clus.filter_zero_string'
+
+        ## Enrichment analysis
+        --pval '$enri.pval'
+        --min_count '$enri.min_count'
+        --ont '$enri.ont'
+        --annot_pkg '$enri.annot_pkg'
+
+        ## Network analysis
+        --method_corr '$net.method_corr'
+        --thres_corr '$net.thres_corr'
+
+        ## output: pre-processing
+        --pre_proc_pdf  '$pre_proc_pdf'
+        --df_stats_out  '$df_stats_out'
+        --outl_out  '$outl_out'
+        --data_wide_out  '$data_wide_out'
+        --data_wide_symb_out  '$data_wide_symb_out'
+
+        ## output: exploratory analysis
+        --expl_anal_pdf  '$expl_anal_pdf'
+
+        ## output: clustering analysis
+        --clus_anal_pdf  '$clus_anal_pdf'
+
+        ## output: enrichment analysis
+        --go_en_out  '$go_en_out'
+
+        ## output: network analysis
+        --gene_net_pdf  '$gene_net_pdf'
+        --imbe_out  '$imbe_out'
+    ]]>
+  </command>
+
+  <!-- =============================================================== -->
+  <inputs>
+    <param name="ion_file" type="data" format="csv"
+           label="Ion data table"
+           help="Ion data table with columns of Ions and meta information." />
+
+    <!-- start of pre -->
+    <section name="pre" title="Pre Processing" >
+
+      <param name="var_id" type="integer" value="1"
+             label="Specify variable column index of input data"
+             help="Indicate which column will be the variable (ORF or SYMBOL)." />
+
+      <param name="batch_id" type="integer" value="3"
+             label="Specify batch ID column index of input data"
+             help="Indicate which column will be batch ID." />
+
+      <param name="data_id" type="integer" value="5"
+             label="Specify data start column index of input data"
+             help="Indicate which column will be the start of data matrix." />
+
+      <param name="method_norm" type="select"
+             label="Select a method for batch correction">
+      <option value="median" selected="true">Median</option>
+      <option value="median+std">Median plus std</option>
+      <option value="none">None</option>
+      </param>
+
+      <!-- batch control -->
+      <conditional name="batch">
+        <param name="batch_control" type="select"
+               label="Use control lines for batch correction or not" >
+        <option value="yes" selected="true">Yes</option>
+        <option value="no">No</option>
+        </param>
+
+        <when value="yes">
+          <param name="control_lines" type="text" value="BY4741"
+                 label="Specify batch control lines (rows)">
+          <sanitizer>
+            <valid initial="string.ascii_letters,string.digits"></valid>
+          </sanitizer>
+          </param>
+
+          <param name="control_use" type="select"
+                 label="Select lines for batch correction">
+          <option value="control">Use control lines for batch correction</option>
+          <option value="all" selected="true">Use all lines for batch correction</option>
+          <option value="control.out">Use all lines except control lines for batch correction</option>
+          </param>
+        </when>
+
+        <when value="no">
+        </when>
+      </conditional>
+
+      <param name="method_outliers" type="select"
+             label="Select a method for outlier detection">
+      <option value="IQR">IQR</option>
+      <option value="mad">MAD</option>
+      <option value="log.FC.dist" selected="true">log FC dist</option>
+      <option value="none">none</option>
+      </param>
+
+      <param name="thres_outl" type="float" value="3.0"
+             label="Specify outlier detection threshold" />
+
+      <!-- standardisation method -->
+      <conditional name="stand">
+        <param name="stand_method" type="select"
+              label="Select a method for standardisation">
+        <option value="std" selected="true">STD</option>
+        <option value="mad">MAD</option>
+        <option value="custom">Custom</option>
+        </param>
+
+        <when value="custom">
+          <param name="std_file" type="data"  format="tabular"
+                 label="STD file"
+                 help="A data matrix with only two columns. The fisrt
+                       column is the names of ion and the second one is std
+                       values. " />
+        </when>
+      </conditional>
+
+      <param name="thres_symb" type="float" value="2.0"
+             label="Specify symbolisation threshold" />
+
+    </section>
+    <!-- end of pre -->
+
+    <section name="expl" title="Exploratory analysis" >
+      <param name="thres_ion_corr" type="float" value="0.15"
+             label="Threshold for Ion correlation (0 - 1)" />
+    </section>
+
+    <section name="clus" title="Clustering analysis" >
+      <param name="min_clust_size" type="float" value="10.0"
+             label="Specify minimal cluster center number" />
+      <param name="h_tree" type="float" value="0.0"
+             label="Cutting height for hierarchical clustering" />
+      <param name="filter_zero_string" type="boolean" truevalue="True"
+             falsevalue="False" checked="True"
+             label="Filter the zero string?" />
+    </section>
+
+    <section name="enri" title="Enrichment analysis" >
+      <param name="pval" type="float" value="0.05"
+             label="Specify p-value threshold for enrichment analysiss" />
+      <param name="min_count" type="float" value="3.0"
+             label="Minimal count number for enrichment analysis" />
+      <param name="ont" type="select"
+             label="Select gene ontology for GO Terms">
+      <option value="BP" selected="true">BP</option>
+      <option value="MF">MF</option>
+      <option value="CC">CC</option>
+      </param>
+      <param name="annot_pkg" type="select"
+            label="Select an annotation package">
+      <option value="org.Sc.sgd.db" selected="true">Yeast(org.Sc.sgd.db)</option>
+      <option value="org.Hs.eg.db">Human(org.Hs.eg.db)</option>
+      <option value="org.Mm.eg.db">Mouse(org.Mm.eg.db)</option>
+      </param>
+    </section>
+
+    <section name="net" title="Network analysis" >
+      <param name="method_corr" type="select"
+             label="Select a method for similarity measure">
+      <option value="pearson">Pearson</option>
+      <option value="spearman">Spearman</option>
+      <option value="kendall">Kendall</option>
+      <option value="cosine" selected="true">Cosine</option>
+      <option value="mahal_cosine">Mahalanobis Cosine</option>
+      <option value="hybrid_mahal_cosine">Hybrid Mahalanobis Cosine</option>
+      </param>
+      <param name="thres_corr" type="float" value="0.7" min="0" max="1"
+             label="Specify similarity threshold (0 - 1)" />
+    </section>
+
+  </inputs>
+
+
+  <!-- =============================================================== -->
+  <outputs>
+    <data format="pdf" name="pre_proc_pdf"
+          label="Pre-processing plots for Ions on ${on_string}" />
+    <data format="tabular" name="df_stats_out"
+          label="Statistical summary of data set on ${on_string}"/>
+    <data format="tabular" name="outl_out"
+          label="Outlier table on ${on_string}"/>
+    <data format="tabular" name="data_wide_out"
+          label="Pre-processed data in wide format on ${on_string}"/>
+    <data format="tabular" name="data_wide_symb_out"
+          label="Symbolization data in wide format on ${on_string}"/>
+    <data format="pdf" name="expl_anal_pdf"
+          label="Explanatation analysis plots for Ions on ${on_string}" />
+    <data format="pdf" name="clus_anal_pdf"
+          label="Explanatation analysis plots for Ions on ${on_string}" />
+    <data format="tabular" name="go_en_out"
+          label="GO enrichment table on ${on_string}"/>
+    <data format="pdf" name="gene_net_pdf"
+          label="Gene network plots on ${on_string}" />
+    <data format="tabular" name="imbe_out"
+          label="Impact and betweenness table on ${on_string}"/>
+  </outputs>
+
+  <!-- =============================================================== -->
+  <tests>
+    <test>
+      <param name="ion_file" value="Dataset_IonFlow_Ionome_KO_short.csv" />
+      <param name="var_id" value="1" />
+      <param name="batch_id" value="3" />
+      <param name="data_id" value="5" />
+      <param name="method_norm" value="median" />
+      <param name="batch_control" value="yes" />
+      <param name="control_lines" value="BY4741" />
+      <param name="control_use" value="all" />
+      <param name="method_outliers" value="log.FC.dist" />
+      <param name="thres_outl" value="3.0" />
+      <param name="stand_method" value="std" />
+      <param name="thres_symb" value="2" />
+      <param name="thres_ion_corr" value="0.15" />
+      <param name="min_clust_size" value="10.0" />
+      <param name="h_tree" value="0.0" />
+      <param name="filter_zero_string" value="TRUE" />
+      <param name="pval" value="0.05" />
+      <param name="min_count" value="3" />
+      <param name="ont" value="BP" />
+      <param name="annot_pkg" value="org.Sc.sgd.db" />
+      <param name="method_corr" value="cosine" />
+      <param name="thres_corr" value="0.7" />
+      <output name="pre_proc_pdf" file="res/pre_proc.pdf" compare="sim_size" />
+      <output name="df_stats_out" file="res/df_stats.tsv" compare="diff" />
+      <output name="outl_out" file="res/outl.tsv" compare="diff" />
+      <output name="data_wide_out" file="res/data_wide.tsv" compare="diff" />
+      <output name="data_wide_symb_out" file="res/data_wide_symb.tsv" compare="diff" />
+      <output name="expl_anal_pdf" file="res/expl_anal.pdf" compare="sim_size" />
+      <output name="clus_anal_pdf" file="res/clus_anal.pdf" compare="sim_size" />
+      <output name="go_en_out" file="res/go_en.tsv" compare="diff" />
+      <output name="gene_net_pdf" file="res/gene_net.pdf" compare="sim_size" />
+      <output name="imbe_out" file="res/impact_betweenness.tsv" compare="diff" />
+    </test>
+  </tests>
+
+  <!-- =============================================================== -->
+<help>
+IonFlow  Pipeline
+=================
+
+Description
+-----------
+
+This galaxy tool wraps R package IonFlow_ with modification to process
+ionomics data to aid reproducible data sharing and big data initiatives.
+
+The pipeline includes:
+
+Pre-Processing
+  This procedure performs batch correction with or without control lines,
+  outlier detection and data standardisation. The processed concentration
+  data and a symbolisation profile data are returned for further analysis.
+
+Exploratory Analysis
+  This procedure performs correlation analysis and PCA analysis in terms of
+  ions. The heatmap with hierarchical clustering and network graph are based
+  on the correlation analysis.
+
+Clustering Analysis
+  This step performs hierarchical clustering based on symbolised profile.
+  The selected cluster centres (control by the threshold of minimal cluster
+  centre number) are applied to enrichment and network analysis.
+
+Enrichment Analysis
+  This step uses the clustering results for enrichment analysis. Current suports
+  three annotation packages:
+
+  - Yeast(org.Sc.sgd.db)
+  - Human(org.Hs.eg.db)
+  - Mouse(org.Mm.eg.db)
+
+Network Analysis
+  This part uses hierarchical clustering of the symbolised profile
+  for network analysis. Genes with correlation coefficient large than a
+  threshold are then used. Some network analysis stats such as impact and
+  betweenness are also returned.
+
+.. _IonFlow: https://github.com/AlinaPeluso/MetaboFlow
+
+Inputs
+------
+
+Ionomics data
+~~~~~~~~~~~~~
+
+The input file is an ionomics data table in tubular format. The following is
+an example with the first two columns of knockout name and batch ID and
+other columns are ion data. To use this input data in ``Pre-processing`` , the
+user must indicate ``var_id`` as ``1`` (``Knockout``), ``batch_id`` as ``2``
+(``Batch_ID``) and ``data_id`` as ``3``. If the file has the batch control
+information in the first column, ``control_lines`` should indicate. For
+example, if ``YDL227C`` will be used as batch control, ``control_lines =
+"YDL227C"``.
+
+
+ +----------+----------+---------+-------+-------+--------+----------+---------+-------+---------+-------+----------+----------+
+ | Knockout | Batch_ID | Ca      | Cd    | Cu    | Fe     | K        | Mg      | Mo    | Na      | Ni    | P        | S        |
+ +----------+----------+---------+-------+-------+--------+----------+---------+-------+---------+-------+----------+----------+
+ | YDL227C  | 14       | 59.549  | 0.953 | 2.202 | 10.942 | 3448.070 | 693.992 | 1.603 | 259.816 | 1.573 | 4963.315 | 556.397  |
+ +----------+--+-------+---------+-------+-------+--------+----------+---------+-------+---------+-------+----------+----------+
+ | YDL227C  | 14       | 62.258  | 0.927 | 2.067 | 26.262 | 3493.741 | 705.008 | 2.691 | 273.640 | 4.443 | 4874.101 | 553.229  |
+ +----------+--+-------+---------+-------+-------+--------+----------+---------+-------+---------+-------+----------+----------+
+ | YDL227C  | 14       | 65.075  | 0.875 | 2.048 | 10.244 | 3317.611 | 691.411 | 1.878 | 278.167 | 1.448 | 4608.300 | 535.609  |
+ +----------+--+-------+---------+-------+-------+--------+----------+---------+-------+---------+-------+----------+----------+
+ | YDL227C  | 14       | 56.886  | 0.985 | 2.203 |  9.206 | 3330.854 | 702.734 | 1.396 | 268.609 | 1.640 | 5119.736 | 546.230  |
+ +----------+----------+---------+-------+-------+--------+----------+---------+-------+---------+-------+----------+----------+
+
+|
+
+Custom STD data
+~~~~~~~~~~~~~~~
+
+Standard derivation values can be provide by user if standardisation method
+``stand_method`` in pre-processing procedure is selected as ``custom``. The
+user defined std file has tabular format such as:
+
+  +------+----------+
+  |  Ion |   sd     |
+  +------+----------+
+  |  Ca  | 0.150    |
+  +------+----------+
+  |  Fe  | 0.163    |
+  +------+----------+
+  |  K   | 0.094    |
+  +------+----------+
+  |  Mg  | 0.059    |
+  +------+----------+
+  |  Na  | 0.107    |
+  +------+----------+
+  |  Ni  | 0.078    |
+  +------+----------+
+  |  Zn  | 0.067    |
+  +------+----------+
+
+|
+
+Outputs
+-------
+
+Pre-processing
+~~~~~~~~~~~~~~
+
+The output includes:
+
+- A PDF file for the plots:  dot-plot with ion vs batch and distribution
+  plot of ions.
+- A tabular file for statistical summary of data set
+- A tabular file for outlier table
+- A tabular file for processed data set
+- A tabular file for the symbolisation data set
+
+Exploratory analysis
+~~~~~~~~~~~~~~~~~~~~
+
+A single PDF file with plots:
+
+- Correlation map
+- Heatmap with dendrogram
+- PCA plot
+- Correlation network graph
+
+Clustering analysis
+~~~~~~~~~~~~~~~~~~~
+
+A single PDF file with clustering plots.
+
+Enrichment analysis
+~~~~~~~~~~~~~~~~~~~
+
+A tabular file for GO Terms enrichment table.
+
+Network analysis
+~~~~~~~~~~~~~~~~
+
+Two files are returned:
+
+- A PDF file for plots
+  - network graph
+  - impact scatter plot
+- A tabular file for impact and betweenness table
+
+
+</help>
+  <citations>
+  </citations>
+</tool>
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/ionflow/ionflow_funcs.R	Mon Aug 09 09:41:22 2021 +0000
@@ -0,0 +1,898 @@
+#' =======================================================================
+#'
+PreProcessing <- function(data = NULL, var_id = 1, batch_id = 3, data_id = 5,
+                          method_norm = c("median", "median+std", "none"),
+                          control_lines = NULL,
+                          control_use = c("control", "all", "control.out"),
+                          method_outliers = c("mad", "IQR", "log.FC.dist", "none"),
+                          thres_outl = 3,
+                          stand_method = c("std", "mad", "custom"),
+                          stdev = NULL, thres_symb = 2) {
+
+
+  #' -------------------> Import data
+  #' ji: get sample id
+  data$sample_id <- rownames(data)
+
+  data <- data[, c(var_id, ncol(data), batch_id, data_id:(ncol(data) - 1))]
+  names(data)[1:3] <- c("Line", "Sample_ID", "Batch_ID")
+  mat <- data[, -c(1:3)]
+
+  #' ji: Remove samples with zeros or negative or missing values
+  data <- data[!is.na(sum(mat)), ]
+  data <- data[!(sum(mat <= 0) > 0), ]
+
+  #' get summary stats
+  res <- as.data.frame(t(sapply(mat, function(x) {
+    c(round(summary(x), 3), round(var(x), 3))
+  })))
+  names(res)[ncol(res)] <- "Variance"
+  res <- cbind(Ion = names(mat), res)
+  rownames(res) <- NULL
+  df_raw <- res
+
+  #' data long format
+  data_long <- reshape2::melt(data,
+    id = c("Line", "Sample_ID", "Batch_ID"), variable.name = "Ion",
+    value.name = "Concentration"
+  )
+
+  #' convert to factors before using levels function.
+  data_long$Line <- factor(data_long$Line)
+  data_long$Ion <- factor(data_long$Ion)
+  ion_name <- levels(data_long$Ion)
+
+  #' -------------------> Median batch correction
+  data_long$control <- rep(1, length(data_long$Concentration))
+  data_long$log <- log(data_long$Concentration)
+
+  #' ji: control use in batch correction
+  if (length(control_lines) > 0) {
+    if (control_use == "all") { }
+    if (control_use == "control") {
+      data_long$control[!(data_long$Line %in% control_lines)] <- 0
+    }
+    if (control_use == "control.out") {
+      data_long$control[data_long$Line %in% control_lines] <- 0
+    }
+  }
+
+  #' batch correction methods
+  if (method_norm == "median") {
+    data_long <- plyr::ddply(data_long, "Ion", function(x) {
+      res <- plyr::ddply(x, "Batch_ID", function(y) {
+        med <- median(y$log[y$control == 1])
+        y$log_corr <- y$log - med
+        y$med <- med
+        y
+      })
+    })
+  }
+  if (method_norm == "median+std") {
+    data_long <- plyr::ddply(data_long, "Ion", function(x) {
+      res <- plyr::ddply(x, "Batch_ID", function(y) {
+        med <- median(y$log[y$control == 1])
+        st_de <- sd(y$log[y$control == 1])
+        y$log_corr <- y$log - med - st_de
+        y$med <- med
+        y
+      })
+    })
+  }
+  if (method_norm == "none") {
+    data_long$log_corr <- data_long$log
+    data_long$med <- NULL
+  }
+
+  #' get correction stats
+  res <- plyr::ddply(data_long, "Ion", function(x) {
+    c(round(summary(x$log_corr), 3), round(var(x$log_corr), 3))
+  })
+  names(res)[ncol(res)] <- "Variance"
+  df_bat <- res
+
+  #' -------------------> Outlier detection
+
+  #' ji: outlier detection methods
+  if (method_outliers == "IQR") {
+    data_long <- plyr::ddply(data_long, "Ion", function(x) {
+      res <- plyr::ddply(x, "Batch_ID", function(y) {
+        lowerq <- quantile(y$log_corr, na.rm = T)[2]
+        upperq <- quantile(y$log_corr, na.rm = T)[4]
+        iqr <- upperq - lowerq
+        extreme.t.upper <- (iqr * thres_outl) + upperq
+        extreme.t.lower <- lowerq - (iqr * thres_outl)
+        y$Outlier <- ifelse((y$log_corr > extreme.t.upper) |
+          (y$log_corr < extreme.t.lower), 1, 0)
+        return(y)
+      })
+    })
+  }
+  if (method_outliers == "mad") {
+    data_long <- plyr::ddply(data_long, "Ion", function(x) {
+      res <- plyr::ddply(x, "Batch_ID", function(y) {
+        med_dev <- mad(y$log_corr)
+        extreme.t.upper <- (med_dev * thres_outl)
+        extreme.t.lower <- -(med_dev * thres_outl)
+        y$Outlier <- ifelse((y$log_corr > extreme.t.upper) |
+          (y$log_corr < extreme.t.lower), 1, 0)
+        return(y)
+      })
+    })
+  }
+  if (method_outliers == "log.FC.dist") {
+    data_long <- plyr::ddply(data_long, "Ion", function(x) {
+      res <- plyr::ddply(x, "Batch_ID", function(y) {
+        extreme.t.upper <- thres_outl
+        extreme.t.lower <- -thres_outl
+        y$Outlier <- ifelse((y$log_corr > extreme.t.upper) |
+          (y$log_corr < extreme.t.lower), 1, 0)
+        return(y)
+      })
+    })
+  }
+
+  if (method_outliers == "none") {
+    data_long$Outlier <- rep(0, length(data_long$Line))
+    df_outlier <- data.frame()
+  } else {
+    df_outlier <- data.frame(cbind(
+      levels(data_long$Ion),
+      table(data_long$Ion, data_long$Outlier),
+      round(table(data_long$Ion, data_long$Outlier)[, 2] /
+            dim(data_long)[1] * 100, 2)
+    ))
+    rownames(df_outlier) <- c()
+    colnames(df_outlier) <- c("Ion", "no_outlier", "outlier", "outlier(%)")
+  }
+
+  #' ji: remove samples with at least an outlier value
+  samples_to_exclude <- unique(data_long$Sample_ID[data_long$Outlier == 1])
+  data_long <- data_long[!(data_long$Sample_ID %in% samples_to_exclude), ]
+
+  #' -------------------> Standardisation
+
+  #' ji: standardisation methods
+  if (stand_method == "std") {
+    sds <- plyr::ddply(data_long, "Ion", function(x) sd(x$log_corr))
+    nam <- sds[, 1]
+    sds <- as.numeric(as.vector(sds[, 2]))
+    names(sds) <- nam
+  }
+  if (stand_method == "mad") {
+    sds <- plyr::ddply(data_long, "Ion", function(x) mad(x$log_corr))
+    nam <- sds[, 1]
+    sds <- as.numeric(as.vector(sds[, 2]))
+    names(sds) <- nam
+  }
+  if (stand_method == "custom") {
+    # specific 2-columns format for vector of sd
+    sds <- stdev
+    nam <- sds[, 1]
+    sds <- as.numeric(as.vector(sds[, 2]))
+    names(sds) <- nam
+  }
+
+  #' ji: aggregate measurements at line level (median)
+  data_wide_line_log_norm <- reshape2::dcast(data_long, Line ~ Ion,
+    fun.aggregate = median,
+    value.var = "log_corr"
+  )
+
+  #' ji: normalise by stds
+  data_wide_line_z_score <- data_wide_line_log_norm
+  data_wide_line_z_score[, 2:ncol(data_wide_line_z_score)] <- data_wide_line_z_score[, 2:ncol(data_wide_line_z_score)] / sds
+
+  #' -------------------> Symbolisation
+  symb_profiles <- data_wide_line_z_score[, 2:ncol(data_wide_line_z_score)]
+  symb_profiles[(symb_profiles > -thres_symb) & (symb_profiles < thres_symb)] <- 0
+  symb_profiles[symb_profiles >= thres_symb] <- 1
+  symb_profiles[symb_profiles <= -thres_symb] <- -1
+
+  #' ji: save sybolic profiles
+  data_wide_line_symb <- cbind(Line = data_wide_line_z_score$Line, symb_profiles)
+
+  #' plot z-score distributions
+  p1 <- ggplot(
+      data = data_long,
+      aes(x = factor(Batch_ID), y = log_corr, col = factor(Batch_ID))
+    ) +
+    geom_point(shape = 1) +
+    facet_wrap(~Ion) +
+    xlab("Batch.ID") +
+    ylab("Log FC to batch median") +
+    theme(legend.position = "none") +
+    theme(axis.text.x = element_blank(), axis.ticks.x = element_blank())
+
+  # plot overview processed samples
+  dat <- reshape2::melt(data_wide_line_z_score, id = "Line")
+  p2 <- ggplot(data = dat, aes(x = value)) +
+    geom_histogram(binwidth = .1) +
+    facet_wrap(~variable) +
+    xlab("Concentration (z-score)") +
+    ylab("Counts") +
+    xlim(-10, 10) +
+    geom_vline(xintercept = c(-thres_symb, thres_symb), col = "red")
+
+  # Histogram Number of Elements Changed
+  ions.changed <- rowSums(abs(data_wide_line_symb[,2:ncol(data_wide_line_symb)]))
+   
+  p3 <- ggplot(data=data.frame(table(ions.changed)), aes(x=ions.changed, y=Freq)) + 
+               geom_bar(stat="identity") +
+               xlab("Number of Elements Changed") +
+               ylab("Number of Mutants");
+   
+  # Histogram number of changes per element
+  ions.up <- colSums((data_wide_line_symb[,2:ncol(data_wide_line_symb)])==1)
+  ions.down <- colSums((data_wide_line_symb[,2:ncol(data_wide_line_symb)])==-1)
+  
+  ions.direction <- data.frame(hist.name = names(c(ions.down, ions.up)),
+                               hist.val = c(ions.down, ions.up),    
+                               hist.type = c(rep("down",length(ions.down)), rep("up",length(ions.up)))
+                               )
+  
+  p4 <- ggplot(data=ions.direction, aes(fill=hist.type, x=hist.name, y=hist.val)) + 
+    geom_bar(position="stack", stat="identity") +
+    scale_fill_manual(values=c("down"="blue","up"="red")) +
+    theme(legend.title = element_blank()) +
+    ylab("Number of Mutants") +
+    xlab("");
+  
+  if (method_norm != "none"){
+  # plot batch median log-concentrations
+  plot.data.long <- data_long[data_long["Outlier"]==0, ] 
+  batch_median_ions <- plot.data.long[!duplicated(plot.data.long[,"med"]), c("Batch_ID","Ion","med"), drop = FALSE];
+  
+  ion.batch.mean.median <- batch_median_ions %>%
+    dplyr::group_by(Ion) %>%
+    dplyr::summarize(mean = mean(med, na.rm = TRUE)) 
+  
+  ion.order <- as.character(ion.batch.mean.median$Ion[sort.list(ion.batch.mean.median$mean)],  decreasing = TRUE)
+  
+  batch_median_ions$Ion <- factor(batch_median_ions$Ion, levels = ion.order)
+  
+  p5 <- ggplot(batch_median_ions, aes(x=Ion, y=med, group = Batch_ID)) +
+      geom_line(aes(), color = "gray") +
+      theme(text = element_text(size=20), axis.title.x=element_blank()) +
+      ylab("Log-concentration") +
+      stat_summary(aes(y = med, group=1), fun = mean, colour="green1", geom="line", group=1) + 
+      stat_summary(fun.min = function(x) mean(x) - sd(x), fun.max = function(x) mean(x) + sd(x), position ='dodge', 
+                   colour="green1", geom = 'errorbar', aes(group = 1), width=.1)+
+      ggtitle("Median log-concentrations of batches");
+  
+    # plot CV batch median log-concentrations
+  ion.batch.cv.median <- batch_median_ions %>%
+      dplyr::group_by(Ion) %>%
+      dplyr::summarize(CV = sd(med, na.rm = TRUE)/mean(med, na.rm = TRUE)) 
+  
+  ion.batch.cv.median <- data.frame(ion.batch.cv.median)
+  
+  ion.batch.cv.median <- ion.batch.cv.median[order(ion.batch.cv.median$CV),]
+  
+  ion.batch.cv.median$Ion <- factor(ion.batch.cv.median$Ion, levels = ion.batch.cv.median$Ion)
+  
+  p6 <- ggplot(ion.batch.cv.median, aes(x=Ion, y=abs(CV), group =1)) +
+      ylab(" Absolute CV") +
+      geom_line(aes(), color = "red") +
+      theme(text = element_text(size=20), axis.title.x=element_blank()) +
+      scale_y_log10() +
+      ggtitle("CV median log-concentrations across batches");
+  
+  }else{
+      p5 <- NULL
+      p6 <- NULL
+  }
+  
+  #' -------------------> Output
+  res                    <- list()
+  res$stats.raw.data     <- df_raw                    # raw data
+  res$stats.outliers     <- df_outlier                # outliers
+  res$stats.batches      <- df_bat                    # batch corrected data
+  res$stats.std          <- sds                       # standard deviations
+  res$data.long          <- data_long                 # with Batch_ID
+  res$data.line.logFC    <- data_wide_line_log_norm
+  res$data.line.zscores  <- data_wide_line_z_score
+  res$data.line.symb     <- data_wide_line_symb
+  res$plot.overview      <- p1
+  res$plot.hist          <- p2
+  res$plot.change.stat   <- p3
+  res$plot.change.dir    <- p4
+  res$plot.medians       <- p5
+  res$plot.CV            <- p6
+  return(res)
+}
+
+#' =======================================================================
+#'
+IonAnalysis <- function(data = NULL, thres_ion_corr = 0.15, method_ion_corr = "pearson"){
+  
+  #' -------------------> PCA
+  ionProfile.PCA = NULL
+  ionProfile.PCA$pr.y = prcomp(data[, -1],scale. = F)
+  ionProfile.PCA$y = cbind(data.frame(Line = data$Line), as.data.frame(ionProfile.PCA$pr.y$x))
+  
+  unit.norm = function(x)(x / sqrt(sum(x^2)))
+  ionProfile.PCA$y[,grepl("^PC",colnames(ionProfile.PCA$y))] = apply(ionProfile.PCA$y[,grepl("^PC",colnames(ionProfile.PCA$y))],2,unit.norm)
+  
+  p.PCA.data = ionProfile.PCA$y %>%
+    dplyr::select(Line, PC1, PC2 )
+  
+  my.annotation = tbl_df(ionProfile.PCA$pr.y$rotation) %>%
+    dplyr::select(PC1, PC2) %>%
+    dplyr::mutate(Ion = row.names(ionProfile.PCA$pr.y$rotation)) %>%
+    `colnames<-`(c("x", "y", "Ion")) 
+  
+  p_pca <- p.PCA.data %>%
+    ggplot(aes(x = PC1, y = PC2)) +
+    geom_segment(inherit.aes = F, data = my.annotation,
+                 aes(x = 0, y = 0, xend = x/2, yend = y/2),
+                 color = "blue",
+                 arrow = arrow(length = unit(0.02, "npc")))+
+    geom_text(inherit.aes = F, data = my.annotation,
+              aes(x = 0.51*x, y = 0.51*y, label = Ion),
+              color = "red", size = 4) + 
+    geom_point(size = 1, alpha = 1/20) + 
+    theme(aspect.ratio = 1) +
+    scale_shape(solid = FALSE) +
+    labs(x = paste0("PC1",
+                    " (",round(summary(ionProfile.PCA$pr.y)$importance[2,"PC1"],2)*100,"%)"),
+         y = paste0("PC2"," (",
+                    round(summary(ionProfile.PCA$pr.y)$importance[2,"PC2"],2)*100,"%)"),
+         color = "changed")  
+  
+  #' PCA loading
+  pca_loadings <- data.frame(ionProfile.PCA$pr.y$rotation)
+  rownames(pca_loadings) <- colnames(data[, -1])
+  pca_loadings <- pca_loadings[, 1:2]
+  
+  
+  #' -------------------> Correlation
+  col3 <- colorRampPalette(c("steelblue4", "white", "firebrick"))
+  corrplot.mixed(cor(data[, -1], use = "complete.obs", method = method_ion_corr),
+    number.cex = .7,
+    lower.col = "black", upper.col = col3(100)
+  )
+  p_corr <- recordPlot()
+
+
+  #' -------------------> Heatmap with dendrogram
+  pheatmap(data[, -1], show_rownames = F, cluster_cols = T, cluster_rows = T,
+           legend = T, fontsize = 15, clustering_method = "ward.D",
+           scale = "row")
+  p_heat <- recordPlot()
+
+  #' -------------------> Correlation network
+  #' wl-13-08-2020, Thu: there is no 'qgraph' in conda forge and bio conda.
+  if (T) {
+    #' library(glasso)
+    #' corr_reg <- glasso(corr, rho = 0.01)
+    #' net <- network::network(corr_reg$w, directed = FALSE)
+    corr <- cor(na.omit(data[, -1]), method = method_ion_corr)
+    corr[abs(corr) < thres_ion_corr] <- 0
+    net <- network::network(corr[], directed = FALSE)
+
+    #' set edge attributes
+    net %e% "weight" <- corr
+    net %e% "weight_abs" <- abs(corr) * 6
+    net %e% "color" <- ifelse(net %e% "weight" > 0, "lightgreen", "coral")
+    p_net <-
+      ggnet2(net,
+        label = TRUE, mode = "fruchtermanreingold",
+        node.size = 10, edge.size = "weight_abs", edge.color = "color"
+      )
+  } else {
+    #' wl-06-07-2020, Mon: 'cor_auto' is from package qgraph(lavaan)
+    #' wl-28-07-2020, Tue: cad and corr are the same
+    cad <- cor_auto(data[, -1])
+    suppressWarnings(qgraph(cad,
+      graph = "glasso", layout = "spring",
+      tuning = 0.25, sampleSize = nrow(data[, -1])
+    ))
+    Graph_lasso <- recordPlot()
+  }
+
+  res <- list()
+  res$data.pca.load <- pca_loadings
+  res$plot.pca  <- p_pca
+  res$plot.corr <- p_corr
+  res$plot.net <- p_net
+  res$plot.heat <- p_heat
+  return(res)
+
+}
+
+
+
+#' =======================================================================
+#' wl-04-10-2020, Sun: Hierarchical clustering
+#' ji-10-01-2020, Sun: Input, Method, Output simplified
+
+ProfileClustering <- function(symbol_profiles, min_clust_size = 10, h_tree = 0, filter_zero_string = TRUE) {
+  
+  if (filter_zero_string){
+    symbol_profiles <- symbol_profiles[rowSums(symbol_profiles[, -1])!=0, ]  
+  }
+  x <- symbol_profiles[, -1] 
+  dis <- stats::dist(x, method = "manhattan")
+  hc <- hclust(d = dis, method = "single")
+  clus <- data.frame(Line = symbol_profiles$Line, Cluster = cutree(hc, h = h_tree))
+  
+  tab <- as.data.frame(table(clus$Cluster), stringsAsFactors = F)
+  names(tab) <- c("Cluster", "Number.of.genes")
+  
+  tab_subset <- tab[tab$Number.of.genes > min_clust_size, ]
+  tab_subset <- tab_subset[order(tab_subset$Number.of.genes, decreasing = T), ]
+  idx_subset <- clus %in% tab_subset$Cluster
+  
+  
+  res <- list()
+  res$clusters.vector <- clus
+  res$tab.clusters <- tab
+  res$tab.clusters.subset <- tab_subset
+
+  return(res)
+  
+}
+
+
+#' =======================================================================
+#' wl-06-11-2020, Fri: Get ENTREZID  from SYMBOL
+#'
+get_entrez_id <- function(gene_list, annot_pkg = "org.Sc.sgd.db", key_type = "ORF") {
+  
+  res <- AnnotationDbi::select(get(annot_pkg), keys = gene_list,
+                               columns = "ENTREZID", keytype = key_type)
+  res <- res[,2,drop = T]
+  res <- res[!is.na(res)]
+  res <- res[!duplicated(res)]
+
+  return(res)
+}
+
+#' =======================================================================
+#' wl-03-10-2020, Sat: KEGG enrichment analysis for symbolization data
+#' wl-06-11-2020, Fri: The first column of data must be ORF for
+#'  org.Sc.sgd.db or SYMBOL for any other annotation packages.
+#' ji-11-01-2020, Mon: Input, Method, Output simplified
+#' 
+
+KeggEnricher <- function(cluster_vector, pval = 0.05, 
+                        min_count = 3, annot_pkg = "org.Sc.sgd.db", 
+                        gene_uni = NULL) {
+
+  if(is.null(gene_uni)){
+    gene_uni <- as.character(cluster_vector$Line)
+  }
+  
+  clusters_set <- unique(cluster_vector$Cluster)
+  
+  #' geneIds can be ORF or ENTREZID
+  enrich <- lapply(clusters_set, function(x) {
+    params <- new("KEGGHyperGParams",
+                  geneIds = gene_uni[cluster_vector$Cluster == x],
+                  universeGeneIds = gene_uni,
+                  annotation = annot_pkg,
+                  categoryName = "KEGG",
+                  pvalueCutoff = pval,
+                  testDirection = "over")
+
+    over <- hyperGTest(params)
+  })
+
+  # name list with original clusters ID 
+  names(enrich) <- clusters_set
+  
+  #' There is no explicit methods for getting manual summary table.
+  summ <- lapply(enrich, function(x) {
+    tmp <- summary(x)
+    if (nrow(tmp) == 0) tmp <- NULL #' wl-04-10-2020, Sun: it happens very often.
+    return(tmp)
+  })
+  summ <- summ[!sapply(summ,is.null)]
+
+  #' binding and filtering
+  summ <- lapply(summ, "[", -c(3, 4)) %>%
+    dplyr::bind_rows(.id = "Cluster") %>%
+    dplyr::filter(Pvalue <= pval & Count >= min_count)
+
+  res <- list()
+  res$enrichment.summary <- summ
+  res$enrichment.full.results <- enrich
+  return(res)
+  
+  
+}
+
+#' =======================================================================
+#' wl-03-10-2020, Sat: GO enrichment analysis for symbolization data
+#' wl-06-11-2020, Fri: The first column of data must be ORF for
+#'  org.Sc.sgd.db or SYMBOL for any other annotation packages.
+#'
+GOEnricher <- function(cluster_vector, pval = 0.05, ont = c("BP","CC","MF"),
+                      min_count = 3, annot_pkg = "org.Sc.sgd.db",
+                      gene_uni = NULL) {
+  
+  if(is.null(gene_uni)){
+    gene_uni <- as.character(cluster_vector$Line)
+  }
+  
+  ont <- match.arg(ont)
+  
+  genes_not_annotated <- NULL
+  
+  if ( annot_pkg == "org.Sc.sgd.db"){
+    genes_not_annotated <- unlist(mget(
+      mappedkeys(org.Sc.sgdGO2ALLORFS)[which(is.na(Term(mappedkeys(org.Sc.sgdGO2ALLORFS))))], org.Sc.sgdGO2ALLORFS)
+      )
+    gene_uni <- mappedkeys(org.Sc.sgdGO)[mappedkeys(org.Sc.sgdGO) %in% gene_uni]
+  }
+  if ( annot_pkg == "org.Hs.eg.db"){
+    genes_not_annotated <- unlist(mget(
+      mappedkeys(org.Hs.egGO2ALLEGS)[which(is.na(Term(mappedkeys(org.Hs.egGO2ALLEGS))))], org.Hs.egGO2ALLEGS)
+    )
+    #gene_uni <- mappedkeys(org.Hs.egGO)
+    gene_uni <- mappedkeys(org.Hs.egGO)[mappedkeys(org.Hs.egGO) %in% gene_uni]
+  }
+  if ( annot_pkg == "org.Mm.eg.db"){
+    genes_not_annotated <- unlist(mget(
+      mappedkeys(org.Mm.egGO2ALLEGS)[which(is.na(Term(mappedkeys(org.Mm.egGO2ALLEGS))))], org.Mm.egGO2ALLEGS)
+    )
+    gene_uni <- mappedkeys(org.Mm.egGO)[mappedkeys(org.Mm.egGO) %in% cluster_vector$Line]
+  }  
+  
+  gene_uni <- as.character(gene_uni[!gene_uni %in% genes_not_annotated])
+    
+  cluster_vector <- cluster_vector[cluster_vector$Line %in% gene_uni,]
+  clusters_set <- unique(cluster_vector$Cluster)
+  
+  #' geneIds can be ORF or ENTREZID
+  enrich <- lapply(clusters_set, function(x) { 
+    gene_set <- as.character(cluster_vector$Line[cluster_vector$Cluster == x])
+    params <- new("GOHyperGParams",
+                  geneIds = gene_set,
+                  universeGeneIds = gene_uni,
+                  annotation = annot_pkg,
+                  categoryName = "GO",
+                  ontology = ont,
+                  pvalueCutoff = pval,
+                  conditional = T,
+                  testDirection = "over")
+
+    over <- hyperGTest(params)
+  })
+
+  # name list with original clusters ID 
+  names(enrich) <- clusters_set
+  
+  summ <- lapply(enrich, function(x) {
+    Pvalue        <- round(pvalues(x), digit = 4)
+    ID            <- names(Pvalue)
+    Description   <- Term(ID)
+    OddsRatio     <- oddsRatios(x)
+    ExpCount      <- expectedCounts(x)
+    Count         <- geneCounts(x)
+    CountUniverse <- universeCounts(x)
+
+    tab <- cbind(ID, Description, Pvalue, OddsRatio, ExpCount, Count, CountUniverse)
+    rownames(tab) <- NULL
+    tab <- na.omit(tab)   #' wl-03-10-2020, Sat: this is why summary fails.
+    tab <- data.frame(tab, Ontology = ont)
+  })
+
+  summ <- lapply(summ, "[", -c(4, 5)) %>%
+            dplyr::bind_rows(.id = "Cluster") %>%
+            dplyr::filter(Pvalue <= pval & Count >= min_count)
+
+  res <- list()
+  res$enrichment.summary <- summ
+  res$enrichment.full.results <- enrich
+  return(res)
+}
+
+
+
+
+GeneticNetwork <- function(data = NULL, 
+                        method_corr = c("pearson", "spearman", "kendall",
+                          "cosine", "mahal_cosine", "hybrid_mahal_cosine"),
+                        network_modules = c("louvain", "input"),
+                        thres_corr = 0.7,
+                        cluster_vector = NULL,
+                        cluster_label_vector = NULL,
+                        n_labels = 3
+                        ) {
+
+  
+  mat <- as.matrix(data[,!colnames(data)%in%c("Line","Cluster")])
+  
+
+  #' Compute similarity matrix
+  if (method_corr == "pearson" ||
+      method_corr == "spearman" ||
+      method_corr == "kendall") {
+    corrGenes <- cor(t(as.matrix(mat)), 
+                     method = method_corr,
+                     use = "pairwise.complete.obs")
+  } else if (method_corr == "cosine") {
+    corrGenes <- cosine(t(as.matrix(mat)))
+  } else if (method_corr == "mahal_cosine") {
+    corrGenes <- cosM(mat, mode = "normal")
+  } else if (method_corr == "hybrid_mahal_cosine") {
+    corrGenes <- cosM(mat, mode = "hybrid")
+  }
+
+  #' Adjacency matrix
+  A <- corrGenes
+  diag(A) <- 0
+  A <- (A > thres_corr)
+  A <- ifelse(A == TRUE, 1, 0)
+  
+  if (network_modules == "input"){
+   
+    if (length(cluster_label_vector) == 0){
+      cluster_vector <- as.character(cluster_vector$Cluster)
+    }else{
+      mm <- match(cluster_vector$Cluster, cluster_label_vector$Cluster)
+      cluster_vector <- cluster_label_vector$label[mm]
+    }
+    
+    tmp <- unique(cluster_vector)
+    if (length(tmp) != 1) {
+      cpy <- rainbow(length(tmp))
+      names(cpy) <- tmp
+    } else {
+      cpy <- "Set2"
+    }
+    
+  }
+  if (network_modules == "louvain"){
+    # community detection
+    tmp <- igraph::graph_from_adjacency_matrix(A, mode="undirected")
+    com <- igraph::cluster_louvain(tmp, weights = NULL)
+    cluster_vector <- as.character(igraph::membership(com))
+    degree_vector <- igraph::degree(tmp)
+  
+    tmp <- unique(cluster_vector)
+    if (length(tmp) != 1) {
+      cpy <- rainbow(length(tmp))
+      names(cpy) <- tmp
+    } else {
+      cpy <- "Set2"
+    }
+  }
+  
+  
+  #' Generate network
+  net <- network::network(A, directed = FALSE)
+  net %v% "Label" <- cluster_vector
+  
+  #' Remove communities of size 1
+  if (network_modules == "louvain"){
+    net <- delete.vertices(net, which(degree_vector == 0));
+  }
+  
+  net_p <- GGally::ggnet2(net,
+                           mode = "fruchtermanreingold",
+                           color = "Label",
+                           palette = cpy,
+                           edge.alpha = 0.5, size = 2, 
+                           color.legend = "Modules",
+                           legend.size = 10, 
+                           legend.position = "right"
+  )
+  
+  #' network edge list 
+  net <- as.matrix(net, matrix.type = "edgelist")[,1:2];
+  net[,] <- cbind(as.character(data$Line[net[,1]]), as.character(data$Line[net[,2]]))
+
+  #' Impact and betweenness
+  btw <- sna::betweenness(A) # or use 'net' instead of 'A'
+  impact <- apply(mat, 1, norm, type = "2") # L2 norm
+
+  df.res <- data.frame(
+    Line = data$Line,
+    impact = round(impact, 3),
+    betweenness = round(btw, 3),
+    log.betweenness = round(log(btw + 1), 3),
+    pos = factor(ifelse((impact < quantile(impact, .75)) & (log(btw + 1) < quantile(log(btw + 1), .75)), 1,
+      ifelse((impact < quantile(impact, .75)) & (log(btw + 1) > quantile(log(btw + 1), .75)), 2,
+        ifelse((impact > quantile(impact, .75)) & (log(btw + 1) < quantile(log(btw + 1), .75)), 3, 4)
+      )
+    )),
+    pos.label = factor(ifelse((impact < quantile(impact, .75)) & (log(btw + 1) < quantile(log(btw + 1), .75)), "Low impact, low betweenness",
+      ifelse((impact < quantile(impact, .75)) & (log(btw + 1) > quantile(log(btw + 1), .75)), "Low impact, high betweenness",
+        ifelse((impact > quantile(impact, .75)) & (log(btw + 1) < quantile(log(btw + 1), .75)), "High impact, low betweenness", "High impact, high betweenness")
+      )
+    ))
+  )
+  rownames(df.res) <- data$Line[]
+
+  q1 <- row.names(subset(df.res, (impact < quantile(impact, .75)) & (log.betweenness < quantile(log.betweenness, .75))))
+  q2 <- row.names(subset(df.res, (impact < quantile(impact, .75)) & (log.betweenness > quantile(log.betweenness, .75))))
+  q3 <- row.names(subset(df.res, (impact > quantile(impact, .75)) & (log.betweenness < quantile(log.betweenness, .75))))
+  q4 <- row.names(subset(df.res, (impact > quantile(impact, .75)) & (log.betweenness > quantile(log.betweenness, .75))))
+
+  #' labels 
+  N <- n_labels
+  lst <- list(q1, q2, q3, q4) 
+  idx <- lapply(lst, function(x) {
+    if (length(x) > N){
+      tmp <- df.res[x, c("betweenness","impact")];
+      union(rownames(tmp)[order(tmp$betweenness, decreasing = TRUE)[1:N]],
+            rownames(tmp)[order(tmp$impact, decreasing = TRUE)[1:N]])
+    }else{x}
+  })
+  idx <- unique(unlist(idx))
+
+  df.idx <- df.res[idx, ]
+
+  im_be_p <-
+    ggplot(data = df.res, aes(x = impact, y = log.betweenness)) +
+    geom_point(aes(col = pos.label), alpha = .3, size = 3) +
+    scale_color_manual(values = c(
+      "plum4", "palegreen4", "indianred",
+      "cornflowerblue"
+    )) +
+    theme_linedraw() +
+    theme_light() +
+    theme(legend.position = "bottom") +
+    guides(colour = guide_legend(nrow = 2)) +
+    theme(legend.title = element_blank()) +
+    geom_text_repel(data = df.idx, aes(label = Line), size = 3.5) +
+    geom_vline(xintercept = quantile(df.res$impact, .75), linetype = "dashed") +
+    geom_hline(
+      yintercept = quantile(df.res$log.betweenness, .75),
+      linetype = "dashed"
+    ) +
+    xlab("Impact") +
+    ylab("Log(betweenness+1)")
+
+  
+  res <- list()
+  res$network <- net 
+  res$network.modules <- cluster_vector
+  res$plot.network <- net_p # plot gene network with symbolic pheno
+  res$plot.impact_betweenness <- im_be_p # plot impact betweenees
+  res$stats.impact_betweenness <- df.res # impact and betweenees data
+  return(res)
+}
+
+
+
+
+
+cosM <- function(x, mode = c("normal", "hybrid")) {
+
+  #' --------------------------------------------------------------------
+  #' library("pracma")
+  #' pinv: Pseudoinverse (Moore-Penrose Generalized Inverse)
+  pinv <- function (A, tol = .Machine$double.eps^(2/3)) {
+    stopifnot(is.numeric(A), length(dim(A)) == 2, is.matrix(A))
+    s <- svd(A)
+    p <- (s$d > max(tol * s$d[1], 0))
+    if (all(p)) {
+      mp <- s$v %*% (1/s$d * t(s$u))
+    } else if (any(p)) {
+      mp <- s$v[, p, drop=FALSE] %*% (1/s$d[p] * t(s$u[, p, drop=FALSE]))
+    } else {
+      mp <- matrix(0, nrow=ncol(A), ncol=nrow(A))
+    }
+    return(mp)
+  }
+
+  mldivide <- function(A, B, pinv = TRUE) {
+    stopifnot( is.numeric(A) || is.complex(A), is.numeric(B) || is.complex(B))
+    if (is.vector(A)) A <- as.matrix(A)
+    if (is.vector(B)) B <- as.matrix(B)
+    if (nrow(A) != nrow(B)) {
+      stop("Matrices 'A' and 'B' must have the same number of rows.")
+    }
+    if (pinv) {
+      pinv(t(A) %*% A) %*% t(A) %*% B
+    } else {
+      qr.solve(A, B)
+    }
+  }
+
+  mrdivide <- function(A, B, pinv = TRUE) {
+    stopifnot( is.numeric(A) || is.complex(A), is.numeric(B) || is.complex(B))
+    if (is.vector(A)) A <- t(A)
+    if (is.vector(B)) B <- t(B)
+    if (ncol(A) != ncol(B)) {
+      stop("Matrices 'A' and 'B' must have the same number of columns.")
+    }
+    t(mldivide(t(B), t(A), pinv = pinv))
+  }
+
+  #' --------------------------------------------------------------------
+
+  #' compute covariance
+  Cov <- cov(x, use = "pairwise.complete.obs")
+  n <- dim(x)[1]
+  m <- dim(x)[2]
+
+  #' compute eigenvalues
+  Eig <- eigen(Cov)
+  score <- mrdivide(as.matrix(x), t(Eig$vectors))
+
+  #' wl-25-10-2020, Sun: n must be larger than m othwise this script fails.
+  if (any(Eig$values < 0)) {
+    stop("Cov Not Positive SemiDefinite !")
+  }
+
+  #' compute pairwise cosine similarity
+  C <- rep(0, n * (n - 1) / 2)
+  d <- 0
+  for (i in 1:(n - 1)) {
+    for (j in (i + 1):n) {
+      d <- d + 1
+      #' inner product and norms
+      inner <- 0
+      normx1 <- 0
+      normy1 <- 0
+      for (l in 1:m) {
+        if (mode == "normal") {
+          inner <- inner + score[i, l] * score[j, l] / Eig$values[l]
+        } else if (mode == "hybrid") {
+          inner <- inner + score[i, l] * score[j, l]
+        }
+        normx1 <- normx1 + (score[i, l] * score[i, l] / Eig$values[l])
+        normy1 <- normy1 + (score[j, l] * score[j, l] / Eig$values[l])
+      }
+      C[d] <- inner / (sqrt(normx1) * sqrt(normy1))
+    }
+  }
+
+  #' wl-25-10-2020, Sun: convert to symmetric matrix
+  if (T) {
+    #' wl's implementation
+    #' mat <- matrix(1, n, n)
+    #' mat[lower.tri(mat, diag = F)] <- C
+    #' mat[which(lower.tri(t(mat)), arr.ind = T)[, c(2,1)]] <- C
+
+    #' ji's implemetation
+    mat <- matrix(0, n, n)
+    mat[lower.tri(mat, diag = F)] <- C
+    mat <- mat + t(mat)
+    diag(mat) <- 1
+
+    dimnames(mat) <- list(rownames(x), rownames(x))
+    return(mat)
+  } else {
+    return(C)
+  }
+
+}
+#' 
+#' =======================================================================
+#' From R package "lsa"
+#' x <- iris[, -5]
+#' cosine(as.matrix(x))
+#' cosine(as.matrix(t(x)))
+#'
+cosine <- function(x, y = NULL) {
+  if (is.matrix(x) && is.null(y)) {
+    co <- array(0, c(ncol(x), ncol(x)))
+    f <- colnames(x)
+    dimnames(co) <- list(f, f)
+    for (i in 2:ncol(x)) {
+      for (j in 1:(i - 1)) {
+        co[i, j] <- cosine(x[, i], x[, j])
+      }
+    }
+    co <- co + t(co)
+    diag(co) <- 1
+    return(as.matrix(co))
+  } else if (is.vector(x) && is.vector(y)) {
+    return(crossprod(x, y) / sqrt(crossprod(x) * crossprod(y)))
+  } else if (is.vector(x) && is.matrix(y)) {
+    co <- vector(mode = "numeric", length = ncol(y))
+    names(co) <- colnames(y)
+    for (i in 1:ncol(y)) {
+      co[i] <- cosine(x, y[, i])
+    }
+    return(co)
+  } else {
+    stop("argument mismatch. Either one matrix or two vectors needed as input.")
+  }
+}
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/ionflow/macros.xml	Mon Aug 09 09:41:22 2021 +0000
@@ -0,0 +1,44 @@
+<macros>
+  <xml name="requirements">
+    <requirements>
+      <requirement type="package" version="1.6.6">r-optparse</requirement>
+      <requirement type="package" version="1.4.4">r-reshape2</requirement>
+      <requirement type="package" version="1.8.6">r-plyr</requirement>
+      <requirement type="package" version="1.0.6">r-dplyr</requirement>
+      <requirement type="package" version="1.1.3">r-tidyr</requirement>
+      <requirement type="package" version="3.3.3">r-ggplot2</requirement>
+      <requirement type="package" version="0.9.1">r-ggrepel</requirement>
+      <requirement type="package" version="0.89">r-corrplot</requirement>
+      <requirement type="package" version="3.1.1">r-gplots</requirement>
+      <requirement type="package" version="1.16.1">r-network</requirement>
+      <requirement type="package" version="2.6">r-sna</requirement>
+      <requirement type="package" version="2.1.1">r-ggally</requirement>
+      <requirement type="package" version="3.13.0">bioconductor-go.db</requirement>
+      <requirement type="package" version="2.58.0">bioconductor-gostats</requirement>
+      <requirement type="package" version="1.0.12">r-pheatmap</requirement>
+      <requirement type="package" version="1.2.6">r-igraph</requirement>
+      <requirement type="package" version="3.2.4">bioconductor-kegg.db</requirement>
+      <requirement type="package" version="3.13.0">bioconductor-org.sc.sgd.db</requirement>
+      <requirement type="package" version="3.13.0">bioconductor-org.hs.eg.db</requirement>
+    </requirements>
+  </xml>
+  <xml name="stdio">
+    <stdio>
+      <regex match="Execution halted"
+            source="both"
+            level="fatal"
+            description="Execution halted." />
+      <regex match="Error in"
+            source="both"
+            level="fatal"
+            description="An undefined error occurred, please check your input
+                          carefully and contact your administrator." />
+      <regex match="Fatal error"
+            source="both"
+            level="fatal"
+            description="An undefined error occurred, please check your input
+                          carefully and contact your administrator." />
+    </stdio>
+  </xml>
+
+</macros>
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/ionflow/test-data/Dataset_IonFlow_Ionome_KO_short.csv	Mon Aug 09 09:41:22 2021 +0000
@@ -0,0 +1,2823 @@
+"orf_id","plate_id","trays_id","batch_id","Ca","Cd","Co","Cu","Fe","K","Mg","Mn","Mo","Na","Ni","P","S","Zn"
+"1","BY4741",11,88,1,118.01855,0.83536,0.17545,2.20607,8.67336,3224.25138,523.76232,1.33972,1.75765,147.79554,1.58683,4036.94219,653.02571,19.16301
+"2","BY4741",23,88,1,39.93342,0.84135,0.16781,1.84792,8.66908,2991.78134,437.37788,1.27339,1.85148,121.7359,1.20679,3673.13953,476.36643,15.98715
+"3","BY4741",35,88,1,17.5135,0.76082,0.14513,1.58885,4.91347,2219.52564,256.25412,0.89513,1.73904,79.56759,1.10363,2138.09998,279.43642,12.55235
+"4","BY4741",47,88,1,30.34089,0.84361,0.16709,2.44383,8.57787,2851.1804,361.87374,1.19424,1.89345,90.5466,1.22088,3220.96622,355.06658,15.27348
+"5","BY4741",59,88,1,28.5296,0.8598,0.16399,1.77133,5.90262,2807.72266,360.63154,1.12887,2.01328,97.90982,1.0611,3238.62113,371.25657,14.84949
+"6","BY4741",71,88,1,44.54168,0.83439,0.1599,1.74531,7.205,2414.25673,293.36174,1.00249,1.81015,67.27554,1.00818,2605.85501,231.38444,14.77511
+"7","BY4741",83,88,1,35.23599,0.83168,0.15839,1.78133,6.06207,2651.64347,325.70903,1.06596,1.79324,77.92219,1.10725,2851.15068,256.74484,15.08956
+"8","BY4741",95,88,1,36.80574,0.78151,0.14613,1.91171,7.82979,2288.65034,264.74517,0.95363,1.84724,83.05214,2.75398,2377.86942,180.37451,15.06511
+"9","BY4741",11,89,1,49.87643,0.89098,0.17937,2.02641,6.95042,3499.59617,532.82025,1.4143,2.00943,127.72827,1.27413,4179.98499,680.93403,16.96328
+"10","BY4741",23,89,1,55.66239,0.84234,0.17031,1.90232,17.79881,3018.39171,455.35255,1.29596,2.00459,125.4246,1.16272,3653.58444,469.18262,18.37319
+"11","BY4741",35,89,1,22.4409,0.79005,0.18657,1.85378,5.69795,2684.23431,332.23097,1.06787,1.99871,85.98306,0.99115,2778.50149,334.74153,13.00427
+"12","BY4741",47,89,1,25.12463,0.85613,0.16483,1.85453,5.33134,2884.03491,398.61344,1.15496,1.84046,115.46684,1.05677,3401.49943,344.89722,15.15893
+"13","BY4741",59,89,1,29.44312,0.87916,0.16887,1.87856,8.41275,3020.46396,422.96951,1.24821,1.85012,111.76879,2.36983,3502.28565,455.91795,16.22817
+"14","BY4741",71,89,1,18.87506,0.81661,0.16234,1.7357,5.10987,2550.82062,330.20337,1.04729,1.91999,131.5325,1.14496,2920.57952,309.9828,14.1734
+"15","BY4741",83,89,1,12.49325,0.82537,0.15682,1.67354,5.20195,2386.52419,292.6615,1.00391,1.80618,83.38268,0.92857,2604.03574,200.78989,13.97614
+"16","BY4741",95,89,1,15.65098,0.84031,0.16123,1.69523,281.62136,2429.97832,259.55299,1.47581,1.86328,71.30176,36.28849,2311.50311,119.72918,16.06095
+"17","BY4741",11,90,1,59.75103,0.84673,0.17161,2.06155,17.70061,3099.01282,523.47771,1.33733,2.04168,174.17996,1.17147,4001.23579,595.30735,16.94089
+"18","BY4741",23,90,1,42.03505,0.82363,0.16701,2.17403,17.82921,2934.92609,436.268,1.23084,2.51295,136.78117,1.16222,3637.29081,482.42035,15.9416
+"19","BY4741",35,90,1,23.66711,0.78101,0.15701,2.06385,4.889,2723.79796,325.23377,1.04847,1.71337,81.92122,0.95269,2746.11842,330.97258,13.35265
+"20","BY4741",47,90,1,38.88236,0.88391,0.17611,2.2538,7.12081,3019.95481,451.59956,1.2601,1.85877,250.88614,1.12393,3726.19521,454.39026,16.11784
+"21","BY4741",59,90,1,29.31916,0.8445,0.15848,2.05697,6.66955,2807.34258,339.79049,1.12114,1.79259,75.73281,0.99109,3087.03998,329.04759,14.75219
+"22","BY4741",71,90,1,25.11863,0.80596,0.16142,1.94339,5.41517,2638.58991,349.32696,1.09729,1.75094,123.5104,1.01493,3164.01687,302.36893,14.3688
+"23","BY4741",83,90,1,23.82126,0.79837,0.15293,1.96622,5.20906,2392.65369,311.04029,1.0157,1.79685,94.71936,1.5965,2773.46455,235.43839,14.13855
+"24","BY4741",95,90,1,27.26646,0.81233,0.15191,2.14113,6.28443,2243.14725,287.00822,0.96386,1.80718,113.37349,2.02481,2627.12274,253.57812,14.18023
+"25","BY4741",11,94,2,29.75855,0.75579,0.15697,1.89219,12.37799,2789.27227,308.80746,1.07488,2.27887,131.01332,1.18169,2381.6302,326.65447,12.66868
+"26","BY4741",23,94,2,17.81699,0.77401,0.1527,2.56343,11.12948,2623.77809,319.56901,1.00558,1.3789,143.57448,1.08979,2510.09741,286.65776,13.04521
+"27","BY4741",35,94,2,9.78638,0.77745,0.15168,1.62963,11.09411,2310.79316,236.97126,0.88738,1.28473,108.49806,1.00379,1965.89866,166.91457,11.9779
+"28","BY4741",59,94,2,1.74717,0.74497,0.14473,1.57065,8.97148,1918.54256,176.77326,0.69458,1.40356,109.67997,0.94856,1627.20515,77.89848,10.18824
+"29","BY4741",71,94,2,13.16574,0.81992,0.15278,1.69549,11.53162,2401.23142,284.00895,0.94765,1.38222,139.50691,3.89763,2367.69267,199.59121,12.8589
+"30","BY4741",83,94,2,15.9794,0.83104,0.15372,1.8538,10.37615,2365.51824,265.85077,0.95795,1.63237,120.84126,2.31961,2316.9117,216.50163,13.46131
+"31","BY4741",95,94,2,31.86331,0.88517,0.16356,1.86455,11.93713,2754.36498,348.16076,1.13068,1.487,158.78572,1.274,2869.15783,324.07416,15.36764
+"32","BY4741",11,95,2,24.41309,0.75553,0.15914,1.76686,9.64502,2611.84459,340.02205,1.03719,1.42579,184.44361,1.36358,2504.91062,355.32828,12.46864
+"33","BY4741",23,95,2,19.86629,0.78116,0.15373,2.28852,8.95931,2575.80101,299.52469,1.01627,1.38355,121.24281,1.21451,2518.06634,291.5253,13.00073
+"34","BY4741",35,95,2,17.01462,0.78711,0.15134,1.60066,9.02919,2358.45542,242.49411,0.92508,1.4684,107.02054,0.93151,2102.52119,201.17289,12.09611
+"35","BY4741",47,95,2,10.39488,0.75274,0.14023,1.47682,6.71899,2064.06748,204.1704,0.77137,1.1687,88.29438,0.7997,1690.51434,71.6957,10.55226
+"36","BY4741",59,95,2,16.42744,0.80168,0.15484,1.63542,8.7792,2385.59962,241.00089,0.89989,1.26603,102.60031,0.92348,1978.7784,177.53678,12.5545
+"37","BY4741",71,95,2,22.01382,0.81784,0.15665,1.6657,9.44946,2574.33154,299.75667,1.03853,1.28507,122.01186,1.01898,2444.42767,207.98587,13.84244
+"38","BY4741",83,95,2,18.42067,0.82347,0.15745,1.84475,8.98569,2447.59575,280.76941,1.0005,1.32573,112.65646,1.12724,2371.82087,227.72699,13.27066
+"39","BY4741",95,95,2,32.89474,0.89109,0.16249,1.78665,10.22767,2982.00436,376.56994,1.18193,1.3264,131.04199,1.16531,3065.74339,381.93947,15.11777
+"40","BY4741",11,96,2,29.95958,0.74592,0.15908,1.88971,15.34831,2741.40422,382.78656,1.08578,1.34784,191.97336,4.10494,2699.77473,407.42303,13.61489
+"41","BY4741",23,96,2,17.21482,0.77003,0.15255,1.74849,9.79153,2526.82533,300.80924,0.98469,1.22914,116.61205,0.99231,2417.41497,258.43004,12.43677
+"42","BY4741",35,96,2,11.57701,0.80137,0.15523,1.71455,11.5193,2354.35181,249.06792,0.92688,1.3135,106.32091,0.98891,2075.92662,174.0518,12.26946
+"43","BY4741",47,96,2,1.37828,0.73995,0.14542,1.87895,8.72666,2127.22699,195.23638,0.79225,1.37004,74.66328,0.8405,1558.09686,108.87707,10.09587
+"44","BY4741",59,96,2,6.01376,0.78827,0.15147,1.68329,23.61718,2210.87174,195.79134,0.82463,1.46205,68.72423,0.87878,1679.42707,101.33807,10.92285
+"45","BY4741",71,96,2,14.90198,0.82633,0.15612,1.6857,9.0298,2477.56875,287.13918,0.95783,1.21593,122.99937,0.97401,2428.34087,220.82219,12.89067
+"46","BY4741",83,96,2,18.31172,0.81608,0.15407,1.66221,9.89047,2565.10995,288.09905,1.02845,1.26285,104.24724,0.97235,2426.87049,195.87262,13.00252
+"47","BY4741",95,96,2,21.97781,0.85036,0.15731,1.74707,10.95532,2499.3709,295.41073,1.03642,1.25539,123.5244,1.08949,2593.40797,223.33803,14.33394
+"48","BY4741",11,97,3,53.19826,0.87668,0.17485,2.16352,15.34182,3075.23484,460.873,1.29165,1.44761,171.69374,2.38131,3580.90348,385.84716,19.4229
+"49","BY4741",23,97,3,49.44055,0.89551,0.18131,2.17524,11.08556,3061.93506,507.18809,1.24152,1.362,233.75905,2.13043,3856.06937,429.53777,19.46033
+"50","BY4741",35,97,3,45.41225,0.92593,0.18065,2.27364,13.87765,2904.0259,436.96444,1.19351,1.46411,200.9084,2.80123,3624.3634,382.23995,19.51638
+"51","BY4741",47,97,3,35.97758,0.92998,0.17665,2.19919,12.58425,2892.7239,412.31197,1.20165,1.83553,191.60253,2.35802,3486.36115,342.95847,18.51343
+"52","BY4741",59,97,3,46.39397,0.91106,0.17829,2.22229,11.61952,2794.85148,418.66707,1.17106,1.293,187.11769,1.68896,3378.63064,321.32382,17.60448
+"53","BY4741",71,97,3,45.84896,0.94531,0.18334,4.21793,12.49159,2884.3673,453.1319,1.24989,1.51778,205.79557,5.6447,3580.87228,367.92197,18.39977
+"54","BY4741",83,97,3,33.24262,0.9545,0.17581,2.35878,11.09796,2643.73298,350.44662,1.11053,1.26656,161.01206,1.60646,2995.35166,245.18078,17.28792
+"55","BY4741",95,97,3,49.66597,1.01662,0.18207,2.27186,12.18528,2983.48794,397.53953,1.25736,1.38443,149.95098,1.67883,3462.14502,303.22008,19.88757
+"56","BY4741",11,98,3,38.27221,0.8635,0.17653,2.13991,12.058,2992.64347,434.90843,1.25489,1.48691,214.73058,1.65772,3598.56971,409.08428,18.93772
+"57","BY4741",23,98,3,33.20123,0.90975,0.1782,2.09077,11.50716,3191.70412,512.30314,1.26615,1.44868,229.13319,1.21853,4018.48824,455.45272,17.58179
+"58","BY4741",35,98,3,29.64186,0.90259,0.17715,1.99053,11.59739,2868.94487,452.39363,1.18611,1.51286,209.23663,1.21835,3586.18109,341.98761,18.94559
+"59","BY4741",47,98,3,25.65393,0.88023,0.17527,1.95513,9.52698,2946.89805,438.97982,1.16654,1.23261,189.26076,1.18785,3561.42718,330.21172,16.41823
+"60","BY4741",59,98,3,31.46325,0.91869,0.17654,1.94615,9.87774,2631.85974,379.16125,1.0745,1.33835,189.98485,1.24207,3273.47201,323.15798,16.64664
+"61","BY4741",71,98,3,31.169,0.98484,0.17975,2.02655,10.6491,3004.64659,460.01401,1.25125,1.27445,213.80511,1.26173,3731.2996,512.62339,17.41423
+"62","BY4741",83,98,3,30.73521,0.95905,0.17688,2.09703,9.45407,2725.53274,365.19864,1.12281,1.28581,175.51066,1.35102,3023.48389,287.18548,17.498
+"63","BY4741",95,98,3,51.51036,0.98457,0.18846,2.13887,12.39517,3134.70923,400.16666,1.26276,1.29797,147.33345,1.4515,3593.89377,301.78003,19.88861
+"64","BY4741",11,99,3,37.72044,0.80667,0.16451,1.9298,10.43845,2908.83838,431.74084,1.23552,1.30515,182.43153,1.21138,3488.67556,359.83,16.36092
+"65","BY4741",23,99,3,38.69664,0.89226,0.17756,2.02073,11.76597,3180.29235,571.71216,1.31951,1.51943,261.60589,1.22991,4276.91935,498.48028,17.16395
+"66","BY4741",35,99,3,30.72775,0.86015,0.1738,1.96576,10.96409,2866.22577,438.06851,1.15371,1.42745,200.3953,1.18624,3554.48779,340.73567,16.03587
+"67","BY4741",47,99,3,28.89897,0.87898,0.16926,1.96473,10.552,2808.18151,417.67437,1.13621,1.31243,208.05555,1.17102,3475.40885,360.33119,16.37158
+"68","BY4741",59,99,3,21.47339,0.88996,0.17666,2.02116,11.50493,2714.42042,414.32581,1.13045,1.3561,190.31375,1.22769,3433.66389,278.56767,16.09947
+"69","BY4741",71,99,3,22.54307,0.90142,0.17193,2.00433,9.93954,2802.02637,407.73028,1.17305,1.24095,175.95681,1.15215,3428.0983,272.51665,16.32712
+"70","BY4741",83,99,3,19.47683,0.92835,0.16999,1.99133,11.81333,2607.51285,332.20823,1.10588,1.3167,142.32212,1.12585,3025.45463,167.54657,15.91877
+"71","BY4741",95,99,3,27.64589,0.91787,0.17364,2.01809,11.1461,2849.59047,371.67379,1.16122,1.2332,145.87271,1.18933,3258.82923,280.77755,16.97964
+"72","BY4741",11,100,4,49.00525,0.79663,0.15059,1.85866,5.64788,2280.54631,399.59284,1.18385,0.75731,128.81575,0.79981,2661.99592,519.80446,14.60112
+"73","BY4741",23,100,4,48.03245,0.83956,0.16097,1.38624,7.47668,2482.5763,470.89053,1.24666,0.64886,161.08681,0.99084,3094.60946,568.81996,15.81239
+"74","BY4741",35,100,4,36.56616,0.84421,0.14837,1.25826,5.63004,2115.6053,327.32237,1.0834,0.65382,115.06133,0.70473,2286.89146,419.36271,13.99435
+"75","BY4741",47,100,4,36.69022,0.85678,0.14293,1.27447,4.5089,1834.40847,266.13423,0.95072,0.75451,103.68561,0.82588,2029.19506,356.27268,14.19088
+"76","BY4741",59,100,4,34.06728,0.8631,0.14165,1.2253,4.47229,1713.91531,269.37131,0.95533,0.67293,105.9245,0.6448,2018.9701,361.0751,13.12304
+"77","BY4741",71,100,4,39.18134,0.90762,0.1516,1.38343,5.85726,1912.06826,263.31562,1.01334,0.85443,93.69793,1.00491,2129.34108,348.15599,15.63323
+"78","BY4741",83,100,4,32.2148,0.89327,0.14682,1.21725,5.05494,1708.19869,241.4618,0.92492,0.68869,103.41797,0.73413,1868.43646,319.89011,13.94882
+"79","BY4741",95,100,4,32.64466,0.86642,0.13162,1.30397,3.95849,1465.77105,189.71103,0.84674,0.67762,75.33446,0.79319,1487.98818,232.07654,14.33264
+"80","BY4741",11,101,4,40.71765,0.81351,0.15318,1.41804,6.29074,2353.34506,403.55117,1.20455,0.6177,131.5816,0.78899,2850.96145,515.26093,13.77645
+"81","BY4741",23,101,4,59.83007,0.82196,0.16204,1.43391,6.66467,2438.6328,550.78478,1.21624,0.60697,216.82107,1.1546,3513.03714,634.19299,15.35537
+"82","BY4741",35,101,4,38.64036,0.82671,0.15195,1.26815,6.24448,1972.66642,336.49346,1.05652,0.61991,145.18106,0.77555,2462.96037,439.3072,13.31342
+"83","BY4741",47,101,4,29.65722,0.81773,0.13934,1.24424,4.18405,1738.03897,291.03272,0.97332,0.5043,113.34974,0.75579,2116.04957,355.36597,12.56011
+"84","BY4741",59,101,4,29.16261,0.86005,0.14536,1.22238,5.59408,1754.7808,271.08997,0.93592,0.70145,103.13693,0.74856,2074.54314,346.03119,13.03752
+"85","BY4741",71,101,4,28.40493,0.88269,0.14673,1.34599,4.97916,1735.36217,260.96216,1.00399,0.698,90.43656,0.74227,2007.39815,332.22236,13.10801
+"86","BY4741",83,101,4,28.92477,0.90301,0.14898,1.39952,5.43641,1869.18003,294.16713,1.00753,0.64209,113.92115,0.69069,2263.61185,353.13659,14.06861
+"87","BY4741",95,101,4,28.23273,0.88343,0.1389,1.38566,5.45,1558.8755,196.6612,0.85803,0.77083,83.35469,0.67512,1665.38668,244.07691,13.27296
+"88","BY4741",11,102,4,43.42542,0.77848,0.14882,1.39643,5.69774,2220.44317,386.52894,1.26162,0.56948,132.94986,0.90351,2663.31973,510.39681,14.15917
+"89","BY4741",23,102,4,37.31944,0.74188,0.13749,1.28884,4.6897,2067.1099,346.32105,1.22621,0.52576,131.18052,0.8164,2458.20101,439.64411,13.97339
+"90","BY4741",35,102,4,38.81738,0.79642,0.14804,1.2898,4.74398,2116.0219,381.33372,1.12366,0.56332,134.77747,0.91924,2691.49424,470.6661,14.0967
+"91","BY4741",47,102,4,36.54855,0.80758,0.13994,1.25079,5.07384,1765.74779,296.76409,1.00691,0.65364,122.09896,0.90933,2203.83271,405.33031,13.046
+"92","BY4741",59,102,4,29.84956,0.81669,0.13144,1.21252,4.42524,1677.19681,253.72857,0.93831,0.53261,85.07637,0.85259,1823.37986,324.99275,12.60307
+"93","BY4741",71,102,4,31.4687,0.81821,0.13394,1.15747,4.50134,1599.35241,220.28093,0.88855,0.67263,90.27264,0.76371,1762.81544,286.03936,12.3462
+"94","BY4741",83,102,4,38.64634,0.88786,0.14596,1.28524,5.4101,1854.49341,291.28471,1.08246,0.60379,111.40894,0.73692,2262.7583,377.01274,14.32299
+"95","BY4741",95,102,4,33.98132,0.84754,0.12786,1.28717,3.46402,1370.69421,176.19296,0.87348,0.54294,74.98997,0.75436,1489.97781,224.0377,13.29623
+"96","BY4741",11,103,5,16.4916,0.9104,0.17865,1.42548,4.42062,2788.90616,508.58172,1.35931,0.61436,177.66042,0.71991,3527.9288,354.2266,15.1912
+"97","BY4741",23,103,5,12.9439,0.91098,0.16107,1.35502,2.29852,2649.58963,441.58283,1.2467,0.56672,149.4107,0.68153,3038.64701,267.99329,14.58984
+"98","BY4741",35,103,5,14.74182,0.91322,0.16781,1.42315,2.56209,2557.5952,433.53513,1.27798,0.66602,157.24887,0.70372,3048.806,318.83359,14.52889
+"99","BY4741",47,103,5,23.49491,0.9779,0.17346,1.46832,4.4328,2665.4511,480.10991,1.31259,0.66584,199.13562,0.82591,3344.53091,383.31098,15.70631
+"100","BY4741",59,103,5,15.27482,0.98212,0.16392,1.41518,3.88059,2309.99931,367.88353,1.1882,0.92232,142.80369,0.7387,2670.6333,227.69052,15.29736
+"101","BY4741",71,103,5,15.07968,0.97443,0.165,1.38044,3.48946,2299.00142,327.71771,1.13301,0.6474,113.39519,0.70943,2435.99585,241.00266,14.66116
+"102","BY4741",83,103,5,7.72388,0.98227,0.15881,1.38493,2.69425,2140.2035,303.2237,1.14417,0.58509,117.18581,0.67036,2176.14123,192.00399,14.4806
+"103","BY4741",95,103,5,7.91233,0.94623,0.14939,1.36444,2.7022,1927.75078,254.16808,1.05414,0.59566,100.04138,0.64007,1955.02619,144.34623,14.10885
+"104","BY4741",11,104,5,30.8222,0.97587,0.18074,1.46649,2.10416,2950.48115,501.96322,1.42226,0.53375,175.16151,0.73189,3653.19414,383.45176,15.65141
+"105","BY4741",23,104,5,16.71056,0.96907,0.17982,1.50916,4.49976,2860.51194,496.16149,1.41866,0.60383,184.10305,0.96512,3618.17903,355.19851,15.75392
+"106","BY4741",35,104,5,17.30277,0.97663,0.17896,1.4945,2.64257,2716.10407,504.99405,1.36092,0.66203,206.1563,0.81639,3549.70223,404.02206,15.89603
+"107","BY4741",47,104,5,14.53069,1.00572,0.17494,1.46043,2.86421,2606.60845,423.53278,1.31894,0.56823,156.47484,0.77323,2993.32963,292.92608,14.91664
+"108","BY4741",59,104,5,19.96281,1.06584,0.1852,1.57207,3.01043,2858.14822,503.81777,1.47635,0.5611,157.87803,0.84069,3574.31978,359.15097,17.00366
+"109","BY4741",71,104,5,13.03453,0.96832,0.16097,1.40851,2.49261,2447.63817,357.96803,1.28157,0.57312,101.8769,0.70653,2628.0238,224.535,14.41329
+"110","BY4741",83,104,5,11.79836,1.04988,0.16985,1.46722,2.86429,2333.01784,343.8512,1.2895,0.60908,90.1186,0.68959,2511.87515,198.61105,14.80565
+"111","BY4741",95,104,5,12.84327,1.03873,0.16739,1.50124,4.60966,2266.64759,299.93417,1.25783,0.66567,87.96461,5.84096,2244.59213,199.69847,15.2166
+"112","BY4741",11,105,5,14.74304,0.87756,0.16618,1.30518,1.45241,2502.59483,469.24583,1.24778,0.57369,181.56281,0.64986,3149.31423,334.15352,14.56256
+"113","BY4741",23,105,5,17.87067,0.93169,0.17852,1.42512,3.54202,2651.57605,497.99307,1.32214,0.62112,186.05347,0.71319,3504.84597,383.77146,15.37007
+"114","BY4741",35,105,5,21.18418,0.9536,0.17481,1.42726,2.95807,2681.23244,490.03982,1.33797,0.57562,173.65627,0.72565,3472.63302,383.86078,15.46486
+"115","BY4741",47,105,5,13.44886,0.98809,0.1693,1.39549,2.90955,2571.70219,399.97482,1.28542,0.6337,131.92075,0.72421,3019.82566,311.12056,14.54207
+"116","BY4741",59,105,5,9.06194,0.99822,0.16731,1.36306,4.20791,2452.8612,383.19868,1.27539,1.06052,107.73192,0.72284,2649.7471,220.6345,14.83683
+"117","BY4741",71,105,5,12.83539,1.02248,0.17058,1.42105,3.34265,2381.00203,356.45148,1.22323,0.86752,100.31451,0.70428,2749.52526,228.49871,14.87127
+"118","BY4741",83,105,5,6.00216,0.96172,0.15699,1.31129,1.26867,2078.24316,296.02019,1.06629,0.57119,95.76384,0.62553,2076.75144,140.26383,14.06936
+"119","BY4741",95,105,5,14.85779,0.99872,0.15839,1.46806,2.96022,2133.27169,299.12128,1.17733,0.56186,95.87171,0.67947,2236.29693,263.48754,14.88577
+"120","BY4741",11,106,6,32.43396,0.72787,0.13132,0.9645,3.59617,2028.1588,400.44559,0.95881,0.38579,138.57199,0.51092,2773.71675,338.1553,10.99771
+"121","BY4741",23,106,6,29.46028,0.75357,0.12998,1.02623,2.7034,1887.81154,368.75922,0.90177,0.43728,113.44913,0.51249,2431.81238,290.95303,13.34126
+"122","BY4741",35,106,6,17.97008,0.72502,0.12419,0.98755,2.51916,1761.40624,321.60414,0.8065,0.51604,111.06009,0.46047,2136.88308,279.83474,10.78169
+"123","BY4741",47,106,6,14.15883,0.7527,0.12391,0.89074,3.07417,1592.70281,269.50027,0.73878,0.41058,77.96432,0.44403,1852.31831,183.45847,10.37156
+"124","BY4741",59,106,6,15.51432,0.75069,0.1219,0.88815,2.61237,1522.00473,266.72312,0.73788,0.53452,90.12611,0.44279,1890.33259,228.57503,10.86579
+"125","BY4741",71,106,6,14.34495,0.7495,0.12674,0.93399,1.75421,1381.73522,251.82089,0.70164,0.52121,99.1328,0.45971,1525.78511,122.47318,10.61192
+"126","BY4741",83,106,6,13.0059,0.73067,0.11991,0.93482,1.87694,1512.40922,283.93306,0.71927,0.4286,89.24077,0.43299,1833.16021,122.17495,10.51711
+"127","BY4741",95,106,6,11.35572,0.74618,0.12885,0.86568,2.04024,1571.30492,278.72825,0.70613,0.4997,96.99817,0.42931,1856.32141,101.0981,10.539
+"128","BY4741",11,107,6,22.0884,0.74738,0.13574,0.91078,3.66434,2014.12151,432.08279,0.98231,0.47264,118.32398,0.52401,2715.82548,339.79562,11.36698
+"129","BY4741",23,107,6,18.28325,0.79819,0.13651,0.97641,4.87677,1875.64177,386.80515,0.93957,0.55108,133.02787,0.53351,2623.5958,342.35606,11.47617
+"130","BY4741",35,107,6,16.666,0.75664,0.13775,1.02019,4.68957,2011.9953,388.3176,0.92255,0.56379,108.4164,0.53083,2540.51762,318.28978,11.53345
+"131","BY4741",47,107,6,9.90665,0.7853,0.12716,0.84617,2.76032,1678.50216,263.66191,0.8021,0.43842,66.01598,0.47828,1792.10315,196.13836,10.94718
+"132","BY4741",59,107,6,14.68109,0.79093,0.136,1.67857,3.3001,1998.41514,363.21096,0.92431,0.42979,105.25737,0.53208,2468.07869,319.77718,11.73558
+"133","BY4741",71,107,6,8.54707,0.77127,0.12741,0.87549,3.08733,1608.67039,261.48894,0.78136,0.47416,74.34644,0.45485,1756.04016,150.00882,10.7359
+"134","BY4741",83,107,6,8.54291,0.76196,0.12743,0.88659,3.34335,1622.10973,284.46193,0.74718,0.45768,65.74835,0.43094,1736.38863,124.56815,10.7879
+"135","BY4741",95,107,6,11.6906,0.77735,0.13076,0.82677,2.1262,1721.93547,294.42256,0.80611,0.39393,76.6295,0.4836,1930.14047,112.89502,11.27901
+"136","BY4741",11,108,6,17.86678,0.74374,0.12932,0.90015,3.37907,1922.76131,367.39059,0.90565,0.56748,128.91422,0.43964,2567.32547,324.31951,11.41787
+"137","BY4741",23,108,6,13.76895,0.75298,0.13243,0.85356,1.429,1665.20026,353.19885,0.87681,0.39757,135.93964,0.44614,2288.89402,263.65088,11.22258
+"138","BY4741",35,108,6,11.48977,0.73297,0.12393,0.84156,2.294,1601.93459,312.78759,0.79185,0.45376,111.34694,0.45247,2079.95989,292.77165,11.13535
+"139","BY4741",47,108,6,10.4671,0.76166,0.12484,0.78047,2.27192,1497.63908,305.42754,0.75919,0.60762,93.69392,0.39732,1950.25789,191.25057,10.7507
+"140","BY4741",59,108,6,15.64537,0.75028,0.12097,0.78434,2.45776,1370.16957,283.12852,0.69376,0.49444,111.46054,0.55198,1769.49048,227.58649,11.98088
+"141","BY4741",71,108,6,7.9025,0.74947,0.12225,0.76166,2.48977,1555.07387,276.53946,0.76453,0.43694,79.87984,0.40374,1757.69555,131.04009,10.82597
+"142","BY4741",83,108,6,6.74597,0.72146,0.11547,0.68401,5.65735,1463.79871,261.57128,0.7062,0.41852,68.75455,0.36661,1692.95909,74.36815,10.49526
+"143","BY4741",11,109,7,40.2309,0.91591,0.16601,1.38877,3.43964,2286.86877,468.32936,1.12461,0.55519,198.13644,0.77104,3018.82674,455.09285,18.2201
+"144","BY4741",23,109,7,41.94556,0.94273,0.18384,1.53088,3.60528,2684.8457,548.32013,1.256,0.55106,228.45476,0.83202,3629.87638,573.14593,17.83583
+"145","BY4741",35,109,7,41.25738,0.94404,0.18141,1.58263,3.75148,2691.97504,551.54236,1.24838,0.54915,216.80751,0.86675,3668.46837,540.8842,17.6224
+"146","BY4741",47,109,7,38.28697,0.89641,0.17002,1.40366,3.01318,2225.77748,435.07921,1.12792,0.4612,183.61074,0.78863,3001.68093,430.44324,16.39993
+"147","BY4741",59,109,7,33.51731,0.90134,0.16853,1.3779,5.92655,2188.15928,427.72549,1.1042,0.92686,175.02794,0.81514,2873.46574,388.65814,17.71053
+"148","BY4741",71,109,7,44.19316,1.04513,0.19369,1.63978,4.68919,3097.65996,694.5341,1.39138,0.63464,256.88151,1.00136,4712.53417,676.99713,20.29939
+"149","BY4741",83,109,7,38.67334,0.94254,0.17968,1.50915,4.02331,2608.8297,541.30131,1.25111,0.48645,222.68372,0.92448,3647.71827,548.41269,18.92045
+"150","BY4741",95,109,7,37.43093,0.90777,0.17048,1.37196,9.09636,2418.27556,429.26853,1.25317,0.45086,154.47242,1.58027,2882.74034,422.21601,18.52552
+"151","BY4741",11,110,7,29.63914,0.90607,0.1706,1.5084,6.22416,2312.66332,481.65519,1.15369,1.76453,201.16097,0.81343,3214.60126,428.89629,16.42305
+"152","BY4741",23,110,7,31.32845,0.90723,0.1779,1.51431,4.34724,2448.83079,486.78806,1.22883,0.57104,199.34296,0.83387,3442.3339,490.95594,15.86714
+"153","BY4741",35,110,7,28.68395,0.8465,0.16662,1.39544,7.7198,2090.2828,441.44092,1.08113,0.49524,212.91848,0.81694,2989.91912,419.75358,15.40118
+"154","BY4741",47,110,7,29.89931,0.91125,0.17632,1.4471,3.67907,2306.5507,508.2883,1.17445,0.53564,225.5284,0.86406,3415.01483,464.85578,16.45066
+"155","BY4741",59,110,7,27.07708,0.89355,0.17636,1.38184,3.90451,2125.16641,430.88322,1.1366,0.57757,176.00527,0.82491,2705.17225,338.73829,16.05182
+"156","BY4741",71,110,7,36.68356,0.96239,0.18311,1.52143,5.1934,2746.07705,598.02326,1.30034,0.63433,221.16057,0.93372,3941.62927,553.89,17.22821
+"157","BY4741",83,110,7,36.05694,0.96687,0.18569,1.56924,5.58141,2757.80254,636.28661,1.26508,0.89807,242.50501,0.93043,4274.84267,606.01728,17.68374
+"158","BY4741",95,110,7,38.81531,0.97031,0.18141,1.39086,4.32996,2557.89566,491.80924,1.24868,0.51321,174.29274,0.89814,3274.08416,484.80827,19.99142
+"159","BY4741",11,111,7,39.04073,0.84615,0.15693,1.33576,3.70319,2199.78497,445.47928,1.13199,0.57767,194.18521,0.76316,3041.02788,432.64676,16.98027
+"160","BY4741",23,111,7,38.06182,0.8595,0.16311,1.42072,4.82637,2262.00643,467.28731,1.1595,0.69137,200.52012,0.77981,3208.46425,479.47648,17.13316
+"161","BY4741",35,111,7,30.84024,0.84737,0.16036,1.38397,3.91173,2215.56929,442.84859,1.11096,0.56118,178.07484,0.7271,3090.30695,449.95483,15.73983
+"162","BY4741",47,111,7,36.83522,0.90457,0.17106,1.38988,4.30683,2371.48867,504.19683,1.19574,0.6954,216.34789,0.82901,3454.03978,560.94019,17.33144
+"163","BY4741",59,111,7,30.9824,0.87562,0.16566,1.35352,5.28917,2303.31592,452.7147,1.18128,0.63893,168.37437,0.78317,2954.13597,443.52995,16.13815
+"164","BY4741",71,111,7,34.42628,0.85096,0.17016,1.39127,5.13566,2212.66864,501.23581,1.13519,0.53059,236.8444,0.83816,3346.06341,495.45692,15.91289
+"165","BY4741",83,111,7,32.10777,0.89438,0.16658,1.38237,4.76904,2279.13325,458.08204,1.13995,0.67754,202.91493,0.80325,3123.22295,498.00662,16.34666
+"166","BY4741",95,111,7,34.3833,0.87484,0.16387,1.34738,27.20696,2220.36821,441.09309,1.13054,9.05483,157.9407,0.8081,2944.18586,470.49217,17.5111
+"167","BY4741",11,112,8,40.15042,0.70727,0.1784,1.60161,7.38412,2330.96755,412.09489,1.22463,0.57911,118.95818,1.59712,3171.80544,437.86387,16.79742
+"168","BY4741",23,112,8,32.63958,0.62618,0.16534,1.3186,8.2284,1970.78227,318.01519,1.07403,0.8057,101.51915,1.18402,2460.14766,308.30248,14.4724
+"169","BY4741",35,112,8,36.33745,0.65559,0.16809,1.36859,6.91303,2135.80869,376.40621,1.11508,0.62542,109.61185,1.26908,2938.32002,366.67176,15.33457
+"170","BY4741",47,112,8,35.49905,0.7049,0.17577,1.65996,6.51656,2443.96211,418.7808,1.24283,0.65301,103.59531,1.28855,3277.72179,439.09375,16.26836
+"171","BY4741",59,112,8,33.31704,0.65924,0.16718,1.34114,6.53696,2125.39515,348.01315,1.10273,0.65096,95.98867,1.1722,2721.52912,335.15536,15.16837
+"172","BY4741",71,112,8,36.55988,0.66132,0.16921,1.35606,6.82855,2167.02546,337.26276,1.12611,0.69834,99.20073,1.14056,2652.49385,371.80015,15.18137
+"173","BY4741",83,112,8,40.71841,0.75732,0.17843,1.46201,8.14912,2420.9975,443.70556,1.21149,0.82884,132.75999,1.29073,3458.27633,450.78673,16.98732
+"174","BY4741",95,112,8,38.14924,0.66776,0.16795,1.35308,7.23436,2143.22285,312.76251,1.12798,0.69216,84.39623,1.13459,2439.07269,291.73482,15.47345
+"175","BY4741",11,113,8,39.63761,0.69441,0.18329,1.40851,7.74409,2282.62049,412.56696,1.25592,0.63386,115.14064,1.60392,3227.07405,450.07439,16.44454
+"176","BY4741",23,113,8,33.65773,0.66024,0.175,1.38514,6.99039,2216.54356,359.12175,1.17333,0.60448,104.60015,1.18767,2836.45657,364.32192,15.61834
+"177","BY4741",35,113,8,29.54668,0.63271,0.16779,1.26686,6.94053,2064.81449,332.42171,1.1183,0.61195,101.99686,1.09593,2584.2553,327.97205,14.70114
+"178","BY4741",47,113,8,29.49759,0.63802,0.168,1.31081,7.01672,2183.1236,359.02454,1.14138,0.5842,99.76303,1.10323,2802.45963,356.61488,15.07965
+"179","BY4741",59,113,8,34.40968,0.71635,0.17157,1.42571,7.63337,2157.65446,401.97205,1.15765,0.65076,135.83082,1.24656,3140.39498,392.30758,16.4296
+"180","BY4741",71,113,8,31.41854,0.65165,0.17589,1.346,9.01328,2142.6452,342.46796,1.16961,0.63939,97.93258,1.15754,2666.70182,342.10977,15.19976
+"181","BY4741",83,113,8,54.29653,0.67602,0.1715,1.41337,7.55357,2343.48911,368.82202,1.25428,0.71932,194.11429,1.24766,2739.91233,1209.4079,15.39493
+"182","BY4741",95,113,8,30.18604,0.63622,0.17127,1.35036,7.98979,1988.97462,299.71699,1.10305,0.59203,93.1217,1.31205,2354.9243,267.15965,14.91357
+"183","BY4741",11,114,8,29.35447,0.53679,0.14104,1.53676,7.8309,2052.83632,333.22382,1.06896,0.54184,83.74502,0.92488,2574.31346,338.02119,15.83895
+"184","BY4741",23,114,8,31.70406,0.61374,0.15868,1.26699,7.30005,2029.38759,325.46222,1.07944,0.67543,102.45672,0.96275,2541.31995,301.45393,14.37922
+"185","BY4741",35,114,8,38.60635,0.60108,0.15539,1.50702,7.05925,1967.93068,322.88744,1.05786,0.57722,104.85368,1.46471,2544.94061,320.51388,14.76687
+"186","BY4741",47,114,8,31.66985,0.61472,0.16198,1.25037,6.54169,1988.70174,338.37942,1.0661,0.55014,109.18348,0.98248,2592.69705,348.62038,14.48932
+"187","BY4741",59,114,8,28.51787,0.63437,0.15947,1.30377,6.07174,1959.13475,311.88563,1.04164,0.62669,106.53604,0.98888,2447.70244,330.30139,14.33975
+"188","BY4741",71,114,8,30.41379,0.62705,0.1597,1.29804,6.1543,2072.73081,317.08038,1.11539,0.67015,85.56785,1.00914,2519.10019,316.15745,15.17685
+"189","BY4741",83,114,8,29.31445,0.61286,0.15691,1.27135,6.72483,1981.09249,307.16922,1.05549,0.61766,101.65705,1.04685,2375.70736,324.59476,14.53833
+"190","BY4741",95,114,8,29.70359,0.62399,0.15759,1.24492,6.63798,1981.2425,303.95947,1.04869,0.65811,91.26695,1.01544,2425.7112,286.17792,14.45836
+"191","BY4741",11,115,9,40.99153,0.87,0.20231,1.93185,7.2693,2951.08748,491.33196,1.52077,0.88761,225.94665,1.54396,3266.36851,494.89135,18.77613
+"192","BY4741",23,115,9,27.84445,0.86434,0.19414,1.71807,7.92063,2901.05953,496.83428,1.40853,0.68317,218.40387,1.29475,3254.07391,477.8025,15.8347
+"193","BY4741",35,115,9,24.50425,0.89132,0.2022,1.85959,6.59129,2823.45129,431.77894,1.35352,0.71476,192.52624,1.25691,2777.25608,434.31197,14.73065
+"194","BY4741",47,115,9,15.57599,0.82981,0.18774,1.59749,4.75395,2493.34858,368.83898,1.22247,0.64233,156.47568,1.10385,2293.89357,271.9344,13.83534
+"195","BY4741",59,115,9,17.80843,0.87495,0.19575,2.0589,5.30864,2545.56672,408.35854,1.25187,0.65759,178.78415,1.30575,2580.9524,305.94453,14.4552
+"196","BY4741",71,115,9,23.15003,0.87829,0.19981,1.71942,6.28679,2772.82352,440.56025,1.34809,0.67167,186.27873,1.26745,2825.83829,425.6328,14.02066
+"197","BY4741",83,115,9,32.03981,0.95752,0.21651,1.889,6.77448,3442.53831,592.92298,1.57539,0.73736,247.45352,1.32491,3909.81623,701.90062,16.12123
+"198","BY4741",95,115,9,33.51138,0.93203,0.2125,2.04708,7.21457,3703.3579,644.3756,1.7072,0.61702,226.96644,1.79027,4318.97962,743.55985,16.71447
+"199","BY4741",11,116,9,37.55684,0.87453,0.20284,2.35987,7.25633,3157.85132,489.53311,1.57498,0.74341,171.123,1.51131,3300.71186,489.80757,16.28659
+"200","BY4741",23,116,9,31.82231,0.88492,0.20637,2.11313,7.59477,3208.7222,494.36306,1.5619,0.6686,155.24389,1.34681,3349.30071,499.72482,15.85408
+"201","BY4741",35,116,9,31.82643,0.89164,0.20549,2.36134,6.96302,2870.7057,463.22449,1.41018,0.67169,179.52801,1.4364,3097.36756,486.8431,15.60991
+"202","BY4741",47,116,9,19.34737,0.88528,0.19948,1.91321,5.10532,2745.66862,405.43297,1.3275,0.66975,155.14104,1.25127,2713.05198,324.29093,14.43506
+"203","BY4741",59,116,9,22.80736,0.92273,0.20431,1.84204,5.19217,2703.53077,414.30524,1.34285,0.72499,154.61248,1.27934,2690.06865,301.4001,15.37433
+"204","BY4741",71,116,9,24.31303,0.89796,0.19785,1.79287,7.33668,3006.67728,450.68591,1.39804,0.94582,153.75379,1.33454,2951.05653,400.84521,15.26015
+"205","BY4741",83,116,9,31.63187,0.94151,0.20882,1.96575,7.9039,3419.66949,574.81041,1.57144,0.65925,217.39792,1.42747,3918.48331,635.7223,15.81537
+"206","BY4741",95,116,9,47.61051,0.91156,0.22514,3.47852,70.0713,3679.49813,629.775,2.02325,0.6448,224.15071,3.14717,4333.06931,734.86413,17.1547
+"207","BY4741",11,117,9,53.05699,0.87515,0.20367,2.01301,7.05387,3097.40136,512.1285,1.66223,0.64995,176.30139,1.46327,3397.09143,505.50047,17.85783
+"208","BY4741",23,117,9,45.79521,0.85384,0.2094,1.92864,6.25294,2867.46746,446.21763,1.43651,0.6602,154.03138,1.27006,3036.42718,434.66136,15.70734
+"209","BY4741",35,117,9,23.15788,0.851,0.18604,1.66344,6.27415,2661.44372,405.99883,1.3063,0.75627,140.99575,1.13657,2578.57346,359.6133,13.98087
+"210","BY4741",47,117,9,30.63872,0.88818,0.2044,1.86935,4.73647,2818.69786,458.55506,1.37114,0.59586,164.8422,1.32426,2946.05097,401.27667,15.32256
+"211","BY4741",59,117,9,22.826,0.86959,0.19396,1.67487,4.65976,2530.85052,389.78709,1.26994,0.76782,143.5643,1.10586,2472.70874,303.94381,14.68287
+"212","BY4741",71,117,9,22.56287,0.87104,0.19069,1.64505,5.78935,2833.28277,421.32232,1.35241,0.70027,138.41924,1.11484,2817.61773,436.60692,14.51082
+"213","BY4741",83,117,9,32.1267,0.93687,0.21287,1.77751,6.22326,3362.34794,541.40515,1.55935,0.60696,167.88195,1.21998,3630.08722,626.83282,15.65582
+"214","BY4741",95,117,9,40.39828,0.8935,0.2143,1.8941,7.06633,3464.47264,583.22782,1.56638,0.65507,214.85806,1.28668,3935.74181,683.44202,17.293
+"215","BY4741",11,118,10,13.97113,0.79884,0.19411,2.00989,8.8275,2626.2718,420.259,1.31701,0.55948,93.80346,3.61917,3091.38093,276.21199,15.31093
+"216","BY4741",23,118,10,13.58546,0.78982,0.19537,1.84915,7.20444,2454.93201,372.6728,1.21693,0.63659,96.77667,1.88613,2920.66467,260.11805,14.41998
+"217","BY4741",35,118,10,26.02702,0.83588,0.20167,1.69959,10.41625,2822.74963,446.52226,1.35096,1.22389,170.0341,2.07178,3365.41714,768.21004,15.27356
+"218","BY4741",47,118,10,10.77121,0.81086,0.19406,1.58791,6.43075,2549.91669,372.73504,1.21782,0.59641,93.21165,1.60006,2933.64974,266.00455,14.39713
+"219","BY4741",59,118,10,13.32224,0.7943,0.19144,2.40851,8.01073,2235.94407,345.31999,1.2568,0.90315,99.66168,5.04827,2585.94291,183.01166,15.55667
+"220","BY4741",71,118,10,11.0127,0.81823,0.19239,1.63776,7.12017,2467.52091,363.47549,1.22525,0.67535,81.31015,2.07702,2908.05905,225.82233,14.15412
+"221","BY4741",83,118,10,14.89756,0.8416,0.19732,1.85504,7.91072,2443.57219,371.3724,1.28358,1.35582,96.53743,2.78538,2952.47067,238.31442,14.76266
+"222","BY4741",95,118,10,14.37718,0.86918,0.19411,2.33332,7.87193,2689.47065,387.82668,1.37587,0.89477,84.42619,4.99864,3090.63439,251.05703,16.39155
+"223","BY4741",11,119,10,14.02865,0.80963,0.19052,2.0603,7.18436,2686.66861,419.35134,1.33667,0.55552,80.26602,1.95801,3085.57831,252.53825,14.98332
+"224","BY4741",23,119,10,13.87727,0.79164,0.19687,1.68621,5.83008,2554.51958,395.38017,1.30802,0.59118,87.66839,1.78961,3084.98118,242.1214,14.86687
+"225","BY4741",35,119,10,16.35835,0.82206,0.19494,1.75268,7.06221,2740.41206,422.60501,1.32673,0.70715,91.77139,1.92242,3251.01107,292.52001,14.93739
+"226","BY4741",47,119,10,10.42987,0.82231,0.19243,1.64755,5.25268,2579.32911,387.26185,1.28156,0.50983,85.24021,1.58951,3025.55282,259.50991,14.42551
+"227","BY4741",59,119,10,10.33775,0.82485,0.19382,3.08834,6.05762,2504.21793,360.54937,1.23059,0.5938,76.42265,1.68923,2827.7063,249.44231,14.18439
+"228","BY4741",71,119,10,10.25561,0.81215,0.19129,1.91122,5.4239,2484.93272,347.82924,1.20972,0.57535,78.75172,1.33023,2760.24612,238.71594,13.96217
+"229","BY4741",83,119,10,9.11119,0.83199,0.19091,1.68775,5.81448,2459.7603,369.77202,1.19351,0.54931,91.5587,1.30598,2938.62084,234.6643,14.28383
+"230","BY4741",95,119,10,8.80293,0.8505,0.19472,1.5273,4.2687,2688.84693,390.62294,1.26357,0.49753,75.6484,1.4349,3143.62501,223.33992,14.71784
+"231","BY4741",11,120,10,8.62401,0.79359,0.18929,1.47914,4.84924,2532.06999,429.7536,1.27529,0.8619,93.93126,1.07961,3124.54893,255.57527,14.05816
+"232","BY4741",23,120,10,6.97242,0.77838,0.18711,1.55195,4.39428,2376.60407,367.25015,1.17808,0.82246,94.10282,1.11754,2904.83712,234.90824,13.66204
+"233","BY4741",35,120,10,8.622,0.79001,0.19431,1.79453,5.39856,2505.67118,387.03587,1.26051,0.68216,88.88397,2.34269,2878.65986,253.23832,14.24239
+"234","BY4741",47,120,10,10.91052,0.79835,0.19126,1.49753,4.66742,2493.69258,394.37015,1.27073,0.53179,90.70099,1.11386,2958.35317,255.41096,13.78889
+"235","BY4741",59,120,10,6.1582,0.78789,0.18865,2.02455,4.39427,2217.80718,344.74271,1.13817,0.58524,95.22871,1.08302,2602.48301,186.04373,13.77036
+"236","BY4741",71,120,10,9.50096,0.8202,0.18787,1.48644,4.69588,2387.58674,355.81865,1.20673,0.66184,77.64182,1.06019,2784.06933,229.31268,13.95362
+"237","BY4741",83,120,10,7.54153,0.82379,0.18974,1.46102,4.09342,2307.40512,373.64341,1.14993,0.56496,98.04384,1.06022,2925.42857,190.64124,14.31144
+"238","BY4741",95,120,10,7.07739,0.84633,0.18782,1.52749,4.32494,2520.26444,386.48479,1.23558,0.61503,77.32933,1.26959,3090.04928,191.25554,14.35801
+"1649","YBR174C",2,101,4,54.38866,0.64461,0.13317,1.51526,6.21482,2696.78004,486.21667,1.10034,0.78018,238.67318,0.7563,3071.13349,570.96164,15.32199
+"1650","YBR174C",14,101,4,37.57975,0.66027,0.1357,1.4344,5.26281,2543.67217,389.2968,1.04294,0.71982,195.81168,0.71624,2709.10261,567.44245,13.96466
+"1651","YBR174C",26,101,4,28.63551,0.67887,0.13106,1.39922,5.35535,2197.64926,282.57035,0.91424,0.86596,144.69565,0.70996,2076.83595,417.02072,13.1415
+"1652","YBR174C",38,101,4,24.72283,0.6524,0.12482,1.26805,5.54505,1820.17601,260.90263,0.82922,0.77831,149.88327,0.61367,1888.37881,389.13783,12.77515
+"1653","YBR174C",50,101,4,22.04526,0.6904,0.1307,1.28197,5.37082,1808.85318,231.66828,0.83695,1.0741,127.76107,0.67259,1821.45078,360.5815,13.04218
+"1654","YBR174C",62,101,4,19.59032,0.6879,0.123,1.26884,4.1605,1788.89542,227.52617,0.80485,0.76096,120.47321,0.60237,1729.08776,314.53705,12.66103
+"1655","YBR174C",74,101,4,19.41936,0.69292,0.12291,1.24642,5.5486,1600.223,193.44007,0.7457,1.1168,101.79694,0.67499,1546.72366,265.86402,12.16183
+"1656","YBR174C",86,101,4,20.27877,0.70114,0.11432,1.24958,4.11692,1405.29902,152.20235,0.65168,0.85542,93.10392,0.5707,1263.31946,223.93811,11.8793
+"1657","YBR175W",4,101,4,39.35024,0.68931,0.14431,1.43823,6.02424,2565.79812,394.20676,1.0504,0.85964,176.73066,0.79364,2676.67842,521.03509,14.51971
+"1658","YBR175W",16,101,4,35.25975,0.68283,0.13811,1.37062,5.68011,2338.06965,328.29841,0.99498,0.80625,133.20502,0.70787,2407.27867,504.12299,14.12735
+"1659","YBR175W",28,101,4,30.28514,0.70265,0.14192,1.38333,6.83678,2359.41485,346.26673,0.98684,0.94926,172.21996,0.84633,2471.24507,550.89835,14.31345
+"1660","YBR175W",40,101,4,25.37405,0.69874,0.13528,1.30916,5.55052,2011.51405,273.96705,0.87197,0.84515,144.44292,0.62361,2058.33154,450.12842,13.59228
+"1661","YBR175W",52,101,4,26.88842,0.71087,0.13777,1.34122,8.93391,2113.10315,288.51449,0.89186,0.83672,160.58741,0.68487,2161.09471,488.27355,14.06688
+"1662","YBR175W",64,101,4,30.40406,0.75873,0.14934,1.4306,5.51305,2239.09801,339.84604,0.95729,0.83701,177.88412,0.71313,2591.91744,539.58602,15.01269
+"1663","YBR175W",76,101,4,25.16136,0.76059,0.13552,1.34193,6.40003,1789.99911,234.3512,0.78865,0.92524,130.54431,0.64335,1845.51218,397.19098,13.91687
+"1664","YBR175W",88,101,4,20.38385,0.74925,0.12317,1.22748,11.66365,1409.3983,159.55699,0.68047,0.84028,82.56241,0.61761,1243.43502,221.66045,12.99553
+"1665","YBR176W",5,101,4,49.2865,0.78912,0.15511,1.38143,5.32212,2955.99443,467.42592,1.23096,0.79854,119.16587,0.91479,3219.55278,447.00194,14.19942
+"1666","YBR176W",17,101,4,37.59841,0.7603,0.14707,1.18602,5.13672,2616.84403,386.65585,1.07979,0.52887,100.78629,0.74265,2716.78937,474.46363,12.53372
+"1667","YBR176W",29,101,4,32.91935,0.77197,0.14467,1.15032,5.25531,2434.46544,321.51827,1.00509,0.51281,98.30386,0.76812,2427.03571,425.89124,12.45295
+"1668","YBR176W",41,101,4,30.3602,0.76776,0.14326,1.16546,4.92524,2298.73119,320.34837,0.99322,0.51062,88.91296,0.7288,2290.61112,363.0139,12.26444
+"1669","YBR176W",53,101,4,28.16399,0.80706,0.14574,1.17626,5.49486,2070.40281,273.23868,0.91475,0.59298,89.31617,0.76495,2170.93867,345.16307,12.4498
+"1670","YBR176W",65,101,4,31.0326,0.89836,0.15454,1.35505,5.40244,2304.98862,295.27941,1.00985,0.72494,96.0374,0.89204,2216.88589,384.42236,13.87839
+"1671","YBR176W",77,101,4,32.07507,0.86744,0.14493,1.18318,4.1616,2035.99531,238.71901,0.89547,0.55353,76.58785,0.91773,1936.60595,299.15179,13.33997
+"1672","YBR176W",89,101,4,34.42733,0.86983,0.13132,1.10202,3.56592,1684.69194,177.23335,0.77601,0.51641,49.00886,0.69373,1369.07351,201.414,14.542
+"1673","YBR177C",7,101,4,83.39483,0.85903,0.17313,2.10249,6.44281,2929.14341,538.04987,1.27459,0.54289,197.95576,1.5336,3441.01887,562.38372,16.23047
+"1674","YBR177C",19,101,4,52.34927,0.788,0.15164,1.54254,5.43554,2362.08931,372.12147,1.046,0.49813,121.95798,1.07442,2621.77699,455.50492,13.34694
+"1675","YBR177C",31,101,4,29.8693,0.80736,0.14805,1.20494,7.96562,2236.74464,317.86691,0.98416,0.5211,103.28625,0.82446,2350.09012,377.49802,12.6156
+"1676","YBR177C",43,101,4,30.13186,0.82365,0.14937,1.2072,5.16777,2191.02053,303.60386,0.95566,0.47007,111.68255,0.87123,2214.09411,377.56515,12.91333
+"1677","YBR177C",55,101,4,25.59177,0.8447,0.14678,1.13929,4.79793,1931.81979,309.72243,0.8956,0.56133,118.06853,0.80296,2313.63456,330.86946,12.51089
+"1678","YBR177C",67,101,4,24.63919,0.8576,0.13818,1.12625,4.38298,1956.4703,256.51775,0.87812,0.49908,89.51452,0.72155,1956.97202,316.72419,12.02449
+"1679","YBR177C",79,101,4,27.78265,0.90074,0.15073,1.20388,5.10202,1966.87771,274.95069,0.92856,0.59863,98.0608,0.80417,2112.69803,308.99562,12.72987
+"1680","YBR177C",91,101,4,29.34239,0.90778,0.13571,1.39497,5.63233,1659.47105,180.69513,0.78575,0.61482,63.61269,0.67252,1398.49603,200.94224,12.31443
+"1681","YBR178W",8,101,4,46.12861,0.79004,0.15676,1.33474,6.49884,2608.01554,428.09264,1.13805,0.47428,117.29703,0.86771,2984.06124,539.99164,13.49389
+"1682","YBR178W",20,101,4,40.65863,0.79997,0.15336,1.28188,5.44071,2403.92987,390.80752,1.08785,0.75486,110.13523,0.86612,2710.62329,469.27986,12.86016
+"1683","YBR178W",32,101,4,33.36968,0.8083,0.14495,1.20147,5.08326,2100.38624,318.45308,0.98754,0.49284,104.27365,0.77045,2385.76909,425.84687,12.27441
+"1684","YBR178W",44,101,4,34.51051,0.85971,0.16363,1.32865,5.1778,2336.39907,388.88262,1.08108,0.48738,137.74034,0.88589,2857.01142,461.40929,13.38907
+"1685","YBR178W",56,101,4,45.48859,0.87752,0.15395,1.23072,7.72455,2084.88316,299.09938,0.98051,0.56149,100.57016,0.78418,2332.30889,392.87215,13.01162
+"1686","YBR178W",68,101,4,28.58643,0.91023,0.1544,1.26016,4.8543,1990.7032,272.61043,0.9627,0.54488,95.16045,0.82399,2181.94078,335.56622,13.1586
+"1687","YBR178W",80,101,4,26.13357,0.82564,0.1328,1.10324,3.69988,1492.44006,203.4533,0.73381,0.45263,74.05448,0.69398,1563.35223,225.98934,11.42384
+"1688","YBR178W",92,101,4,40.48687,0.90378,0.14633,1.19974,4.20797,1604.55289,210.44336,0.82561,0.60362,73.11197,0.84999,1637.04137,220.62848,13.01414
+"1689","YBR179C",9,101,4,52.83266,0.82256,0.17256,1.34974,5.45366,1014.74802,447.06836,0.68061,0.16698,111.62961,1.24024,2709.36439,620.54053,14.01406
+"1690","YBR179C",21,101,4,38.97522,0.81225,0.17541,1.76113,6.0312,993.15261,480.0113,0.63248,0.22924,121.10285,1.07356,2863.69907,647.93329,13.72373
+"1691","YBR179C",33,101,4,31.08183,0.85199,0.16887,1.22962,5.66913,894.18017,333.48649,0.56369,0.2295,89.32067,1.51523,2199.65803,493.69352,12.76968
+"1692","YBR179C",45,101,4,24.622,0.8277,0.15968,1.07803,4.91516,760.34225,297.81013,0.50223,0.25215,70.85917,0.88967,1928.48214,384.7688,12.08082
+"1693","YBR179C",57,101,4,24.55509,0.84928,0.1567,1.09959,4.66996,725.43094,269.57972,0.47253,0.2067,65.03187,0.85805,1757.2187,358.40299,12.20065
+"1694","YBR179C",69,101,4,25.41083,0.90885,0.16661,1.1372,5.43053,788.1041,281.94522,0.51592,0.26247,75.81167,0.95064,1991.06672,389.17784,12.9935
+"1695","YBR179C",81,101,4,22.43298,0.84356,0.14925,0.98686,4.09629,645.46789,222.75392,0.4249,0.25667,59.16137,0.84091,1578.34817,285.9996,11.44432
+"1696","YBR179C",93,101,4,28.35448,0.89117,0.14932,1.12763,4.72257,635.47346,218.11266,0.44394,0.24546,52.22863,0.90359,1401.52101,295.1846,12.60822
+"1697","YBR180W",10,101,4,63.70041,0.78742,0.15737,1.37994,8.40884,2579.04401,465.70477,1.18263,0.5378,164.54673,0.904,3103.46931,579.5211,13.89379
+"1698","YBR180W",22,101,4,43.25859,0.78216,0.15246,1.32051,6.03388,2352.75102,417.84588,1.02954,0.49794,169.133,0.89855,2821.68091,558.07571,13.5299
+"1699","YBR180W",34,101,4,33.40074,0.81996,0.15054,1.24582,5.08929,2099.14316,331.34218,0.98522,0.49566,116.06617,0.75591,2311.59301,395.03893,12.66572
+"1700","YBR180W",46,101,4,31.40664,0.83666,0.15247,1.22989,5.76041,2118.11367,328.54308,0.96766,0.47317,127.12859,0.7754,2463.3743,424.85869,12.89462
+"1701","YBR180W",58,101,4,34.02252,0.86269,0.15757,1.35187,5.49551,2107.48546,350.46096,0.96921,0.53361,138.43548,0.82146,2511.2047,429.19053,13.42668
+"1702","YBR180W",70,101,4,29.78884,0.88051,0.15234,1.2271,4.79069,2001.79771,304.82352,0.93816,0.48941,116.17877,0.76263,2379.78762,381.43216,13.09399
+"1703","YBR180W",82,101,4,26.2681,0.86102,0.14222,1.20065,3.94731,1593.32558,225.2709,0.79161,0.48419,93.98498,1.11388,1726.37523,256.68756,12.19577
+"1704","YBR180W",94,101,4,24.29517,0.86175,0.13074,1.13268,3.58581,1473.15737,179.37152,0.72037,0.50523,69.85943,1.31161,1329.27784,193.30479,11.87735
+"1705","YBR181C",2,102,4,75.27486,0.75819,0.14907,1.36917,5.53712,3072.0217,469.92854,1.2408,0.54853,128.97737,0.73142,3046.0105,490.63558,13.9578
+"1706","YBR181C",14,102,4,52.6799,0.77505,0.14463,1.28962,4.49135,2697.15085,378.79686,1.10576,0.52595,98.83508,0.59687,2513.50256,467.68832,12.66003
+"1707","YBR181C",26,102,4,35.12726,0.79081,0.14297,1.14463,4.26261,2516.25685,326.12512,1.02986,0.53045,77.94061,0.48129,2319.28926,387.94604,12.03586
+"1708","YBR181C",38,102,4,39.43544,0.81402,0.14673,1.1947,4.56318,2555.72661,323.53347,1.03145,0.5718,86.56625,0.49291,2216.07556,396.32423,12.49388
+"1709","YBR181C",50,102,4,34.73344,0.86409,0.14427,1.23929,4.82018,2369.29912,270.7277,1.01922,0.61718,72.2412,0.51135,2042.03304,352.16224,12.29278
+"1710","YBR181C",62,102,4,31.84406,0.86688,0.13909,1.27548,4.02759,2198.60051,251.05659,0.96752,0.67048,64.31643,0.49636,1853.18925,327.60653,12.83085
+"1711","YBR181C",74,102,4,26.48359,0.85333,0.13636,1.22013,4.7881,2048.26606,217.75492,0.90916,0.76159,57.14637,0.48953,1695.94864,257.53379,12.18111
+"1712","YBR181C",86,102,4,33.24134,0.88814,0.13442,1.21494,4.23239,1864.26226,195.31248,0.81972,0.62717,50.82126,0.53076,1425.11002,233.97336,12.3232
+"1713","YBR182C",3,102,4,64.82896,0.78261,0.15741,1.41094,5.07649,3068.56232,540.93544,1.24496,0.4537,143.97097,0.81488,3472.93608,577.97876,14.44359
+"1714","YBR182C",15,102,4,36.9952,0.74339,0.13959,1.19377,4.4366,2461.76179,348.32961,1.03651,0.42294,82.09721,0.61259,2379.3841,456.16533,12.05238
+"1715","YBR182C",27,102,4,36.79883,0.75293,0.14007,1.13723,3.89034,2374.71595,348.26569,1.01174,0.43273,100.48253,0.62499,2593.74007,466.20627,12.15093
+"1716","YBR182C",39,102,4,32.21279,0.76178,0.13555,1.10138,4.59918,2211.52703,277.49309,0.94198,0.51558,78.56939,0.66866,2149.98628,383.28139,11.82045
+"1717","YBR182C",51,102,4,40.76852,0.90125,0.16052,1.36168,5.23692,2586.72735,362.1486,1.12212,0.58201,93.69706,0.71415,2630.25586,475.60923,14.00668
+"1718","YBR182C",63,102,4,37.42841,0.89618,0.15921,1.37626,4.62951,2636.8664,347.56825,1.11199,0.50047,90.37911,0.7262,2647.58845,461.51502,13.68449
+"1719","YBR182C",75,102,4,29.97356,0.8504,0.14275,1.22047,4.33619,2133.73942,284.68974,0.92588,0.5599,77.60907,0.60546,2200.03671,374.22616,12.32502
+"1720","YBR182C",87,102,4,28.45517,0.82309,0.12468,1.15333,3.19652,1545.79308,157.45888,0.77905,0.54384,42.90587,0.76654,1194.95303,149.42034,11.54324
+"1721","YBR183W",4,102,4,70.81351,0.74522,0.14881,1.35984,5.1113,2901.9663,498.04939,1.17985,0.44675,135.22197,0.79511,3181.22222,526.9726,14.37879
+"1722","YBR183W",16,102,4,49.98867,0.73797,0.14162,1.177,10.6529,2521.58343,366.61652,1.08211,0.43092,91.00866,1.77657,2496.08136,457.57577,12.56241
+"1723","YBR183W",28,102,4,37.41654,0.76951,0.14331,1.18901,4.64902,2420.64576,364.31403,1.01689,0.47105,98.87141,0.6402,2525.20059,464.52458,12.36928
+"1724","YBR183W",40,102,4,30.4806,0.75729,0.13669,1.12253,4.37064,2326.00839,310.88909,0.93975,0.47424,78.89135,0.84356,2180.58272,378.53257,11.8328
+"1725","YBR183W",52,102,4,30.50255,0.77685,0.13096,1.12303,3.81959,2027.17109,243.13588,0.85996,0.50904,74.74248,0.58787,1903.82253,356.6002,11.7221
+"1726","YBR183W",64,102,4,31.41227,0.76832,0.13783,1.13119,3.83167,2188.28685,312.87727,0.93826,0.41485,95.20629,0.59591,2287.86142,400.03058,11.87292
+"1727","YBR183W",76,102,4,25.84441,0.79649,0.12931,1.06449,3.40707,1831.94444,211.85733,0.81901,0.49116,56.95829,0.57001,1611.11524,244.58937,11.33499
+"1728","YBR183W",88,102,4,26.28442,0.85039,0.12546,1.151,3.00673,1643.04201,176.7961,0.80809,0.48644,47.5097,0.58587,1384.92222,202.11391,11.54164
+"1729","YBR184W",5,102,4,106.91328,1.2156,0.1586,1.58268,4.76915,2151.24561,401.60376,1.45477,0.65681,59.06688,1.45815,2806.44039,440.91367,15.05081
+"1730","YBR184W",17,102,4,61.53122,1.28165,0.16275,1.27823,4.96562,2111.00314,359.04039,1.46881,0.64645,39.22902,1.18416,2629.31783,518.50305,13.08605
+"1731","YBR184W",29,102,4,51.61591,1.34539,0.16547,1.26267,4.9712,1986.7727,349.00642,1.3746,0.80358,38.90483,1.18461,2602.50397,477.9176,12.90609
+"1732","YBR184W",41,102,4,50.22097,1.33389,0.15798,1.27025,3.97925,1921.12254,289.7631,1.3126,0.63732,31.99465,1.08289,2301.89895,396.47431,12.43702
+"1733","YBR184W",53,102,4,46.71939,1.3611,0.16204,1.31538,4.7201,1980.48158,334.10848,1.3584,0.80418,39.28915,1.16655,2543.85715,454.29613,13.28199
+"1734","YBR184W",65,102,4,51.38135,1.47878,0.16783,1.41017,4.6828,1866.62258,311.11347,1.30194,0.75386,34.8295,1.27084,2508.68043,422.5708,13.74693
+"1735","YBR184W",77,102,4,42.11005,1.39333,0.15218,1.27729,3.77178,1518.57645,211.28563,1.11786,0.7482,24.94216,1.04826,1691.43861,287.24565,13.00525
+"1736","YBR184W",89,102,4,40.87713,1.40202,0.13593,1.28137,3.57836,1296.78197,172.5094,1.01971,0.78291,21.92317,1.10234,1400.71434,223.13439,13.64757
+"1737","YBR185C",7,102,4,84.34189,0.8256,0.16794,2.06243,5.73002,2391.9557,522.96784,1.24226,0.39694,218.13618,1.61757,3276.37072,639.48455,17.47023
+"1738","YBR185C",19,102,4,53.41696,0.79861,0.15552,1.51154,4.54473,2060.45644,390.30938,0.91722,0.35048,162.72823,0.94822,2624.69768,501.4954,13.95223
+"1739","YBR185C",31,102,4,30.51869,0.78273,0.14361,1.13417,3.81276,1624.63799,285.72686,0.76975,0.38085,132.41799,0.72198,2078.91808,373.86924,12.2498
+"1740","YBR185C",43,102,4,32.95116,0.85697,0.14877,1.29646,4.17344,1693.18954,292.9533,0.7752,0.39232,135.75849,0.69782,2150.32549,387.0489,13.15105
+"1741","YBR185C",55,102,4,41.19253,0.89759,0.16657,1.36484,5.29458,1817.30102,356.99207,0.83615,0.48092,165.36272,0.81889,2509.68,484.36965,14.22081
+"1742","YBR185C",67,102,4,52.50631,0.84162,0.14278,1.5224,4.78837,1546.51199,261.82635,0.7422,0.44209,130.19331,0.8706,1973.08018,346.41821,13.72019
+"1743","YBR185C",79,102,4,53.42712,0.93901,0.15541,1.73758,4.86015,1724.33065,299.54067,0.81094,0.4833,155.99823,0.96559,2257.37707,400.06669,15.01648
+"1744","YBR185C",91,102,4,34.44887,0.8572,0.1314,1.28814,4.19588,1107.0289,168.53646,0.63646,0.50483,93.51787,0.73442,1342.46276,199.51872,12.20801
+"1745","YBR186W",8,102,4,55.05554,0.76393,0.14777,1.48736,4.64648,2837.00409,446.06555,1.18432,0.40862,112.58181,0.84659,2942.7051,569.38002,14.42446
+"1746","YBR186W",20,102,4,53.31606,0.7967,0.15393,1.3156,4.60711,2746.44412,427.02533,1.16353,0.4841,117.75816,0.72463,2942.36758,563.49249,14.18414
+"1747","YBR186W",32,102,4,42.45902,0.77339,0.14078,1.20928,3.98541,2211.73023,309.71519,0.97453,0.43541,81.84912,0.64993,2218.86198,407.48145,12.84031
+"1748","YBR186W",44,102,4,37.49474,0.81629,0.14306,1.23758,4.07428,2012.50127,261.18457,0.91855,0.4867,77.17531,0.62417,1948.00731,386.16229,12.63501
+"1749","YBR186W",56,102,4,31.59505,0.75524,0.1287,1.12857,4.15666,1775.54041,251.90228,0.81379,0.47171,85.0084,0.65659,1855.52188,295.69364,11.47052
+"1750","YBR186W",68,102,4,35.14974,0.78381,0.1267,1.20257,3.26929,1771.0266,226.13046,0.83175,0.47728,66.32713,0.68166,1733.75991,283.10018,11.90176
+"1751","YBR186W",80,102,4,28.43096,0.78772,0.1262,1.16268,3.18614,1639.78444,176.94401,0.74604,0.43606,58.88961,0.55015,1454.91293,217.94658,11.41158
+"1752","YBR186W",92,102,4,32.48897,0.85704,0.13029,1.46973,8.33996,1629.70387,178.29483,0.875,1.41206,56.53587,0.70831,1394.30093,232.42524,12.73062
+"1753","YBR187W",9,102,4,51.01826,0.90635,0.16339,1.42043,5.33157,2581.96549,480.38941,2.25961,0.43348,136.86599,1.0975,3115.88001,641.5883,14.52428
+"1754","YBR187W",21,102,4,41.31859,0.9071,0.1542,1.22975,4.84565,2383.97863,373.76026,1.97653,0.42763,89.55794,0.90873,2546.51194,498.46657,13.29562
+"1755","YBR187W",33,102,4,39.53082,0.93572,0.15627,1.32236,5.20907,2311.04812,388.97357,1.99542,0.44432,108.7759,0.85504,2625.43077,494.4034,14.09076
+"1756","YBR187W",45,102,4,31.65773,0.94077,0.14823,1.18067,4.28583,1789.97978,278.45368,1.72964,0.45922,79.91236,0.8152,2121.99868,346.29882,12.90181
+"1757","YBR187W",57,102,4,31.03697,0.92005,0.1416,1.12149,4.77208,1661.60896,253.98101,1.62067,0.52694,89.13701,0.79594,1923.90976,349.96355,12.06535
+"1758","YBR187W",69,102,4,27.08249,0.90698,0.13909,1.07911,4.53338,1512.71825,228.20819,1.50039,0.49737,79.30055,0.69982,1703.52574,317.54678,11.73711
+"1759","YBR187W",81,102,4,25.13508,1.01391,0.14539,1.08921,4.5524,1719.37326,230.71539,1.662,0.58755,63.16691,0.65166,1740.01913,279.98349,12.35566
+"1760","YBR187W",93,102,4,33.46658,0.99955,0.13761,1.59969,4.55336,1489.26291,191.31414,1.55193,0.54096,57.37691,0.79649,1455.94837,240.3638,13.48599
+"1761","YBR188C",10,102,4,49.85214,0.78664,0.1559,1.41153,5.34365,2678.71598,385.24233,1.22662,0.56574,117.80854,1.0919,2658.55553,548.15323,14.13105
+"1762","YBR188C",22,102,4,41.56661,0.82553,0.16006,1.30324,6.21335,2884.26627,409.22912,1.24447,0.58724,125.95773,0.85537,2929.74218,575.25665,14.21495
+"1763","YBR188C",34,102,4,34.3983,0.79172,0.14585,1.20812,4.29904,2370.24799,300.43595,1.04631,0.5609,95.78066,0.80135,2233.55973,408.6708,12.95045
+"1764","YBR188C",46,102,4,44.16263,0.86453,0.15802,1.33158,5.17841,2505.41182,345.24723,1.11085,0.63025,121.05975,0.89163,2658.71141,477.37174,14.20778
+"1765","YBR188C",58,102,4,32.05963,0.78745,0.13369,1.11998,4.2436,1921.70117,239.72926,0.90272,0.51754,85.20327,0.70403,1839.74865,320.16979,11.96238
+"1766","YBR188C",70,102,4,43.14624,0.8572,0.15066,1.27601,5.05732,2318.80937,318.89465,1.07877,0.58233,115.8447,0.83951,2475.70772,432.88392,14.04899
+"1767","YBR188C",82,102,4,28.23278,0.85494,0.13625,1.56699,7.20712,1869.86753,213.93254,0.91582,0.66181,71.8471,2.65694,1705.64459,271.75383,12.70453
+"1768","YBR188C",94,102,4,34.3476,0.86293,0.13211,1.22375,4.06934,1685.64743,185.07442,0.87539,0.58217,62.59394,0.70292,1457.88186,212.67284,13.17297
+"1769","YBR194W",2,103,5,50.56121,0.79497,0.18857,1.64176,7.08066,2069.35398,517.47695,0.93566,2.02988,224.48208,1.15308,3338.54942,556.48445,18.09378
+"1770","YBR194W",14,103,5,40.4115,0.7768,0.18836,1.53443,4.624,2055.35166,474.9408,0.85405,1.52174,196.82718,0.99734,3095.77524,427.77882,16.78046
+"1771","YBR194W",26,103,5,34.87862,0.77937,0.17803,1.54216,5.90889,1956.73512,446.62116,0.86974,1.62468,182.99717,0.99925,2972.12346,376.25012,16.40142
+"1772","YBR194W",38,103,5,40.432,0.79099,0.18235,1.56493,5.92007,2113.11399,440.42607,0.87997,1.49991,187.07442,1.01642,3030.11946,465.5031,17.26189
+"1773","YBR194W",50,103,5,39.58899,0.81585,0.18382,1.55242,3.71615,1988.58183,404.03765,0.87224,1.31382,173.65965,1.21087,2916.28686,398.59918,17.2203
+"1774","YBR194W",62,103,5,31.39113,0.8065,0.17256,1.54433,3.75903,1806.35284,329.51251,0.83489,1.41018,143.91983,1.03928,2444.70621,291.78418,16.32033
+"1775","YBR194W",74,103,5,30.78682,0.83257,0.17429,1.47126,4.92295,1605.13359,270.18272,0.75111,1.56606,112.1979,0.96588,1947.81931,227.51881,16.49801
+"1776","YBR194W",86,103,5,35.07922,0.84994,0.17126,1.52773,5.03026,1692.32297,298.41065,0.79217,1.61224,125.56009,0.93678,2161.79753,316.53525,16.90616
+"1781","YBR195C",3,103,5,24.49434,1.02561,0.18703,1.3681,6.34686,3605.81842,553.94344,1.44848,1.04681,154.63247,0.91,4055.63404,483.74948,15.69748
+"1782","YBR195C",15,103,5,14.6383,1.03893,0.18186,1.35816,1.74667,3253.12755,437.1811,1.26323,0.65738,138.43891,0.85456,3202.44154,330.72416,14.60712
+"1783","YBR195C",27,103,5,19.63606,1.07611,0.18372,1.42331,3.19076,3406.36627,468.10372,1.3682,0.71952,161.17993,0.94781,3395.16673,372.3291,15.69901
+"1784","YBR195C",39,103,5,17.67219,1.05084,0.18727,1.36958,3.40091,3498.34034,456.39045,1.38294,0.80582,144.22272,0.93762,3468.43999,363.00781,14.89356
+"1785","YBR195C",51,103,5,13.84757,1.1101,0.18446,1.36094,2.47181,3020.81215,359.46193,1.22326,0.73402,124.22172,0.90078,2903.99203,261.68812,15.00942
+"1786","YBR195C",63,103,5,13.65393,1.07514,0.17614,1.40677,5.39405,2988.08941,342.43604,1.22316,1.18706,113.57286,0.85564,2725.50693,230.00241,14.77
+"1787","YBR195C",75,103,5,14.58415,1.137,0.18271,1.39942,3.36671,3139.22773,346.47033,1.27378,0.73681,107.24239,0.86791,2700.7866,328.24073,15.48909
+"1788","YBR195C",87,103,5,16.66642,1.14307,0.18227,1.3868,4.26598,3010.95683,338.63197,1.23634,0.78748,132.46261,0.91093,2629.84104,311.60665,15.34785
+"1789","YBR197C",4,103,5,38.94084,0.84648,0.16286,1.29868,5.03324,3216.85738,529.10488,1.16619,0.82004,134.10736,0.77582,3452.06466,420.74345,18.92
+"1790","YBR197C",16,103,5,22.12065,0.88004,0.16536,1.24756,17.61584,3009.14691,438.82967,1.16952,0.61452,104.90363,0.75592,2945.47331,334.46306,15.99024
+"1791","YBR197C",28,103,5,15.51227,0.89497,0.1646,1.35609,2.73158,2954.61621,441.78851,1.16869,0.58771,107.40113,0.78238,2943.45415,340.61594,14.66077
+"1792","YBR197C",40,103,5,12.00227,0.87471,0.16024,1.24122,3.17667,2724.08992,382.37996,1.09378,0.92842,100.34634,0.73914,2720.02581,254.84002,14.48857
+"1793","YBR197C",52,103,5,8.22252,0.91475,0.16252,1.26565,2.51727,2585.89557,340.8234,1.01192,0.78085,84.00736,0.75251,2431.46487,204.88296,14.20448
+"1794","YBR197C",64,103,5,7.4235,0.90825,0.16497,1.26654,2.74489,2618.16438,359.65733,1.03825,0.67976,81.17681,0.74017,2559.81237,208.17666,13.72907
+"1795","YBR197C",76,103,5,10.3215,0.97988,0.16408,1.3412,3.86333,2544.92306,301.42761,1.04806,0.87783,72.52049,0.78488,2141.579,257.99308,14.44085
+"1796","YBR197C",88,103,5,10.16279,0.95928,0.16434,1.30552,3.0608,2437.12222,295.09659,1.02029,0.66087,72.0089,0.97087,2128.21117,236.0747,14.28834
+"1797","YBR199W",5,103,5,19.64338,0.93658,0.17177,1.35038,2.79837,3015.0679,538.08236,1.20372,0.57758,151.08576,0.79651,3482.16054,399.99989,15.29072
+"1798","YBR199W",17,103,5,11.00519,0.89476,0.16387,1.30469,1.72771,2790.44158,449.38219,1.06823,0.49144,124.35931,0.76678,2978.63001,321.83398,14.15984
+"1799","YBR199W",29,103,5,13.69239,0.92197,0.17535,1.33137,3.01117,2861.53171,448.50988,1.06347,0.68,127.19854,0.79047,3163.14439,317.54667,14.67095
+"1800","YBR199W",41,103,5,11.80282,0.93057,0.1626,1.2913,3.49991,2656.39502,388.34286,1.03711,0.54559,106.27313,0.77025,2680.32771,280.79243,14.07062
+"1801","YBR199W",53,103,5,15.46526,0.96034,0.17534,1.35117,3.07224,2639.58659,412.70148,1.06109,0.73948,123.62549,0.83054,2987.90414,312.26847,15.09656
+"1802","YBR199W",65,103,5,15.98576,1.02423,0.18832,1.49351,3.99806,2882.0829,441.02285,1.13232,0.57011,139.93502,0.95022,3215.7669,366.71026,15.7985
+"1803","YBR199W",77,103,5,8.36214,1.03605,0.17089,1.33784,2.96505,2381.98161,309.00549,0.94615,0.67695,84.42159,0.81025,2112.42552,210.51569,14.85027
+"1804","YBR199W",89,103,5,19.16631,0.98514,0.15784,1.29246,3.48998,2239.39863,309.6097,0.9263,0.624,77.49026,0.74435,1959.46545,226.03051,13.70377
+"1805","YBR200W",7,103,5,47.85843,0.57969,0.15525,1.54443,2.82197,2349.29739,533.90534,1.33198,0.64812,155.61215,0.77337,3699.69634,467.5108,17.7276
+"1806","YBR200W",19,103,5,40.73986,0.57033,0.14829,1.45296,2.77779,2356.42661,460.85578,1.29229,0.60374,134.37449,0.7252,3325.83559,394.03327,18.09709
+"1807","YBR200W",31,103,5,43.03739,0.64787,0.16368,1.51473,3.6482,2469.9202,524.47678,1.37031,0.6303,153.46509,0.84713,3878.41721,481.43519,17.74307
+"1808","YBR200W",43,103,5,42.98086,0.62069,0.16028,1.50078,2.61255,2263.77206,471.88565,1.28115,0.53668,133.36159,0.7952,3483.61199,414.91207,17.43245
+"1809","YBR200W",55,103,5,43.34902,0.66241,0.16958,1.63851,4.14164,2410.64662,489.13626,1.36456,0.58832,141.29315,0.88147,3539.00033,386.86849,18.76129
+"1810","YBR200W",67,103,5,29.81362,0.64269,0.15161,1.46421,2.62505,1995.99967,347.81935,1.20101,0.55566,97.26868,0.75825,2599.59388,261.05697,16.52205
+"1811","YBR200W",79,103,5,27.75529,0.65807,0.14939,1.42222,1.77931,1871.42947,302.47478,1.07159,0.57651,88.74533,0.79068,2370.82108,228.64732,16.85918
+"1812","YBR200W",91,103,5,31.57901,0.63425,0.14081,1.36513,2.37826,1695.85217,298.0547,1.03255,0.7643,81.74109,0.75224,2033.20999,154.67965,17.28989
+"1817","YBR201W",8,103,5,24.55028,0.85537,0.15821,1.35372,3.53518,2708.83508,523.24709,1.45052,0.79169,175.83249,0.72693,3571.54894,347.6462,15.45081
+"1818","YBR201W",20,103,5,26.9462,0.9227,0.16865,1.43371,3.09363,3095.73926,547.76652,1.61679,0.62373,167.64122,0.77434,3963.06419,419.11475,16.44048
+"1819","YBR201W",32,103,5,27.82366,0.92823,0.17451,1.52993,3.7993,3104.12541,576.18874,1.64639,0.78284,161.75405,0.83752,4077.57832,434.33108,16.41977
+"1820","YBR201W",44,103,5,20.58852,0.92657,0.16348,1.45556,3.53594,2613.31264,407.91711,1.3806,0.57426,131.95547,0.74139,3041.3072,284.69501,15.42762
+"1821","YBR201W",56,103,5,30.41587,0.94848,0.16931,1.50885,6.41439,3027.47644,515.77087,1.59,0.99889,168.73843,0.8475,3836.7877,371.28822,17.52699
+"1822","YBR201W",68,103,5,17.69087,0.91889,0.1527,1.37671,3.87366,2265.4221,353.91237,1.26539,0.92282,128.73568,0.71526,2671.37691,238.094,14.65917
+"1823","YBR201W",80,103,5,13.65959,0.97065,0.15547,1.39785,2.9708,2202.78661,333.07376,1.28407,0.65036,109.97742,0.75138,2470.85447,191.72823,15.17745
+"1824","YBR201W",92,103,5,22.76572,1.00402,0.15573,1.44942,2.42373,2163.27724,287.42294,1.24782,0.58098,90.56308,0.74095,2110.73231,188.12648,16.47011
+"1829","YBR203W",9,103,5,20.61728,1.07465,0.17742,1.33588,1.8149,2814.31427,501.40607,1.40989,0.66705,123.47991,0.8895,3391.18055,372.36396,14.85743
+"1830","YBR203W",21,103,5,16.80563,1.07308,0.17534,1.32451,2.5165,2689.16533,456.32867,1.35704,0.52981,103.51919,0.88702,3155.98195,310.90642,14.04982
+"1831","YBR203W",33,103,5,20.81839,1.13992,0.18705,1.67853,3.10742,2901.27203,458.98721,1.42719,0.58734,100.08489,0.94512,3321.19981,340.89039,14.70118
+"1832","YBR203W",45,103,5,17.99571,1.10473,0.17355,1.36556,3.31166,2603.28294,375.72173,1.32144,0.59022,83.453,0.92357,2708.20477,253.34952,14.69626
+"1833","YBR203W",57,103,5,19.60434,1.18335,0.182,1.43746,2.1024,2638.02412,408.56162,1.37339,0.57069,88.29784,0.9668,2805.92425,276.0392,14.78861
+"1834","YBR203W",69,103,5,20.64057,1.13684,0.17801,1.45239,2.62308,2418.18965,383.58539,1.24074,0.60852,94.92122,1.11861,2867.3486,274.33216,15.01464
+"1835","YBR203W",81,103,5,10.43666,1.13178,0.16492,1.36871,1.17466,2212.59026,322.31494,1.11836,0.64887,77.11564,0.90342,2198.49733,183.72461,14.23792
+"1836","YBR203W",93,103,5,17.51897,1.15817,0.18375,1.44284,2.4925,2207.69399,337.41729,1.18713,0.65578,85.74287,0.99494,2354.53293,209.71922,15.77436
+"1837","YBR204C",10,103,5,14.66521,0.9749,0.17893,1.35654,2.44194,2873.58439,508.13986,1.31165,0.54011,191.76226,0.86288,3324.87279,345.58999,15.38107
+"1838","YBR204C",22,103,5,13.95004,0.97493,0.17812,1.3121,2.72834,2768.99624,442.5596,1.26791,0.54066,179.43207,0.86803,3109.09442,353.67434,14.3834
+"1839","YBR204C",34,103,5,14.04737,1.00783,0.17623,1.39992,3.15095,2804.089,457.78722,1.27622,0.56608,155.6237,0.88287,3014.52399,286.75393,15.06778
+"1840","YBR204C",46,103,5,20.55519,1.04014,0.1893,1.47511,3.57393,2982.04941,484.74748,1.37402,0.59428,197.34954,0.9304,3486.40819,405.58653,15.80526
+"1841","YBR204C",58,103,5,21.19849,1.07026,0.19495,1.50991,3.63366,2867.20497,476.84207,1.37635,0.58831,185.85573,0.97925,3318.69609,368.4461,16.21142
+"1842","YBR204C",70,103,5,11.6671,1.0238,0.17601,1.37077,2.33346,2342.67037,352.29132,1.12384,0.50381,146.29606,0.91759,2425.96502,233.61493,14.33051
+"1843","YBR204C",82,103,5,8.23034,1.01966,0.17318,1.38794,1.85107,2234.87089,325.93575,1.08525,0.63141,143.26272,0.9082,2298.08328,183.38066,14.38028
+"1844","YBR204C",94,103,5,6.74106,1.06693,0.17154,1.34468,2.30792,1985.67125,279.04739,1.01055,0.5864,119.3063,0.87422,1951.24923,156.77407,14.10981
+"1845","YBR205W",2,104,5,33.38715,0.95025,0.18778,1.43844,3.03663,3855.09662,649.13269,1.49295,0.52376,156.35302,0.78164,4522.10443,536.10596,19.55134
+"1846","YBR205W",14,104,5,17.26981,0.85189,0.16262,1.25927,1.85501,2952.13852,461.3828,1.19475,0.49925,126.41632,0.67677,3162.6011,293.16425,16.08296
+"1847","YBR205W",26,104,5,9.65548,0.84956,0.16038,1.2815,2.82745,2825.00461,439.13981,1.15239,0.53853,122.90107,0.65875,3010.85921,267.92988,14.14576
+"1848","YBR205W",38,104,5,12.66948,0.89933,0.16629,1.31563,2.82178,3047.97327,432.46749,1.23881,0.50679,106.72359,0.72139,3152.8235,291.358,14.4861
+"1849","YBR205W",50,104,5,13.69703,0.93525,0.17425,1.35978,2.78059,3045.07151,421.53192,1.2526,0.48015,107.39317,0.84885,3086.14607,306.24202,14.9737
+"1850","YBR205W",62,104,5,11.1249,0.96705,0.17292,1.36048,2.56532,2988.88865,407.38792,1.21453,0.49588,98.77404,0.73458,3055.32098,291.62305,14.88997
+"1851","YBR205W",74,104,5,13.93703,0.9821,0.1705,1.38811,5.26532,2917.94085,358.56607,1.24204,0.89604,94.99232,0.72191,2680.9122,262.77111,15.66099
+"1852","YBR205W",86,104,5,10.41114,0.92877,0.16109,1.32965,3.43672,2806.70065,322.18814,1.14305,0.54115,75.39799,0.68677,2214.33966,207.27227,14.21673
+"1853","YBR206W",3,104,5,21.00694,0.88239,0.1687,1.30054,1.588,3223.67512,539.78804,1.33044,0.38592,135.16454,0.70127,3612.29037,410.71585,15.93137
+"1854","YBR206W",15,104,5,14.9949,0.88779,0.17061,1.33769,1.88546,3003.49296,457.51801,1.22383,0.44496,116.93146,0.73028,3381.13359,327.40871,15.74861
+"1855","YBR206W",27,104,5,14.66282,0.90751,0.16758,1.31791,2.90889,2962.57335,457.33877,1.22859,0.5077,120.59119,0.70768,3236.2882,339.10747,14.53477
+"1856","YBR206W",39,104,5,14.5763,0.91974,0.16929,1.32917,2.75738,2874.22749,419.96538,1.21952,0.48825,111.10835,1.10884,2982.90192,297.90232,14.79226
+"1857","YBR206W",51,104,5,13.30221,0.91768,0.16218,1.2983,2.81579,2783.31969,373.1734,1.16834,0.5239,97.09649,0.70872,2678.36614,251.92886,14.64811
+"1858","YBR206W",63,104,5,17.44325,1.03337,0.18059,1.49363,3.41401,3046.79196,409.9161,1.27577,0.59049,115.73073,0.8673,3036.7633,334.21751,16.03625
+"1859","YBR206W",75,104,5,9.59596,1.00388,0.16296,1.34651,2.40801,2478.88989,287.19432,1.07687,0.4506,76.23719,0.72782,1936.56291,226.5845,14.62712
+"1860","YBR206W",87,104,5,32.47909,1.08802,0.19288,1.65554,3.99587,3201.89105,425.95916,1.38413,0.54194,120.6802,0.95274,3278.76927,370.28498,18.29721
+"1861","YBR207W",4,104,5,24.20692,0.96088,0.18932,1.42977,2.48107,3339.00585,577.61523,1.33764,0.54801,136.67987,0.87733,3869.25028,455.09598,16.44427
+"1862","YBR207W",16,104,5,12.6303,0.91936,0.1732,1.30229,2.05132,3005.40922,477.26536,1.21882,0.64727,106.85741,0.82893,3270.06785,312.13708,15.5803
+"1863","YBR207W",28,104,5,15.00981,0.97306,0.17582,1.33823,3.33309,3032.33697,470.41585,1.19921,0.53947,107.66542,0.87311,3246.05193,323.66121,15.69129
+"1864","YBR207W",40,104,5,19.60002,0.98621,0.18777,1.42621,2.65245,3088.11053,464.2842,1.25248,0.50548,118.29544,0.89945,3467.64234,358.65384,15.94081
+"1865","YBR207W",52,104,5,13.49408,1.0104,0.17803,1.34172,2.96304,2777.77652,378.12816,1.14706,0.55265,84.49531,0.85619,2781.06209,252.92136,14.95032
+"1866","YBR207W",64,104,5,15.63083,1.03113,0.18032,1.41863,2.69026,2854.4306,396.71784,1.19465,0.61808,89.44418,0.89572,2960.81005,272.64711,15.36419
+"1867","YBR207W",76,104,5,8.68729,1.02359,0.172,1.31173,2.49419,2431.44601,332.55594,1.02437,0.62081,91.34627,0.8561,2415.21623,211.4087,14.68865
+"1868","YBR207W",88,104,5,22.924,1.07035,0.17185,1.3866,4.45055,2520.06394,327.01443,1.10283,0.5757,73.935,0.82785,2399.39658,245.89806,15.8129
+"1869","YBR208C",5,104,5,25.5521,0.88316,0.17444,1.38773,2.46391,3531.94012,573.06355,1.41516,0.48085,169.46386,0.72747,4083.78846,485.82264,17.12438
+"1870","YBR208C",17,104,5,16.65097,0.88919,0.17225,1.3849,1.98645,3291.27148,460.94559,1.29929,0.49958,131.78208,0.74446,3212.9361,331.12703,16.25716
+"1871","YBR208C",29,104,5,22.24959,0.91013,0.17584,1.42733,3.90914,3526.30615,531.15871,1.37555,0.53365,153.89406,0.8327,3842.64711,401.43731,16.38958
+"1872","YBR208C",41,104,5,21.16714,0.88773,0.16702,1.38141,4.00019,3173.71558,474.6881,1.31426,0.55832,140.58417,0.76298,3494.82633,342.40995,16.75976
+"1873","YBR208C",53,104,5,12.65973,0.90676,0.16705,1.36837,2.88945,2768.29161,361.94499,1.17558,0.4837,106.10016,0.71608,2544.55511,234.14286,15.05981
+"1874","YBR208C",65,104,5,15.17834,0.93173,0.17228,1.42811,3.2009,3089.84556,426.66572,1.28487,0.83778,125.58616,0.76654,3282.14298,286.8371,15.49428
+"1875","YBR208C",77,104,5,12.64247,0.91808,0.1568,1.33445,2.8565,2451.6443,313.33147,1.09529,0.73501,100.31564,0.7246,2424.8732,225.60304,14.80045
+"1876","YBR208C",89,104,5,46.1009,0.9722,0.17197,1.49077,3.05428,2793.15865,391.33049,1.2797,0.65117,112.18412,0.84742,2851.14788,307.29617,16.99405
+"1877","YBR209W",7,104,5,27.55656,0.84484,0.1766,1.43399,3.96917,3669.72828,480.78287,1.30341,0.73246,81.74209,0.79483,3224.98162,525.40303,19.95631
+"1878","YBR209W",19,104,5,14.42339,0.84622,0.17882,1.44365,7.21139,3722.38893,498.23482,1.32602,0.3649,82.80124,0.76115,3475.5548,510.46087,18.05762
+"1879","YBR209W",31,104,5,4.30722,0.85817,0.17427,1.4342,3.42363,3420.15147,421.70564,1.23243,0.32554,66.99473,0.71832,2934.44901,444.42463,17.20436
+"1880","YBR209W",43,104,5,9.80653,0.87416,0.17234,1.49399,3.6148,3331.78673,370.69338,1.20155,0.32677,62.22917,0.73796,2759.09048,413.24304,18.3383
+"1881","YBR209W",55,104,5,25.86679,0.89773,0.1792,1.58877,4.34968,3648.96061,441.66455,1.30175,0.35488,74.53424,0.79028,3302.67353,539.93204,21.86318
+"1882","YBR209W",67,104,5,16.91732,0.88584,0.16591,1.46426,18.6187,3162.93007,332.8834,1.23165,0.3437,48.37537,0.67475,2388.23519,351.13585,18.07684
+"1883","YBR209W",79,104,5,16.69873,0.92674,0.16811,1.47003,2.53036,3094.04618,300.6274,1.16828,0.36107,45.33924,0.7387,2130.31681,311.19229,17.96606
+"1884","YBR209W",91,104,5,7.85254,0.92395,0.16636,1.92171,3.17682,2839.56775,267.78254,1.07245,0.34804,34.18909,0.65768,1945.9673,235.76886,16.92306
+"1889","YBR210W",8,104,5,15.52023,0.95244,0.17623,1.31471,1.83485,3181.23804,527.90347,1.28895,0.44955,115.76653,0.73737,3509.83647,353.16952,14.38885
+"1890","YBR210W",20,104,5,8.65464,0.9172,0.16758,1.30296,1.96237,2839.35565,444.22262,1.15376,0.54108,104.97305,0.71727,3078.24356,287.51246,13.99487
+"1891","YBR210W",32,104,5,12.30514,0.94809,0.17266,1.34312,2.2323,2871.63399,453.89183,1.18824,0.42287,118.13576,0.78386,3278.02376,333.2986,14.48622
+"1892","YBR210W",44,104,5,13.17495,1.02559,0.17241,1.41358,2.7227,2790.41882,406.70992,1.18909,0.51701,103.16156,0.80417,2887.50672,286.29608,15.37517
+"1893","YBR210W",56,104,5,17.63979,0.98492,0.17861,1.47006,2.58291,2718.01342,415.60026,1.17963,0.5697,108.25104,0.89563,2977.04902,289.41089,15.70619
+"1894","YBR210W",68,104,5,13.7715,1.00354,0.16829,1.37684,2.66268,2792.38683,364.60539,1.17354,0.4399,72.93954,0.73451,2705.9387,278.86282,15.6388
+"1895","YBR210W",80,104,5,9.55879,0.99406,0.16168,1.34469,1.95579,2538.93669,325.26299,1.05349,0.46256,69.51098,0.71539,2301.33223,181.29945,14.85214
+"1896","YBR210W",92,104,5,19.16783,1.03331,0.16801,1.39544,2.84565,2421.93818,294.27047,1.07059,0.55898,64.55741,0.7561,2202.10205,206.94389,15.3214
+"1897","YBR212W",9,104,5,13.11311,0.99765,0.18251,1.39267,1.78498,2805.08748,554.65871,1.27585,0.48148,305.8604,0.79446,3770.56228,390.13915,15.00231
+"1898","YBR212W",21,104,5,10.35234,0.9852,0.17298,1.41025,2.7662,2715.59393,462.2892,1.26678,0.51067,237.83305,0.7935,3116.08245,301.80261,14.7057
+"1899","YBR212W",33,104,5,15.97226,1.01037,0.17879,1.4623,2.40734,2813.84916,482.69313,1.30945,0.49245,243.75165,0.84144,3276.89715,341.92925,15.52252
+"1900","YBR212W",45,104,5,14.41638,1.00731,0.17108,1.36494,3.19713,2570.68608,400.75543,1.22866,0.62541,212.11024,0.82625,2889.98241,286.87376,14.69534
+"1901","YBR212W",57,104,5,10.75367,1.03312,0.17006,1.37641,2.70886,2562.56508,382.31057,1.19821,0.53114,198.28128,0.77132,2756.0853,248.12284,14.91751
+"1902","YBR212W",69,104,5,13.83187,1.0571,0.17779,1.48516,3.85521,2565.67945,392.0018,1.20838,0.56917,184.32489,0.86397,2816.61498,293.73386,14.95687
+"1903","YBR212W",81,104,5,11.56295,1.02807,0.17026,1.4213,4.51609,2528.00321,333.8219,1.17373,0.55098,164.80284,0.7888,2552.80855,224.07725,14.66659
+"1904","YBR212W",93,104,5,18.29891,1.06115,0.16244,1.32221,2.58266,2430.38416,302.24902,1.154,0.50651,124.52689,0.73615,2164.68022,162.90221,14.6011
+"1905","YBR213W",10,104,5,17.92675,0.93278,0.17499,1.24434,1.3054,4242.11343,457.72347,1.50302,0.26201,53.07685,0.68864,3564.21927,344.62776,13.7314
+"1906","YBR213W",22,104,5,16.23044,0.97201,0.17748,1.32551,1.87198,4372.28553,503.24568,1.60574,0.30684,42.42851,0.81499,3954.94724,352.50683,15.00054
+"1907","YBR213W",34,104,5,16.6378,0.94852,0.1725,1.29646,1.94776,4185.77797,496.59769,1.53887,0.26319,40.83059,0.78737,3743.53313,341.57621,14.30854
+"1908","YBR213W",46,104,5,15.02218,0.94608,0.16515,1.26491,2.31499,3788.19827,370.87296,1.35597,0.27257,37.60124,0.71604,2933.87803,249.17938,13.81292
+"1909","YBR213W",58,104,5,21.23308,0.99554,0.1759,1.29909,2.69401,4147.29346,423.35443,1.5205,0.29649,42.18304,0.80827,3229.48092,291.42927,14.48594
+"1910","YBR213W",70,104,5,21.23542,1.02651,0.17505,1.3392,3.49223,3987.03314,346.51218,1.45997,0.32386,35.09845,0.83671,2789.81288,296.62231,14.54361
+"1911","YBR213W",82,104,5,11.41302,1.03332,0.1641,1.28206,2.38106,3418.19068,295.14266,1.32057,0.31068,17.25203,0.72665,2334.87021,173.41263,13.94026
+"1912","YBR213W",94,104,5,11.95368,0.96641,0.1587,1.21266,3.65492,3018.57868,277.08978,1.23131,0.33919,23.77836,0.64677,2191.4478,139.54026,13.47455
+"1913","YBR214W",2,105,5,26.7784,0.94838,0.17784,1.33212,3.24672,3563.14307,611.66295,1.42395,0.56783,101.3368,0.80266,3985.01768,494.92394,16.21261
+"1914","YBR214W",14,105,5,13.32256,0.94842,0.17425,1.2858,2.17344,3162.01769,501.75858,1.26581,0.92261,79.09281,0.83425,3319.06147,363.19973,15.08451
+"1915","YBR214W",26,105,5,18.77033,0.96526,0.17485,1.29237,2.52999,3197.33199,481.1937,1.2914,0.53008,81.84336,0.85508,3150.75251,353.20891,16.58147
+"1916","YBR214W",38,105,5,19.5528,1.03235,0.18373,1.42384,3.05048,3311.92227,466.45724,1.34421,0.84772,74.88928,1.00541,3357.94188,385.67121,16.67519
+"1917","YBR214W",50,105,5,13.6475,1.00073,0.17552,1.31365,4.06756,3008.31872,434.53944,1.21729,0.76145,62.89524,0.81229,3060.39059,356.37746,15.003
+"1918","YBR214W",62,105,5,14.13904,0.9793,0.17459,1.35703,2.83693,3046.83243,430.09711,1.19068,0.60788,80.63597,0.82518,3192.65764,326.1347,15.11759
+"1919","YBR214W",74,105,5,14.6469,1.00008,0.172,1.28998,2.72964,2853.75628,372.3005,1.22066,0.51613,56.71997,0.80982,2651.37976,320.52991,14.62901
+"1920","YBR214W",86,105,5,19.43716,1.00832,0.16925,1.29668,2.92091,2829.33915,360.51599,1.18773,0.55131,51.22631,0.75652,2419.99973,331.98901,14.94658
+"1921","YBR215W",3,105,5,14.68697,0.88536,0.17487,1.29155,2.26539,3031.95827,468.2308,1.20165,0.54649,143.33979,0.71234,3134.5975,463.90705,15.97836
+"1922","YBR215W",15,105,5,14.95938,0.8882,0.1751,1.33555,1.65057,3023.17995,442.72048,1.168,0.51806,133.3177,0.74031,3062.06089,330.11497,16.89249
+"1923","YBR215W",27,105,5,8.82434,0.93316,0.17787,1.32884,3.72151,3120.25312,417.46187,1.16136,0.59951,117.39153,0.70383,2980.41947,339.46509,16.08087
+"1924","YBR215W",39,105,5,9.45314,0.88549,0.17111,1.27742,2.02153,2857.36759,383.81399,1.12089,0.49145,106.03743,0.69494,2752.61324,294.52877,15.07055
+"1925","YBR215W",51,105,5,7.95617,0.95175,0.1709,1.33035,1.9235,2806.75036,343.63527,1.10294,0.68084,86.22597,0.68686,2455.34613,219.76546,16.21891
+"1926","YBR215W",63,105,5,10.63327,0.95711,0.18165,1.3662,3.45171,3011.95729,393.40705,1.20338,0.57439,103.18494,0.76469,2872.00001,345.73921,16.2442
+"1927","YBR215W",75,105,5,6.8887,0.95172,0.16635,1.31452,1.47122,2549.03015,297.74837,1.07331,0.61215,75.52999,0.6799,2205.09208,243.82532,14.63714
+"1928","YBR215W",87,105,5,14.09053,1.01576,0.17386,1.39146,2.61139,2677.0054,328.57088,1.12732,0.72499,79.18862,0.73994,2289.35252,272.64011,16.22578
+"1929","YBR216C",4,105,5,29.12087,0.9164,0.18408,1.38477,23.78294,3114.72517,505.86562,1.39922,0.6543,151.00625,1.30742,3518.79637,419.29438,18.93741
+"1930","YBR216C",16,105,5,11.31005,0.94014,0.17649,1.24866,2.5398,2988.82596,419.94,1.27281,0.52945,111.34354,0.8156,2959.6356,305.2793,15.11172
+"1931","YBR216C",28,105,5,14.05109,0.92456,0.17487,1.26011,4.15563,2848.48886,457.0987,1.25291,0.71386,152.92815,0.93994,3257.27291,365.80197,14.8421
+"1932","YBR216C",40,105,5,12.09809,0.93212,0.16962,1.27343,2.1289,2712.91228,384.20416,1.20323,0.56854,118.73762,0.96578,2786.20877,284.16691,14.80502
+"1933","YBR216C",52,105,5,9.82322,1.01337,0.17453,1.30845,3.00221,2633.42632,355.69685,1.17781,0.53971,102.29069,0.94114,2628.00788,273.19616,14.58061
+"1934","YBR216C",64,105,5,17.3442,1.04011,0.18754,1.43943,2.6351,3267.70063,460.63668,1.38558,0.53443,126.16297,0.92877,3597.61434,388.9166,16.83619
+"1935","YBR216C",76,105,5,11.42639,1.05001,0.17587,1.33282,1.98386,2769.72117,300.00578,1.20028,0.56542,66.70405,0.81654,2323.81993,209.08096,15.779
+"1936","YBR216C",88,105,5,15.77072,1.04016,0.17192,1.28821,2.87593,2650.94261,305.64711,1.15275,0.77647,72.08436,0.80507,2282.45019,207.72384,14.85081
+"1937","YBR217W",5,105,5,20.08257,0.92835,0.17914,1.26401,2.86361,2683.59363,529.20016,1.26377,0.7875,317.21328,0.89008,3325.1089,452.23271,17.89475
+"1938","YBR217W",17,105,5,6.29136,0.91038,0.17898,1.19794,2.92119,2661.49856,510.91131,1.1989,0.72038,279.15746,0.74343,3298.02568,371.55439,15.62811
+"1939","YBR217W",29,105,5,10.24143,0.95238,0.17452,1.24141,2.64835,2571.79162,471.54388,1.20909,0.51155,263.77434,0.75862,3028.33154,375.42008,15.66498
+"1940","YBR217W",41,105,5,4.40107,0.98094,0.17626,1.24582,2.63159,2322.06811,397.52239,1.13509,0.74434,210.63742,0.89411,2649.95787,313.4652,15.08228
+"1941","YBR217W",53,105,5,4.26306,0.98051,0.17427,1.28071,2.87191,2257.62916,368.05157,1.0848,1.09919,194.95123,0.75487,2468.47584,234.28945,15.02447
+"1942","YBR217W",65,105,5,5.85927,0.9692,0.17353,1.20475,2.02823,2234.06245,352.95818,1.05053,0.52072,200.57345,0.72059,2548.18791,237.87012,14.55731
+"1943","YBR217W",89,105,5,14.58243,0.98594,0.16992,1.29118,2.75307,2101.67835,309.33631,1.04909,0.60407,186.20552,0.75784,2234.75103,268.91359,15.32181
+"1944","YBR218C",7,105,5,17.27289,0.89081,0.1727,1.3284,2.14055,3146.54905,542.20043,1.34566,0.58538,171.11175,0.76999,3626.12395,404.40517,14.95162
+"1945","YBR218C",19,105,5,12.57354,0.93215,0.17339,1.34411,2.14249,2928.7589,476.59953,1.28209,0.6925,154.22299,0.72322,3414.20562,349.45194,14.8323
+"1946","YBR218C",31,105,5,20.43774,0.93907,0.17872,1.3599,6.16549,3110.89136,512.24484,1.2965,0.49715,157.9707,0.76295,3526.54327,431.16077,17.15058
+"1947","YBR218C",43,105,5,11.39098,0.93455,0.17377,1.34504,2.67585,2568.94041,402.9631,1.15064,0.559,147.38777,0.80837,2866.18553,291.9105,14.81353
+"1948","YBR218C",55,105,5,10.41667,0.95445,0.16754,1.3208,2.56717,2583.94502,369.22921,1.13192,0.53368,114.65673,0.76564,2593.0202,264.22482,14.66164
+"1949","YBR218C",67,105,5,9.93749,0.93119,0.16727,1.30831,2.40537,2462.66313,366.04011,1.07279,0.96035,111.65383,0.73826,2657.80698,223.82377,14.33094
+"1950","YBR218C",79,105,5,8.06537,1.01264,0.17402,1.36828,2.33487,2382.2038,343.7933,1.13529,0.46698,90.14009,0.73467,2419.03651,230.00931,14.87964
+"1951","YBR218C",91,105,5,7.47038,1.0084,0.16678,1.28884,1.80341,2182.0712,273.90756,1.00593,0.55853,93.41775,0.95812,1963.63676,197.42451,14.3739
+"1952","YBR219C",8,105,5,16.48914,0.94645,0.17479,1.31715,2.53497,2583.9639,518.70423,1.25405,0.56351,193.41041,0.75598,3594.69552,395.39481,14.92976
+"1953","YBR219C",20,105,5,15.29248,0.95566,0.1702,1.33454,2.90916,2504.22403,461.35738,1.24971,0.98205,159.07314,0.72672,3191.61473,330.01461,14.02867
+"1954","YBR219C",32,105,5,15.459,0.97418,0.17548,1.34079,2.72167,2502.11248,465.72943,1.22107,0.53275,168.84832,0.77547,3195.75516,353.12453,14.46929
+"1955","YBR219C",44,105,5,13.59623,0.98993,0.17029,1.3051,2.72132,2391.79387,416.82414,1.15649,0.74369,136.48207,0.7672,2895.19747,304.52224,14.06501
+"1956","YBR219C",56,105,5,13.28971,1.04929,0.1844,1.40405,8.57858,2338.00668,411.32077,1.11269,0.5774,171.34398,0.8936,2988.64376,332.82402,15.0085
+"1957","YBR219C",68,105,5,11.26598,1.02024,0.16951,1.37643,2.04917,2203.01072,355.81121,1.07475,0.51385,120.47145,0.78814,2657.14676,245.53232,14.45316
+"1958","YBR219C",80,105,5,11.67124,1.06856,0.17934,1.37913,2.79864,2286.74016,357.85705,1.09906,0.52701,116.82863,0.76733,2588.11618,256.05475,15.042
+"1959","YBR219C",92,105,5,11.82972,1.06886,0.16965,1.33565,1.17422,1993.78788,287.08384,1.02114,0.48752,94.27029,0.86603,2029.51281,157.23881,14.78584
+"1960","YBR220C",9,105,5,12.92763,0.88678,0.17095,1.28575,1.97,2744.18419,516.56059,1.16719,0.6759,188.48964,0.77733,3304.24036,352.30007,15.00585
+"1961","YBR220C",21,105,5,11.27079,0.93898,0.1702,1.34961,3.0868,2809.29156,483.03393,1.15544,0.76091,153.96759,0.74267,3324.70238,355.09654,14.70365
+"1962","YBR220C",33,105,5,14.67717,0.94318,0.18222,1.41236,4.76698,2825.22572,501.47811,1.12764,0.6149,170.13032,0.83692,3583.09304,378.6079,15.64852
+"1963","YBR220C",45,105,5,10.03376,0.9312,0.17077,1.32878,3.37213,2594.87081,390.87581,1.13448,0.58782,114.40777,0.73465,2744.36653,293.67367,14.20941
+"1964","YBR220C",57,105,5,15.06405,0.95458,0.17345,1.3611,2.62375,2469.91249,384.7241,1.07604,0.65346,133.20687,0.75239,3047.1995,250.24435,14.64012
+"1965","YBR220C",69,105,5,9.58223,0.96045,0.16647,1.26963,3.05596,2330.17319,344.92186,0.98896,0.54502,112.91582,0.75514,2507.11459,241.49671,14.20379
+"1966","YBR220C",81,105,5,13.61064,1.0174,0.17102,1.32032,2.01645,2172.45933,342.26152,0.95814,0.51142,119.57125,0.80932,2464.95717,224.87184,15.08498
+"1967","YBR220C",93,105,5,25.62372,0.95326,0.16197,1.27795,1.71532,2108.75442,297.57103,0.90974,0.46437,96.71007,0.85213,2087.50081,184.31185,16.71347
+"1968","YBR221C",10,105,5,15.41703,1.06034,0.20478,1.5251,3.09296,2338.20493,498.51361,0.74545,0.33325,158.60492,1.0423,3284.52845,470.16857,16.1124
+"1969","YBR221C",22,105,5,14.25906,1.07873,0.20612,1.54796,3.23648,2407.48278,511.15351,0.77777,0.32426,153.60045,1.13048,3431.89399,423.7694,16.45103
+"1970","YBR221C",34,105,5,15.09583,1.05414,0.19872,1.52313,4.50792,2226.25161,452.1282,0.72705,0.36005,136.33936,1.0107,2931.9923,365.2079,15.72034
+"1971","YBR221C",46,105,5,13.21153,1.12752,0.20944,1.55459,4.03682,2282.79599,451.21436,0.75549,0.36858,136.75126,1.03882,3130.67875,397.81856,16.04693
+"1972","YBR221C",58,105,5,8.7997,1.12309,0.20546,1.49412,3.25331,2212.68203,412.8371,0.71363,0.2338,118.13972,0.99494,2815.18555,286.9633,15.90159
+"1973","YBR221C",70,105,5,11.88987,1.15064,0.19318,1.52555,3.46822,2072.25177,354.06285,0.69328,0.1996,105.60266,0.96032,2422.20905,317.65242,15.88736
+"1974","YBR221C",82,105,5,8.30715,1.17877,0.19924,1.51051,2.69017,1923.02724,325.49406,0.64564,0.22341,93.48448,1.07197,2263.43366,252.23321,15.38333
+"1975","YBR221C",94,105,5,9.59426,1.17488,0.19503,1.53559,2.95227,1885.80861,308.47095,0.62151,0.4211,99.43696,0.94537,2275.29884,265.18817,16.35444
+"1980","YBR222C",2,106,6,24.04391,0.66716,0.13162,0.95777,3.1663,2255.29794,417.22204,0.89312,0.41229,131.38511,0.53653,2735.49441,303.92788,11.03392
+"1981","YBR222C",14,106,6,19.97809,0.67153,0.15743,0.98916,2.75186,2104.38452,385.60819,0.81938,0.35838,125.07197,0.50638,2595.77233,314.48714,10.34578
+"1982","YBR222C",26,106,6,18.4472,0.68785,0.12712,1.0358,1.66226,1950.0215,348.32333,0.7665,0.37093,109.54444,0.49583,2217.44507,257.5749,11.31417
+"1983","YBR222C",38,106,6,16.63039,0.69207,0.12481,0.91825,1.68725,1945.52873,321.54169,0.74058,0.34857,98.12028,0.48504,2150.57084,255.43031,10.4322
+"1984","YBR222C",50,106,6,13.22618,0.66651,0.11779,0.78767,1.25157,1693.57983,254.85256,0.65558,0.43809,78.79594,0.42899,1681.93697,158.86781,9.96813
+"1985","YBR222C",62,106,6,12.09693,0.67927,0.11917,0.88248,2.25055,1739.74135,273.58558,0.6493,0.41542,73.94831,0.42402,1822.57413,164.16961,10.1486
+"1986","YBR222C",74,106,6,11.67875,0.69349,0.12386,0.88903,1.61755,1623.02911,257.66681,0.63801,0.39823,75.76887,0.47411,1661.40804,104.68541,10.48761
+"1987","YBR222C",86,106,6,21.49413,0.71275,0.12574,0.84814,1.22971,1681.50651,267.18287,0.64637,0.42754,70.61217,0.48694,1704.92138,94.32422,11.15991
+"1988","YBR223C",3,106,6,25.4103,0.7481,0.13565,1.0248,2.73878,2350.02358,391.37656,0.91635,0.36644,86.82075,0.57431,2590.40503,362.35368,11.70941
+"1989","YBR223C",15,106,6,18.73805,0.73842,0.13066,0.93309,2.15885,1911.74386,342.68332,0.80415,0.5373,81.02379,0.49605,2248.94039,324.055,10.8263
+"1990","YBR223C",27,106,6,19.67361,0.74967,0.13318,1.11042,2.45505,2096.16016,360.69465,0.82582,0.40347,79.03043,0.54833,2412.97658,273.47692,11.40543
+"1991","YBR223C",39,106,6,16.12284,0.71727,0.12725,0.86232,2.62608,1914.32528,326.90667,0.75374,0.4463,66.94996,0.48111,2138.87247,254.04463,10.68366
+"1992","YBR223C",51,106,6,11.78102,0.75004,0.12661,0.81291,2.1847,1719.35543,260.77473,0.68208,0.47882,48.93896,0.45589,1671.5151,150.23404,9.909
+"1993","YBR223C",63,106,6,10.97068,0.74492,0.12152,0.82415,24.32893,1569.08116,255.09547,0.666,0.35819,48.46979,0.44426,1613.84902,131.098,10.28537
+"1994","YBR223C",75,106,6,12.62194,0.74258,0.12268,0.82157,3.43207,1551.58106,247.30444,0.61963,0.88907,53.22564,0.49612,1588.61307,137.28565,10.2967
+"1995","YBR224W",4,106,6,32.46648,1.12003,0.14895,1.07136,3.41531,2174.17795,410.65686,1.35199,0.52026,17.81397,0.78146,2784.76487,359.11085,11.38758
+"1996","YBR224W",16,106,6,28.83356,1.06407,0.14213,1.04872,4.09118,1959.75596,382.20694,1.22403,0.49046,23.88235,0.74966,2594.24217,293.09292,10.79004
+"1997","YBR224W",28,106,6,30.42608,1.11086,0.14792,1.06085,3.07615,2087.5197,389.40011,1.25418,0.55101,20.50338,0.72204,2575.61865,334.41993,11.0188
+"1998","YBR224W",40,106,6,24.82149,1.07067,0.14135,0.89166,2.33221,1746.77673,323.94241,1.07193,0.48365,21.13599,0.69961,2331.2743,319.8382,10.53683
+"1999","YBR224W",52,106,6,16.52298,1.08513,0.13263,0.8686,1.80353,1533.84877,262.33796,0.94936,0.53036,3.59262,0.65637,1782.5225,121.52725,10.80081
+"2000","YBR224W",64,106,6,18.41803,1.09149,0.13408,0.89771,2.39995,1504.53983,258.43142,0.96894,1.0457,4.2851,0.65302,1749.35974,151.25339,10.48583
+"2001","YBR224W",76,106,6,38.39566,1.06656,0.13465,0.98603,1.89114,1598.53936,304.58705,0.99481,0.51785,27.71658,0.95431,2059.20753,181.3317,11.94596
+"2002","YBR225W",5,106,6,23.77356,0.68758,0.12769,1.0665,3.19052,2281.54684,340.37583,0.85498,0.34908,79.11255,0.44551,2452.57821,343.85657,11.54102
+"2003","YBR225W",17,106,6,19.54608,0.65491,0.1151,0.93147,2.22624,2066.72369,310.7758,0.76176,0.42828,63.91949,0.36876,2230.58064,242.84052,10.9307
+"2004","YBR225W",29,106,6,14.79529,0.67646,0.12011,0.92496,2.05064,1970.12021,286.06247,0.7261,0.32907,61.97769,0.39088,1918.59684,244.98655,10.5778
+"2005","YBR225W",41,106,6,16.08476,0.66973,0.1209,0.96954,2.2809,1820.83212,279.3578,0.71273,0.31194,71.51383,0.40569,1938.43323,256.27071,10.72133
+"2006","YBR225W",53,106,6,12.50186,0.66851,0.11089,1.70496,1.85832,1559.64993,252.53143,0.62719,0.38267,49.41472,0.36736,1717.24737,149.27407,11.31494
+"2007","YBR225W",65,106,6,11.105,0.70077,0.11478,0.8952,2.7711,1696.20622,228.01722,0.6427,0.54973,44.37213,0.35927,1545.33081,126.75681,10.50015
+"2008","YBR225W",77,106,6,14.28256,0.68847,0.11473,0.84254,2.5268,1689.52627,229.2339,0.61202,0.51932,53.97047,0.34595,1525.13874,129.13763,11.66468
+"2009","YBR225W",89,106,6,12.08106,0.68292,0.11367,0.75561,2.23606,1667.76269,208.25283,0.59777,0.40694,36.49031,0.31215,1412.5572,96.11331,10.35993
+"2010","YBR226C",7,106,6,22.9578,0.78983,0.14318,1.06583,2.98307,2146.67034,384.54504,0.81839,0.49194,73.8321,0.57061,2518.6286,319.84148,11.38413
+"2011","YBR226C",19,106,6,24.10135,0.76556,0.13732,1.02666,2.78968,1923.49419,353.04991,0.80347,0.48968,77.72862,0.63876,2231.28303,326.02858,11.27799
+"2012","YBR226C",31,106,6,19.29734,0.76256,0.131,1.25415,2.10414,1852.62423,325.97562,0.7071,0.30047,71.40373,0.7955,2142.34524,236.1356,11.61789
+"2013","YBR226C",43,106,6,17.01663,0.7682,0.12795,1.14131,9.28126,1662.61382,275.10706,0.65149,0.37557,57.07584,0.57488,1786.7255,205.37314,10.54949
+"2014","YBR226C",55,106,6,15.52454,0.76587,0.12877,0.93745,1.77831,1658.73293,326.87715,0.63951,0.38899,62.38168,0.50564,1926.18369,173.14542,10.64381
+"2015","YBR226C",67,106,6,15.98064,0.79109,0.12494,1.07934,2.79479,1481.53141,241.37237,0.57003,0.38763,45.77112,0.52796,1495.76084,134.05929,12.05285
+"2016","YBR226C",79,106,6,14.03553,0.75482,0.12908,0.98896,2.34517,1643.32514,287.2131,0.60284,0.74316,66.99976,0.53506,1872.26483,152.2228,11.02344
+"2017","YBR226C",91,106,6,12.849,0.76118,0.13048,0.85287,1.66613,1583.69705,260.86264,0.58358,0.43054,56.43256,0.47065,1751.95361,100.12886,10.66175
+"2018","YBR227C",8,106,6,28.0911,0.87167,0.1568,1.11605,3.21626,1840.81358,392.61901,0.68679,0.39032,110.05334,0.89225,2566.49688,314.25175,11.63761
+"2019","YBR227C",20,106,6,24.37816,0.89065,0.14822,1.14545,2.93915,2006.79565,413.73184,0.68099,0.33556,128.67763,0.9004,2934.00911,358.12445,11.48589
+"2020","YBR227C",32,106,6,21.53894,0.82629,0.13992,1.23847,2.22415,1502.72205,299.91353,0.51926,0.34318,111.47285,1.17899,2101.30167,319.67166,11.07624
+"2021","YBR227C",44,106,6,20.50705,0.88754,0.1367,1.17581,2.85699,1563.99901,302.36885,0.57263,0.35034,87.06054,0.92758,1911.6545,270.78982,11.132
+"2022","YBR227C",56,106,6,20.21947,0.89463,0.13562,1.01333,2.21081,1485.19812,310.43152,0.52659,0.28378,90.55981,0.84954,1947.28996,212.25292,10.88084
+"2023","YBR227C",68,106,6,12.79562,0.89449,0.13381,0.93112,1.82188,1394.16733,254.68417,0.47046,0.32092,71.37122,0.76973,1588.71751,91.38132,10.95802
+"2024","YBR227C",80,106,6,14.1542,0.89205,0.13765,0.97598,1.96404,1434.80565,285.87802,0.45836,0.34062,84.60024,0.77288,1886.83889,130.7815,11.16065
+"2025","YBR227C",92,106,6,12.07903,0.87702,0.13592,0.89062,1.78478,1376.38613,283.40812,0.43475,0.36251,76.64087,0.80284,1764.40313,112.39831,10.47688
+"2026","YBR228W",9,106,6,19.67373,0.65943,0.129,0.93921,2.6321,2151.96619,332.99935,0.83483,0.47532,108.84044,0.52206,2283.24621,277.05947,10.86435
+"2027","YBR228W",21,106,6,23.14465,0.68443,0.14012,1.07335,3.07319,2270.22334,428.36694,0.91714,0.38362,145.06448,0.6423,2950.8299,389.57008,11.57093
+"2028","YBR228W",33,106,6,20.30578,0.68567,0.13541,1.02695,3.15236,2066.51987,349.1113,0.81558,0.53188,117.63244,0.5759,2303.37887,251.81121,11.01851
+"2029","YBR228W",45,106,6,17.6736,0.68049,0.12833,0.98399,2.42785,1941.06712,345.34516,0.77872,0.43482,85.08428,0.56763,2243.90387,201.8212,11.17806
+"2030","YBR228W",57,106,6,19.03898,0.72444,0.13198,0.97131,3.51358,2008.86503,307.75525,0.80728,0.48269,100.64176,0.553,1953.79729,231.24829,10.85885
+"2031","YBR228W",69,106,6,12.28161,0.66095,0.12325,0.92586,5.18006,1632.7018,253.59058,0.63927,0.35942,82.98993,0.51268,1745.27981,139.73623,10.42913
+"2032","YBR228W",81,106,6,13.07825,0.68364,0.12966,0.92907,2.04709,1700.23364,290.90552,0.67117,0.44616,91.09682,0.52503,1971.6606,149.7089,10.90485
+"2033","YBR228W",93,106,6,10.62915,0.67144,0.12555,0.81641,1.27787,1585.04428,264.38224,0.61314,0.3878,89.5415,0.46846,1735.0561,95.42225,10.16347
+"2034","YBR229C",10,106,6,22.39167,0.68553,0.10659,0.9026,3.15708,1808.83721,288.14924,0.85916,0.3475,50.21818,0.30303,2054.47333,310.40988,11.13025
+"2035","YBR229C",22,106,6,30.34762,0.69365,0.11247,1.03606,3.16157,2015.29174,309.50812,0.93866,0.32154,48.52301,0.34049,2205.12028,280.62326,13.47588
+"2036","YBR229C",34,106,6,23.82202,0.69065,0.11379,1.02468,3.09051,1991.11917,297.24621,0.9085,0.34616,70.39208,0.31654,2036.42521,369.77619,10.89094
+"2037","YBR229C",46,106,6,16.97628,0.69981,0.10268,0.95465,2.09312,1692.90913,231.18423,0.78297,0.3462,37.23486,0.27815,1681.62856,230.77975,10.50149
+"2038","YBR229C",58,106,6,17.79709,0.67001,0.10603,0.90763,2.32928,1494.17116,208.96329,0.72337,0.36227,37.43686,0.29702,1447.04303,181.66749,10.33776
+"2039","YBR229C",70,106,6,16.51085,0.68259,0.10211,0.92348,1.91445,1592.58349,213.66585,0.75826,0.45388,38.41376,0.28822,1519.84356,152.61944,10.09546
+"2040","YBR229C",82,106,6,17.63594,0.7179,0.11216,0.94626,2.67599,1701.85984,245.723,0.78231,0.40932,34.43267,0.28239,1669.89499,155.92402,10.96886
+"2041","YBR229C",94,106,6,14.34838,0.67712,0.10332,0.80924,2.50139,1547.29451,218.73114,0.70242,0.32626,39.38056,0.24401,1519.89718,97.52323,10.37543
+"2042","YBR230C",2,107,6,23.09337,0.79389,0.14758,0.98898,3.24717,2510.79902,460.83844,1.0788,0.2976,119.32223,0.61056,3101.49109,402.39249,11.98597
+"2043","YBR230C",14,107,6,16.28802,0.79731,0.13652,0.94686,3.22605,2101.85768,382.57876,0.92775,0.3767,80.09376,0.56631,2381.96484,354.06078,11.01546
+"2044","YBR230C",26,107,6,11.75746,0.77196,0.13082,0.92016,1.25094,2002.66296,348.38626,0.84678,0.44056,77.16676,0.47479,2356.43166,226.22073,11.14474
+"2045","YBR230C",38,107,6,17.00608,0.7871,0.13426,0.89077,2.55282,1821.17307,331.01941,0.80971,0.31597,80.09723,0.59937,2259.86214,263.4427,13.20959
+"2046","YBR230C",50,107,6,9.4605,0.78924,0.12686,0.78429,1.45116,1790.02646,303.23473,0.7866,0.31581,53.0962,0.44111,1852.33515,160.20635,10.08814
+"2047","YBR230C",62,107,6,5.42377,0.79102,0.12838,0.8377,1.35951,1522.75267,262.20111,0.69365,0.35234,66.22566,0.51155,1676.96966,169.79678,10.169
+"2048","YBR230C",74,107,6,10.09478,0.8151,0.13192,0.9534,1.92913,1790.58002,279.86543,0.8061,0.34366,53.59509,0.47402,1837.32452,149.97135,10.72029
+"2049","YBR230C",86,107,6,9.06524,0.8301,0.13317,0.86821,1.56651,1671.61558,281.06284,0.74807,0.37834,60.74786,0.46821,1921.15578,129.6626,10.81532
+"2050","YBR231C",3,107,6,25.29295,0.77922,0.12986,0.91333,3.05522,2504.27268,538.76981,0.77461,0.35828,185.81299,0.50073,3338.74402,391.83137,12.52432
+"2051","YBR231C",15,107,6,18.7996,0.76123,0.13114,0.9041,2.7274,2262.31891,410.61149,0.68957,0.29241,157.06518,0.44216,2726.41875,317.46525,11.97525
+"2052","YBR231C",27,107,6,17.35506,0.77774,0.1313,0.87238,3.2307,2315.89246,465.61542,0.70517,0.32634,140.04283,0.44771,2863.42402,284.87144,11.57535
+"2053","YBR231C",39,107,6,20.29154,0.77863,0.13208,0.91987,3.25807,2276.74842,460.94355,0.69778,0.35461,138.17293,0.50906,2834.64272,271.7954,12.81076
+"2054","YBR231C",51,107,6,14.29254,0.80617,0.1233,0.77806,1.99729,1939.2501,357.72964,0.5873,0.3402,98.18412,0.43126,2123.40988,189.67825,11.64575
+"2055","YBR231C",63,107,6,12.304,0.8264,0.13169,0.86368,1.58326,2003.97456,379.31174,0.60576,0.41538,108.80266,0.45079,2439.66116,155.37962,11.85751
+"2056","YBR231C",75,107,6,14.17018,0.78238,0.11979,0.78015,2.48321,2020.9482,321.19747,0.59562,0.58184,93.93098,0.39546,2142.60883,142.79492,11.44159
+"2057","YBR231C",87,107,6,11.91997,0.85406,0.13299,0.7673,1.22594,1977.75387,355.61444,0.60644,0.3473,92.34625,0.71146,2176.16469,110.71278,12.45608
+"2058","YBR233W",4,107,6,21.19022,0.73952,0.13555,1.06867,3.3035,2555.16764,435.33195,0.95968,0.30985,94.44143,0.53379,2880.13139,361.39004,12.06623
+"2059","YBR233W",16,107,6,14.68978,0.74797,0.12948,0.97215,2.47634,2211.86689,353.86252,0.8519,0.33309,75.0126,0.4849,2392.75264,305.89167,11.3271
+"2060","YBR233W",28,107,6,12.97687,0.73987,0.13512,0.96766,2.12043,2193.56848,342.28615,0.82914,0.33153,90.17788,0.49813,2437.32708,285.15455,11.0609
+"2061","YBR233W",40,107,6,12.84627,0.72325,0.12627,0.91485,2.48964,2074.54046,327.57176,0.76564,0.37071,69.72516,0.46038,2158.55495,255.05598,10.92034
+"2062","YBR233W",52,107,6,8.67464,0.72203,0.11916,0.8123,2.71124,1713.07304,264.90004,0.66717,0.41572,61.45449,0.42785,1812.04808,167.60829,10.70089
+"2063","YBR233W",64,107,6,6.92875,0.75968,0.11948,0.89299,1.39605,1786.06156,262.58613,0.68007,0.31953,48.02536,0.41913,1748.12925,134.02092,10.73706
+"2064","YBR233W",76,107,6,5.6044,0.7496,0.11987,0.84476,1.87328,1867.5088,248.06989,0.69471,0.45556,42.24847,0.38978,1744.4538,128.53153,10.27189
+"2065","YBR233W",88,107,6,4.6046,0.74102,0.12003,0.83467,1.59201,1761.53328,234.78991,0.64947,0.43457,35.87618,0.37721,1590.21369,81.99073,10.91578
+"2066","YBR235W",5,107,6,27.87056,0.71527,0.12855,0.97337,3.53904,3142.11638,378.42774,0.9273,0.29226,116.10303,0.59852,3045.55934,315.72122,12.25056
+"2067","YBR235W",17,107,6,24.05348,0.68775,0.12896,0.95808,8.29015,3203.0468,382.39136,0.9793,0.28883,105.72511,0.50164,3066.67815,329.67549,11.58547
+"2068","YBR235W",29,107,6,13.34329,0.68062,0.1154,0.80502,1.33949,2643.70401,300.75591,0.78568,0.27442,94.45531,0.42262,2415.40962,249.66274,9.98129
+"2069","YBR235W",41,107,6,15.67675,0.69386,0.12659,0.87236,9.04082,2790.3536,327.66811,0.82343,0.32513,97.2843,0.49982,2521.561,261.61327,10.51208
+"2070","YBR235W",53,107,6,11.93912,0.714,0.11691,0.86524,1.5091,2442.93138,288.16843,0.7174,0.33789,87.29645,0.43675,2112.11451,199.48245,10.71627
+"2071","YBR235W",65,107,6,4.60766,0.70142,0.11083,0.70282,0.34111,2272.82668,250.4784,0.62498,0.29379,63.04751,0.34195,1937.71978,60.14905,9.61569
+"2072","YBR235W",77,107,6,9.73878,0.72577,0.12531,0.83724,1.78371,2432.33495,265.73802,0.74044,0.33524,63.14175,0.41001,2181.08643,122.83462,10.43681
+"2073","YBR235W",89,107,6,8.93049,0.7533,0.12466,0.79276,2.13582,2380.20508,240.19235,0.70841,0.42191,61.88637,0.37747,1933.19113,125.37382,10.42921
+"2074","YBR238C",7,107,6,18.94424,0.66574,0.12915,1.07478,7.94952,2366.18239,398.22128,0.93396,0.58086,139.98633,0.48172,2889.04686,423.35373,12.88461
+"2075","YBR238C",19,107,6,12.54453,0.65242,0.11714,0.86233,2.5862,1803.02428,294.24759,0.73785,0.35225,70.88979,0.39912,1870.50211,302.62305,10.84638
+"2076","YBR238C",31,107,6,14.61874,0.65239,0.11823,1.00298,3.89694,2008.80938,313.38565,0.78503,0.41924,81.16198,0.42663,1955.9975,281.20971,11.93572
+"2077","YBR238C",43,107,6,12.66379,0.64075,0.11621,0.92208,3.57858,1805.96074,278.93966,0.72284,0.3803,70.09705,0.34713,1930.27556,226.77854,11.4516
+"2078","YBR238C",55,107,6,6.74893,0.65681,0.10922,0.89868,2.3888,1853.63248,270.87114,0.72584,0.3713,71.39268,0.34235,1779.41526,213.45131,10.81859
+"2079","YBR238C",67,107,6,13.549,0.64406,0.11733,1.28487,4.51979,1764.34957,251.45322,0.71455,0.79085,74.91603,0.35325,1807.39033,160.12854,11.7569
+"2080","YBR238C",79,107,6,11.07438,0.67484,0.12235,1.02241,3.19596,2014.22825,290.38438,0.75682,0.4854,73.90334,0.38385,1969.71297,180.6296,12.43599
+"2081","YBR238C",91,107,6,8.85417,0.65435,0.10981,0.8427,2.12826,1806.6088,245.37125,0.67755,0.50957,52.44342,0.31724,1722.57334,104.69302,12.78371
+"2082","YBR239C",8,107,6,20.71728,0.7796,0.14255,0.99637,3.98308,2117.55995,397.5737,0.83385,0.38466,100.79775,0.59385,2697.26209,298.2103,12.32863
+"2083","YBR239C",20,107,6,17.07494,0.79266,0.13733,1.0037,3.41814,2081.492,410.6922,0.82373,0.34034,90.25441,0.53639,2664.68808,310.5344,11.35627
+"2084","YBR239C",32,107,6,12.47199,0.79241,0.13979,1.06204,3.95464,1994.99308,371.76094,0.77455,0.41764,83.73563,0.54478,2552.05254,262.37023,11.25552
+"2085","YBR239C",44,107,6,8.9296,0.74947,0.12847,0.85161,3.28726,1635.62054,291.65149,0.64621,0.60858,84.0835,0.51631,1893.09735,226.79555,10.41112
+"2086","YBR239C",56,107,6,9.82462,0.78615,0.13099,0.92176,3.3298,1675.42822,268.891,0.6435,0.37301,59.70095,0.53472,1786.32262,202.51264,12.08992
+"2087","YBR239C",68,107,6,9.15379,0.7879,0.13145,0.86806,2.28546,1689.52068,269.52416,0.6173,0.37748,68.24144,0.54179,1721.55967,142.25777,11.27993
+"2088","YBR239C",80,107,6,9.82189,0.78809,0.13172,0.91257,2.48412,1819.0872,295.66773,0.67606,0.35767,56.59229,0.52957,1795.29837,132.14059,11.66457
+"2089","YBR239C",92,107,6,9.61353,0.82954,0.13612,0.85139,2.04449,1770.9741,287.49505,0.6615,0.56794,59.24036,0.53532,1848.8835,129.52623,11.29161
+"2090","YBR240C",9,107,6,16.63597,0.74336,0.13214,0.94776,3.99963,2247.73332,368.61769,0.88256,0.39967,92.54462,0.54359,2483.74822,314.60914,11.13186
+"2091","YBR240C",21,107,6,13.58794,0.75369,0.138,1.03901,3.64306,2217.38914,387.02708,0.89897,0.30821,90.47132,0.54472,2452.67272,310.31682,11.15754
+"2092","YBR240C",33,107,6,14.37631,0.74239,0.12815,0.98026,3.46059,2145.93004,374.7803,0.85532,0.3852,88.19404,0.48033,2603.98171,281.49271,11.18603
+"2093","YBR240C",45,107,6,11.06344,0.74469,0.12392,0.86103,2.06663,1840.80548,312.06747,0.75702,0.40689,66.06273,0.42055,1870.79337,214.9108,10.5184
+"2094","YBR240C",57,107,6,9.26939,0.76016,0.12854,0.89,2.98766,1801.71339,288.77972,0.72757,0.45124,59.48915,0.47306,1980.43923,185.61119,10.5584
+"2095","YBR240C",69,107,6,9.32113,0.75964,0.12859,0.88277,2.87999,1870.00243,280.2046,0.74818,0.50085,54.1355,0.43999,1746.08719,143.90897,10.93281
+"2096","YBR240C",81,107,6,7.00919,0.73158,0.12388,0.85345,1.97154,1775.07135,283.9997,0.72801,0.31318,57.98767,0.42811,1830.67917,147.19157,10.39802
+"2097","YBR240C",93,107,6,8.02813,0.74089,0.12331,0.75053,2.22528,1759.38608,263.05369,0.67861,0.39882,52.23885,0.40561,1756.15989,108.72976,10.59231
+"2098","YBR241C",10,107,6,18.5414,0.72373,0.13379,0.89192,3.49082,1993.2331,386.30188,0.86678,0.43556,96.5076,0.51039,2624.0009,362.76971,11.00875
+"2099","YBR241C",22,107,6,17.56528,0.71145,0.1319,1.02759,3.79186,2121.79926,400.11511,0.90335,0.32897,105.21631,0.53907,2775.24251,342.35782,11.16865
+"2100","YBR241C",34,107,6,15.25082,0.78813,0.14332,1.07364,3.56126,2254.52706,408.84234,0.92542,0.46625,86.75016,0.53894,2795.04304,346.48057,12.46597
+"2101","YBR241C",46,107,6,9.25091,0.72147,0.11864,0.83378,2.83463,1648.62623,266.57579,0.68874,0.34557,72.95304,0.46462,1962.94061,228.09249,10.25678
+"2102","YBR241C",58,107,6,9.80509,0.7362,0.12097,0.83032,2.82581,1657.18963,287.63661,0.70715,0.41413,55.2537,0.47898,1929.58917,176.10405,10.27267
+"2103","YBR241C",70,107,6,8.68332,0.70808,0.11807,0.84038,1.70957,1640.18338,274.56902,0.72514,0.44796,50.19456,0.41576,1798.44706,123.26512,10.45386
+"2104","YBR241C",82,107,6,9.23039,0.74535,0.12526,0.84078,3.56628,1851.79998,287.15123,0.75786,0.36202,51.69525,0.44015,1958.7572,164.93882,10.72983
+"2105","YBR241C",94,107,6,10.17273,0.76127,0.13468,0.83074,2.65917,1893.2916,314.63966,0.78152,0.44848,67.13852,0.48464,2120.06733,161.28312,11.48037
+"2106","YBR242W",2,108,6,20.95367,0.7714,0.13675,0.90219,2.35239,2198.11736,359.91184,1.05042,0.33342,74.54212,0.46697,2503.94997,318.07894,11.53685
+"2107","YBR242W",14,108,6,14.17629,0.77174,0.13024,0.83636,1.93033,1961.8097,313.98457,0.95045,0.36502,58.85231,0.43639,2254.0851,270.53983,10.61037
+"2108","YBR242W",26,108,6,16.66974,0.7451,0.13301,0.84846,1.7771,2096.5439,354.5208,0.96054,0.3465,80.77681,0.46156,2628.34524,329.11059,10.67706
+"2109","YBR242W",38,108,6,17.07596,0.76407,0.13359,0.82783,1.67123,1912.84649,317.63167,0.95473,0.31045,64.24219,0.4201,2121.44061,319.07359,10.73781
+"2110","YBR242W",50,108,6,7.68129,0.78539,0.12505,0.69677,1.41097,1530.04385,241.80993,0.76184,0.37756,42.92066,0.48823,1667.85566,150.39015,10.22117
+"2111","YBR242W",62,108,6,8.62804,0.81678,0.12777,0.7582,1.35966,1661.67751,243.97346,0.8185,0.54263,42.53646,0.42302,1595.7023,158.81166,10.71182
+"2112","YBR242W",74,108,6,12.09726,0.83541,0.1415,0.80404,2.25402,1853.74127,282.56367,0.87352,0.40027,54.73452,0.4517,1912.07066,159.76159,11.14758
+"2113","YBR242W",86,108,6,5.16264,0.77918,0.12256,0.70738,1.16688,1555.75693,245.43345,0.71963,0.43459,51.37817,0.37306,1639.77789,84.41328,10.59261
+"2114","YBR244W",3,108,6,19.5974,0.71357,0.13288,0.89121,2.46856,2140.96538,383.90881,0.92408,0.37027,125.80136,0.45672,2624.27771,369.34619,11.43756
+"2115","YBR244W",15,108,6,15.7583,0.71503,0.13065,0.82472,1.53683,1993.6298,335.86789,0.80002,0.31223,119.92154,0.42351,2312.39438,278.71548,11.17865
+"2116","YBR244W",27,108,6,10.28447,0.66116,0.12657,0.76407,2.66942,1925.93966,357.13554,0.79369,0.47853,125.37542,0.39846,2440.68478,274.9529,10.35209
+"2117","YBR244W",39,108,6,10.54029,0.71543,0.13035,0.82251,2.24011,1823.18734,360.14655,0.75219,0.48935,110.22467,0.43828,2365.85676,257.2777,10.77673
+"2118","YBR244W",51,108,6,9.48912,0.72491,0.1205,0.75235,1.72558,1749.32748,276.7942,0.73917,0.41088,81.11281,0.40654,1816.94381,195.43472,11.02264
+"2119","YBR244W",63,108,6,6.34152,0.71445,0.12655,0.76346,1.08332,1601.22726,284.11002,0.66451,0.34368,84.68964,0.44081,1852.08199,141.17909,10.65201
+"2120","YBR244W",75,108,6,8.53296,0.71015,0.11914,0.77424,1.18536,1580.41165,256.87933,0.67644,0.33191,72.16858,0.41375,1742.52854,127.02076,10.34489
+"2121","YBR244W",87,108,6,5.639,0.70555,0.11952,0.6622,2.47139,1491.40757,272.47232,0.59079,0.47658,92.55401,0.36905,1730.75754,129.5379,10.42034
+"2122","YBR245C",4,108,6,24.17577,0.68929,0.12416,0.9833,2.17167,2283.83828,347.63189,0.80969,0.4041,114.47121,0.41338,2529.06309,323.33669,13.67561
+"2123","YBR245C",16,108,6,12.50626,0.66528,0.1217,0.80782,2.0588,1972.55382,305.59739,0.72524,0.42573,99.35759,0.36209,2136.12114,256.90943,10.93075
+"2124","YBR245C",28,108,6,10.00895,0.65749,0.11752,0.73815,2.73516,1841.81599,290.85174,0.67304,0.54024,94.64608,0.34106,1998.48927,252.13068,10.70647
+"2125","YBR245C",40,108,6,9.29953,0.65848,0.12057,0.74067,2.55006,1905.91176,275.92347,0.66082,0.51781,97.88297,0.36199,1955.08908,254.84161,10.62289
+"2126","YBR245C",52,108,6,14.57649,0.71062,0.11744,0.75357,1.36819,1852.0745,274.83513,0.65322,0.40098,120.69399,0.41141,1795.75689,472.56001,10.80748
+"2127","YBR245C",64,108,6,4.16815,0.67999,0.13596,0.71199,1.23576,1585.71689,216.90738,0.55738,0.36061,64.52013,0.34236,1457.18494,106.26725,10.48383
+"2128","YBR245C",76,108,6,5.63451,0.67657,0.11564,0.71097,1.48048,1685.24782,249.10108,0.58812,0.50842,65.94698,0.33865,1736.98984,127.18295,10.508
+"2129","YBR245C",88,108,6,4.6039,0.70146,0.12127,0.69781,1.16944,1687.78347,223.62682,0.59386,0.42867,63.72044,0.33187,1489.3668,94.84264,11.0977
+"2130","YBR246W",5,108,6,16.14662,0.66596,0.12169,0.84619,2.89347,2095.42992,344.92781,0.80721,0.44059,145.96459,0.37044,2382.34369,333.23767,11.29084
+"2131","YBR246W",17,108,6,11.84758,0.67429,0.12036,0.8109,2.46927,2093.91743,321.71208,0.78729,0.56026,128.1345,0.36445,2290.78083,279.69832,11.19284
+"2132","YBR246W",29,108,6,11.01401,0.69066,0.11989,0.73538,1.60371,2000.10212,297.51439,0.75283,0.42001,121.38536,0.33334,1992.96473,283.50921,11.34455
+"2133","YBR246W",41,108,6,7.84924,0.67584,0.11587,0.70039,2.30315,1877.91218,294.23845,0.70499,0.41252,109.52855,0.30546,2138.02644,239.34241,11.11564
+"2134","YBR246W",53,108,6,5.51546,0.70267,0.11643,0.69509,1.85874,1709.40875,248.38028,0.67022,0.6454,81.45318,0.33089,1650.8327,162.42554,10.83573
+"2135","YBR246W",65,108,6,6.43362,0.68126,0.1142,0.72034,2.09304,1813.17858,276.12805,0.69365,0.49767,102.64886,0.31142,1920.70139,182.18509,10.62852
+"2136","YBR246W",77,108,6,3.29544,0.70512,0.11425,0.64583,3.21562,1673.62676,241.06635,0.61408,0.56219,90.07228,0.29835,1626.40789,136.87183,10.43061
+"2137","YBR248C",7,108,6,18.02657,0.96774,0.17041,1.04024,3.83833,2164.48338,519.97106,0.68332,0.25186,176.46041,0.87027,2582.67087,332.9482,14.49573
+"2138","YBR248C",19,108,6,13.57299,0.91206,0.1459,0.81875,2.81725,1799.46246,431.37564,0.56369,0.21693,149.27011,0.73955,2140.34649,321.68161,12.90598
+"2139","YBR248C",31,108,6,11.29851,0.88852,0.15129,0.8167,2.96958,1812.89024,414.99645,0.55551,0.27748,130.06671,0.73166,2178.39869,269.119,12.31212
+"2140","YBR248C",43,108,6,11.45536,0.87465,0.14882,0.81996,3.03315,1733.96672,423.01182,0.56592,0.31778,132.14748,0.76447,2090.17263,267.15079,11.85306
+"2141","YBR248C",55,108,6,6.42458,0.89293,0.14398,0.72778,2.72266,1611.74358,365.51706,0.50679,0.32192,113.67447,0.67289,1842.98273,220.33673,11.41722
+"2142","YBR248C",67,108,6,4.95197,0.89243,0.1418,0.71367,3.04281,1612.20307,336.98017,0.4774,0.31519,97.32837,0.65218,1734.58784,133.93582,11.262
+"2143","YBR248C",79,108,6,6.68542,0.89801,0.1451,0.79831,2.86091,1684.2908,408.14783,0.50968,0.27585,121.80795,0.70063,1976.72952,169.89955,11.9726
+"2144","YBR248C",91,108,6,3.12585,0.89709,0.14777,0.72776,2.88031,1534.97301,317.62406,0.45149,0.34191,95.24235,1.95466,1610.84593,108.00288,11.69059
+"2145","YBR249C",8,108,6,13.72408,0.72971,0.12675,0.77325,1.66026,1825.42618,328.42587,0.75374,0.4126,105.79182,0.46993,2171.35832,274.77227,11.38938
+"2146","YBR249C",20,108,6,15.00592,0.68034,0.12467,0.7261,2.30564,1709.78305,325.3677,0.70496,0.37941,120.34417,0.46693,2268.80506,289.96717,11.33027
+"2147","YBR249C",32,108,6,16.98814,0.70288,0.1279,0.793,2.09095,1813.9372,363.50041,0.78699,0.40575,117.77206,0.45542,2248.66423,268.75991,11.30253
+"2148","YBR249C",44,108,6,10.97875,0.70301,0.12157,0.68386,2.22184,1440.48021,291.38881,0.6252,0.40475,98.20581,0.44234,1837.42299,199.27676,10.25598
+"2149","YBR249C",56,108,6,8.40963,0.69443,0.11739,0.6605,2.07843,1375.89738,263.59356,0.57297,0.60129,82.73944,0.40357,1687.29689,174.49171,10.00403
+"2150","YBR249C",68,108,6,12.08085,0.74511,0.12362,0.74089,1.75323,1505.48238,272.11467,0.62386,0.5797,92.19524,0.45979,1626.42996,246.28971,10.46481
+"2151","YBR249C",80,108,6,5.78214,0.7139,0.12282,0.68505,1.71427,1462.07621,271.06346,0.60816,0.46769,77.95544,0.43549,1725.48122,133.85453,10.31587
+"2152","YBR249C",92,108,6,3.57437,0.72658,0.12573,0.65912,1.69806,1434.82615,261.09991,0.56882,0.48484,88.28995,0.42937,1801.78412,80.75006,10.29445
+"2153","YBR250W",9,108,6,16.28501,0.71803,0.12767,0.81073,2.36916,2078.51528,346.72838,0.88107,0.50214,96.12989,0.45586,2363.49955,311.90254,11.38739
+"2154","YBR250W",21,108,6,15.06361,0.7072,0.13036,0.83713,2.24735,2108.46261,336.21775,0.84939,0.37578,96.93796,0.45453,2361.0011,285.9432,11.08124
+"2155","YBR250W",33,108,6,16.2933,0.7,0.13499,0.77889,2.9061,2036.39113,376.06818,0.80584,0.42742,106.49292,0.49356,2384.56169,348.07552,11.43049
+"2156","YBR250W",45,108,6,6.78611,0.70376,0.11925,0.67309,1.88149,1603.00472,255.1353,0.65745,0.44638,64.54047,0.38796,1743.5321,197.58749,10.18411
+"2157","YBR250W",57,108,6,7.18749,0.77484,0.12704,0.70901,2.19186,1649.64893,279.50603,0.67723,0.5015,69.75115,0.44852,1703.43525,187.37463,10.70705
+"2158","YBR250W",69,108,6,8.91054,0.73809,0.12868,0.74081,2.0589,1766.38443,304.94219,0.71027,0.44005,87.20056,0.48573,2014.31967,175.10764,10.94416
+"2159","YBR250W",81,108,6,7.10353,0.74411,0.12799,0.71637,1.29302,1615.56084,275.34391,0.63891,0.60457,89.70591,0.48555,1837.02898,143.24149,10.9333
+"2160","YBR250W",93,108,6,3.91542,0.76261,0.12716,0.69256,1.1423,1657.88281,252.94569,0.65396,0.43192,68.79777,0.40439,1676.49698,83.89951,10.45236
+"2161","YBR251W",10,108,6,19.78656,0.78895,0.15701,0.80578,3.3755,842.15513,422.44537,0.4691,0.31558,96.96131,0.54517,2689.79199,373.96853,12.05036
+"2162","YBR251W",22,108,6,17.12883,0.8001,0.15148,0.78996,3.73122,809.13767,432.03524,0.47895,0.36407,99.79196,0.66019,2669.51253,378.934,11.93401
+"2163","YBR251W",34,108,6,12.38346,0.81588,0.14938,0.73357,2.15008,726.77974,346.31659,0.41178,0.2826,71.33487,0.60712,2137.9444,317.28965,11.99309
+"2164","YBR251W",46,108,6,7.74009,0.79888,0.13932,0.67201,2.01283,602.58099,302.18286,0.34411,0.26254,58.93521,0.50664,1899.82875,239.68602,10.55174
+"2165","YBR251W",58,108,6,7.278,0.83795,0.14075,0.66956,2.63163,642.89827,319.6006,0.34288,0.32618,48.29916,0.5739,1693.97968,193.6956,10.84576
+"2166","YBR251W",70,108,6,8.33339,0.79236,0.13686,0.68784,1.66083,621.32804,287.4845,0.34688,0.30315,54.64238,0.53206,1803.73739,158.76929,10.50807
+"2167","YBR251W",82,108,6,9.06447,0.78937,0.13614,0.7846,1.54389,642.322,304.11238,0.3199,0.33724,52.32877,0.57543,1853.79175,176.90532,10.84453
+"2168","YBR251W",94,108,6,11.36706,0.81252,0.14648,0.62443,6.78776,603.25098,316.91904,0.33879,0.49621,51.24601,0.56662,1837.31679,142.09197,11.76633
+"2169","YBR255W",2,109,7,40.56341,0.93345,0.17602,1.44405,3.35227,2722.86311,548.56503,1.09432,0.38542,116.21698,0.99412,3422.25254,483.59051,16.16404
+"2170","YBR255W",14,109,7,33.29468,0.91508,0.17109,1.36845,2.2576,2375.11738,451.27158,0.98652,0.44513,114.07867,0.94566,2942.53994,414.2163,15.04818
+"2171","YBR255W",26,109,7,34.6901,0.91903,0.17694,1.40714,3.11831,2499.6807,464.29617,1.02646,0.33755,100.06348,0.97174,3082.37541,484.76507,15.1898
+"2172","YBR255W",38,109,7,32.48701,0.92884,0.1735,1.34155,4.65857,2447.64823,438.30096,1.03658,1.2592,83.44562,0.9245,2665.91031,364.6988,14.88816
+"2173","YBR255W",50,109,7,39.89843,1.00425,0.19346,1.4739,3.90279,2783.53731,526.80776,1.13831,0.40872,114.55118,1.05369,3396.00608,525.32317,16.67792
+"2174","YBR255W",62,109,7,36.6946,0.90254,0.17099,1.38532,2.51094,2370.4694,493.26803,1.01954,0.35035,109.11488,0.93452,3145.66731,428.24203,15.56661
+"2175","YBR255W",74,109,7,41.25002,0.96692,0.1919,1.54883,3.10146,2822.55405,616.27608,1.13228,0.37038,152.2993,1.06658,4004.72922,576.62053,17.3591
+"2176","YBR255W",86,109,7,41.95923,0.98017,0.1906,1.43851,3.97338,2931.42253,604.06027,1.14832,0.39099,130.41044,1.0499,3861.06484,591.42908,17.22841
+"2177","YBR258C",3,109,7,38.30057,0.9328,0.17321,1.4381,3.11384,2952.03078,515.86085,1.2409,0.42357,169.81798,0.81593,3487.18273,562.11724,17.0508
+"2178","YBR258C",15,109,7,31.31384,0.84276,0.16625,1.31905,3.59152,2436.28133,428.52495,1.09858,0.39793,139.90809,1.29069,2884.66421,368.80075,15.71183
+"2179","YBR258C",27,109,7,33.07024,0.85723,0.17067,1.44043,4.10036,2624.87486,459.06275,1.15907,0.52681,137.28917,0.80185,3076.08292,469.39468,16.35252
+"2180","YBR258C",39,109,7,28.91013,0.85789,0.16477,1.31631,2.89153,2441.21096,398.38326,1.09173,0.50819,120.15228,0.75665,2617.98855,359.78332,15.56888
+"2181","YBR258C",51,109,7,27.99478,0.83969,0.16251,1.20973,2.58538,2176.6246,355.3463,0.98443,0.45055,118.20691,0.81581,2281.75619,335.65019,14.42669
+"2182","YBR258C",63,109,7,29.32276,0.86695,0.16762,1.56994,3.92428,2523.01617,402.10592,1.09343,0.45026,116.77597,0.79062,2676.89089,372.80463,15.62211
+"2183","YBR258C",75,109,7,36.54218,0.85172,0.16581,1.28094,4.00357,2594.8723,448.84971,1.10872,0.56634,143.18646,0.76512,2933.94447,422.82474,16.96342
+"2184","YBR258C",87,109,7,33.89937,0.89733,0.17212,1.26529,7.55661,2619.02883,434.95952,1.10956,0.48153,126.80623,5.3322,2934.47092,463.85756,16.82313
+"2185","YBR259W",4,109,7,34.74066,0.86002,0.16657,1.36979,3.90021,2678.67376,498.64656,1.137,0.51424,167.69959,0.7759,3232.5681,489.60725,16.79559
+"2186","YBR259W",16,109,7,33.96505,0.90124,0.17747,1.46599,4.07634,2739.25737,481.04248,1.15319,0.53269,170.67346,0.83581,3296.19569,476.99322,16.60858
+"2187","YBR259W",28,109,7,52.28735,0.87367,0.17113,1.47536,4.44108,2575.95303,457.00073,1.12196,0.55801,153.52047,0.87798,3129.29779,455.28201,17.66513
+"2188","YBR259W",40,109,7,35.41261,0.90086,0.17553,1.47996,5.21801,2660.36068,477.02573,1.10803,0.67919,169.05878,0.87853,3265.5983,498.46856,17.08391
+"2189","YBR259W",52,109,7,35.22987,0.90868,0.17531,1.41884,3.74533,2643.83491,516.76405,1.12648,0.86032,167.72947,0.86046,3438.41713,507.7804,17.12013
+"2190","YBR259W",64,109,7,36.38213,0.93106,0.17978,1.4536,4.22111,2783.49637,508.01668,1.16795,0.56087,164.68441,0.88678,3358.24287,504.71878,16.93716
+"2191","YBR259W",76,109,7,39.05992,0.90687,0.17496,1.84721,6.0916,2647.07655,482.72365,1.09541,0.47902,171.08831,0.89979,3117.78397,473.89744,18.50214
+"2192","YBR259W",88,109,7,33.43372,0.90176,0.17003,1.28076,8.20336,2647.12531,465.51787,1.08095,0.46926,148.60158,0.84125,3033.59421,435.95473,16.31277
+"2193","YBR260C",5,109,7,39.89298,0.86075,0.16849,1.46506,3.31075,2621.38919,515.72536,1.13348,0.44038,194.24146,0.89293,3446.75871,471.06863,17.7443
+"2194","YBR260C",17,109,7,51.56097,0.86513,0.17605,1.47838,4.22891,2741.66732,569.3992,1.15818,0.51483,213.77877,0.86644,3773.97558,562.14016,18.91561
+"2195","YBR260C",29,109,7,38.87152,0.85725,0.17644,1.46369,4.02758,2506.67606,456.71653,1.09882,0.6716,179.41222,0.89258,3211.21378,505.90034,17.53226
+"2196","YBR260C",41,109,7,37.48821,0.81965,0.16618,1.42009,2.21163,2313.06036,434.05865,1.01628,0.37497,155.59356,0.79393,2939.88011,403.04197,17.69321
+"2197","YBR260C",53,109,7,31.48867,0.8214,0.16175,1.34034,3.0582,2097.89034,363.46109,0.9406,0.44935,141.23909,1.51074,2473.56211,311.43734,15.89611
+"2198","YBR260C",65,109,7,37.47227,0.82371,0.16163,1.25716,2.88738,2350.39385,442.92374,1.00421,0.3746,155.00241,0.8081,2942.60755,423.20055,16.54381
+"2199","YBR260C",77,109,7,33.46168,0.80771,0.16086,1.25976,2.24952,2297.9776,414.95916,0.99263,0.45098,152.41664,0.79688,2735.22377,331.18806,15.27985
+"2200","YBR260C",89,109,7,34.52683,0.86476,0.17245,1.31056,2.85673,2401.56981,448.51747,1.00565,0.50532,150.63242,0.85045,2815.82552,423.08955,16.78494
+"2201","YBR261C",7,109,7,40.65005,0.864,0.16359,1.42032,2.54898,2514.54752,438.24185,1.08097,0.44637,125.45581,0.7218,2903.27291,425.48607,19.14213
+"2202","YBR261C",19,109,7,70.2428,0.89003,0.1698,1.62802,3.74902,2562.3433,456.05296,1.09062,0.6453,148.13736,0.79499,3097.61106,491.58605,18.55302
+"2203","YBR261C",31,109,7,32.35215,0.87043,0.16293,1.44988,4.04044,2453.46176,397.35111,1.05728,0.47899,113.95794,0.74731,2776.91546,431.9134,16.75776
+"2204","YBR261C",43,109,7,36.82711,0.87666,0.16969,1.38512,4.78596,2410.58639,397.32812,1.07439,0.53251,91.84177,0.84782,2598.63207,368.33565,15.962
+"2205","YBR261C",55,109,7,33.28917,0.90174,0.18439,1.49011,4.54152,2404.76239,426.48738,1.06028,0.5103,114.22974,0.8244,2769.27327,429.41178,17.04762
+"2206","YBR261C",67,109,7,35.00958,0.83506,0.16089,1.39243,2.82572,2219.02636,394.36409,0.99941,0.56541,111.71518,0.74503,2665.33282,422.18275,16.54766
+"2207","YBR261C",79,109,7,34.51076,0.91139,0.17643,1.45585,3.73313,2606.42602,436.69525,1.1375,0.50919,111.62522,0.84267,2785.11751,403.72076,17.16938
+"2208","YBR261C",91,109,7,32.2768,0.87028,0.16192,1.25613,0.37963,2364.20478,401.07187,1.03308,0.43272,98.77042,0.66448,2633.19703,245.62135,17.99105
+"2209","YBR262C",8,109,7,41.36736,0.86066,0.16495,1.46221,3.69003,2714.02044,511.42479,1.11524,0.39171,172.14648,0.75962,3502.00618,532.78854,17.96891
+"2210","YBR262C",20,109,7,29.17247,0.80436,0.16177,1.35601,3.72414,2470.3131,420.94042,1.02711,0.42866,142.99694,0.73941,2821.73355,431.5151,15.30804
+"2211","YBR262C",32,109,7,32.60562,0.82518,0.15792,1.52222,3.90844,2601.64591,420.84161,1.06541,0.39034,142.75066,0.74016,2916.99081,458.78943,15.65474
+"2212","YBR262C",44,109,7,29.96145,0.85305,0.1581,1.34598,3.3186,2445.87738,387.18114,1.02114,0.48632,117.00676,0.77197,2545.98372,371.32334,16.5186
+"2213","YBR262C",56,109,7,37.34551,0.83165,0.1625,1.37451,3.1319,2322.89493,370.32149,1.0037,0.4446,136.61968,0.77957,2476.70516,368.23243,15.63701
+"2214","YBR262C",68,109,7,31.81238,0.85085,0.16482,1.37983,3.72588,2632.25813,443.41432,1.0866,0.53859,132.90186,0.77297,3009.83028,474.60092,15.75859
+"2215","YBR262C",80,109,7,31.89219,0.82221,0.16501,1.35624,3.34308,2516.37943,433.95972,1.04657,0.44043,128.20703,0.77357,2896.48852,382.50082,15.43473
+"2216","YBR262C",92,109,7,39.68897,0.96404,0.1829,1.50969,4.79472,3171.10583,631.80103,1.23013,0.44866,179.80056,1.14424,4152.38023,645.21702,18.53116
+"2217","YBR263W",9,109,7,42.481,0.8851,0.17062,1.74721,3.26351,2715.40039,545.2359,1.09111,0.39948,171.9656,0.80022,3485.71207,549.23344,19.81495
+"2218","YBR263W",21,109,7,32.93987,0.84194,0.16314,1.49861,3.03324,2538.30377,466.67105,1.04737,0.39743,139.67219,0.79463,3079.37066,479.52061,16.08459
+"2219","YBR263W",33,109,7,36.6073,0.87892,0.1769,1.52928,3.42465,2742.25047,563.21538,1.10706,0.4291,191.70397,0.91447,3778.33563,585.7168,17.32678
+"2220","YBR263W",45,109,7,41.03141,0.8646,0.16781,1.45608,2.99133,2363.17589,414.81691,0.9994,0.38577,124.30436,0.84469,2654.51863,414.23999,16.65177
+"2221","YBR263W",57,109,7,25.85883,0.81433,0.15732,1.29911,2.38218,2232.94409,379.74301,0.94945,0.38763,110.75171,0.78499,2434.98289,302.02933,14.80653
+"2222","YBR263W",69,109,7,28.6214,0.84263,0.16448,1.33866,2.92199,2381.71197,412.92946,0.98867,0.39155,116.37668,0.78424,2688.21702,386.62013,14.97534
+"2223","YBR263W",81,109,7,30.48315,0.83832,0.1685,1.39291,3.20457,2451.46536,420.50606,1.01339,0.39928,132.62931,0.82721,2788.50734,413.98609,16.22417
+"2224","YBR263W",93,109,7,33.35653,0.88465,0.17847,1.42148,4.35477,2600.63528,499.02852,1.10672,0.4999,141.05275,0.87957,3280.8948,518.75479,18.16137
+"2225","YBR264C",10,109,7,42.41153,0.8367,0.15698,1.34376,2.08975,2483.36235,480.97624,1.10299,0.3419,186.36568,0.7562,3111.1394,437.61948,20.71787
+"2226","YBR264C",22,109,7,38.4857,0.89657,0.17228,1.51133,3.81105,2995.30071,574.63835,1.26894,0.53603,199.21611,0.81512,3969.38942,583.59799,18.91569
+"2227","YBR264C",34,109,7,46.42325,0.87231,0.1694,1.50705,4.07797,2738.76653,527.3956,1.2087,0.39334,199.80714,0.84883,3593.35376,523.49337,17.11555
+"2228","YBR264C",46,109,7,36.95287,0.84537,0.16224,1.30987,3.06241,2428.46152,428.24739,1.07464,0.43757,135.84379,0.76691,2823.95523,393.22614,16.02551
+"2229","YBR264C",58,109,7,30.58122,0.85349,0.16478,1.30647,6.32191,2615.64697,485.76614,1.11951,0.52871,181.48702,0.78698,3231.14056,470.69089,15.62862
+"2230","YBR264C",70,109,7,34.92405,0.84544,0.16237,1.33646,2.64126,2474.45717,413.96519,1.07681,0.40621,140.14588,0.76797,2938.49879,388.80434,19.15032
+"2231","YBR264C",82,109,7,37.16531,0.93149,0.1798,1.44635,3.3172,2944.55629,585.80142,1.21374,0.412,206.65136,0.90241,3797.0539,560.53401,18.16477
+"2232","YBR264C",94,109,7,40.55062,0.93278,0.17909,1.39199,3.59681,2865.35878,547.13915,1.19532,0.39816,189.84699,0.89313,3496.68861,556.09988,19.65876
+"2233","YBR266C",2,110,7,44.85614,0.7681,0.1599,1.42141,5.89861,1832.37985,442.29592,0.74807,0.69958,129.69527,0.69245,2937.03672,494.12143,17.61913
+"2234","YBR266C",14,110,7,38.24887,0.72196,0.15547,1.46164,4.09679,1637.44752,385.08227,0.67408,0.66341,106.22381,0.644,2549.65877,451.76442,16.41358
+"2235","YBR266C",26,110,7,40.29246,0.74392,0.15771,1.57419,4.83264,1678.9724,398.91854,0.73977,0.69007,113.53553,0.65231,2690.95249,481.58074,17.88223
+"2236","YBR266C",38,110,7,48.59513,0.70164,0.15443,1.40975,4.80645,1570.86387,339.32994,0.66804,0.75891,95.28966,0.61347,2263.35625,357.08979,21.45693
+"2237","YBR266C",50,110,7,40.27601,0.67987,0.14634,1.33713,3.99783,1512.90284,312.05678,0.63439,0.64816,91.67285,0.57878,2181.3006,331.28767,16.8496
+"2238","YBR266C",62,110,7,37.55469,0.7054,0.14952,1.41968,6.1682,1578.15259,367.28839,0.66108,0.87228,100.62751,0.6099,2425.07053,380.39056,16.11978
+"2239","YBR266C",74,110,7,55.22792,0.7755,0.16583,1.62332,5.0896,1939.47178,427.19855,0.78191,0.723,124.45525,0.71825,2916.94503,484.39087,21.23805
+"2240","YBR266C",86,110,7,63.1409,0.75873,0.16571,1.57521,5.76742,1857.8502,430.29945,0.80396,0.97142,128.02885,0.74221,2997.89645,499.03249,25.30263
+"2241","YBR267W",3,110,7,55.43834,0.8663,0.18055,1.49496,6.1682,2777.04728,493.4131,1.04579,0.56265,117.65032,0.61706,3296.85605,581.07646,20.23023
+"2242","YBR267W",15,110,7,42.43633,0.78963,0.16208,1.43596,5.43977,2327.43661,407.93944,0.95387,0.78925,89.60659,0.53498,2639.8923,387.97319,17.02606
+"2243","YBR267W",27,110,7,44.7889,0.79972,0.16689,1.4398,5.10061,2452.2128,417.56745,0.9548,0.69675,98.20213,0.56349,2849.19698,476.92695,16.87828
+"2244","YBR267W",39,110,7,45.16577,0.78083,0.16421,1.36487,4.18656,2214.15978,338.38854,0.89934,0.53822,81.54788,0.56221,2346.00049,357.24075,18.52319
+"2245","YBR267W",51,110,7,44.63617,0.76437,0.15786,1.33453,6.64838,2177.45292,328.40106,0.87905,0.59039,88.24406,0.52317,2307.62449,354.30529,18.31848
+"2246","YBR267W",63,110,7,44.20902,0.76285,0.15953,1.3779,5.70818,2322.54057,381.8389,0.89391,1.52646,105.17787,0.59088,2613.77573,414.21211,17.38503
+"2247","YBR267W",75,110,7,49.24612,0.81216,0.17317,1.45428,5.47045,2511.62197,413.43091,0.99083,0.74194,101.99259,0.57911,2899.07246,475.8197,18.99371
+"2248","YBR267W",87,110,7,49.59006,0.75317,0.16263,1.61247,7.91987,2382.1029,366.65204,0.93391,0.89691,101.68375,0.58008,2559.35285,379.12026,19.56986
+"2249","YBR268W",4,110,7,40.62821,0.89567,0.18905,1.28806,4.99616,969.31875,584.55766,0.67406,0.47188,165.40655,0.95747,3526.24956,625.70936,18.11693
+"2250","YBR268W",16,110,7,30.48183,0.85768,0.17779,1.326,7.08816,860.7044,468.16363,0.61732,0.68465,135.99703,0.86768,3018.70913,462.09829,15.76678
+"2251","YBR268W",28,110,7,30.31473,0.82784,0.17804,1.29092,5.26636,854.07321,435.02946,0.59125,0.45633,126.54148,0.88597,2731.37758,519.97175,15.36663
+"2252","YBR268W",40,110,7,28.56693,0.82504,0.17634,1.25179,4.45013,821.60219,421.50881,0.56485,1.04163,111.22737,0.87256,2513.57747,389.77646,15.466
+"2253","YBR268W",52,110,7,29.19504,0.85793,0.17943,1.28666,5.60842,854.33493,416.16933,0.57982,0.56464,113.70869,0.93344,2525.1712,413.4178,15.60375
+"2254","YBR268W",64,110,7,30.98029,0.84554,0.18059,1.34511,4.82764,895.83032,470.47805,0.61201,0.46996,130.75841,0.92964,2915.70281,490.13891,16.19514
+"2255","YBR268W",76,110,7,33.85635,0.81035,0.17938,1.30513,5.30561,895.26928,492.92281,0.61461,0.44806,129.00243,0.88894,2950.98736,443.69751,16.8411
+"2256","YBR268W",88,110,7,56.12839,0.8996,0.20704,1.45882,30.17554,1119.83695,633.83377,0.80019,0.63569,178.60709,1.08198,3846.69492,638.48346,24.86329
+"2541","YDL227C",1,88,1,74.89276,0.77877,0.15738,2.1003,8.77718,3102.23683,501.83247,1.28532,1.34413,221.00712,1.3606,3702.34768,716.11514,17.32701
+"2542","YDL227C",6,88,1,61.37255,0.77455,0.15909,1.97541,9.91917,3187.34964,508.29492,1.32991,1.41226,219.08754,1.16235,3921.48874,615.0119,17.09903
+"2543","YDL227C",13,88,1,70.09741,0.77556,0.16044,1.93999,11.55432,3078.58735,465.16001,1.28824,1.50646,192.31004,1.12231,3688.00424,551.67452,16.45282
+"2544","YDL227C",18,88,1,64.03442,0.78877,0.15981,1.93125,8.28511,3069.77425,469.85546,1.29447,1.85406,191.61638,1.098,3897.74725,565.73566,18.77214
+"2545","YDL227C",25,88,1,72.39494,0.80979,0.16114,2.10523,9.25912,2963.56359,445.4516,1.31501,1.67099,185.17554,1.20671,3694.9021,484.47764,18.30712
+"2546","YDL227C",30,88,1,64.11348,0.81997,0.16556,1.924,7.34153,2952.11791,462.24362,1.26265,1.52226,202.02272,1.11607,3868.44085,523.94772,18.07784
+"2547","YDL227C",37,88,1,120.33692,0.75765,0.1519,4.15238,9.72678,2597.27004,317.65424,1.16241,1.6153,128.90987,1.21268,2706.93848,360.53367,22.44161
+"2548","YDL227C",42,88,1,47.15121,0.75604,0.15503,1.84396,7.05322,2715.35202,407.07674,1.11631,1.34698,179.6212,1.06598,3420.09693,441.54215,17.06743
+"2549","YDL227C",49,88,1,51.37292,0.83351,0.16203,2.36218,8.75837,2970.03594,451.92682,1.25014,1.66646,193.63806,1.36297,3626.19456,459.17191,17.7804
+"2550","YDL227C",54,88,1,99.44683,0.7872,0.16282,2.02031,10.19924,2911.07543,452.10749,1.23984,1.56992,190.899,1.57261,3720.20678,508.79413,23.17053
+"2551","YDL227C",61,88,1,37.13516,0.82094,0.15422,1.85462,9.00836,2779.26803,365.32066,1.14104,1.56133,125.62795,1.13193,3261.59371,333.7811,16.09428
+"2552","YDL227C",66,88,1,85.92829,0.73795,0.15537,2.04628,18.01348,2455.1043,316.10391,1.11036,1.40603,132.15597,1.06146,2907.99226,335.98075,23.37538
+"2553","YDL227C",73,88,1,51.29563,0.77072,0.15195,1.80988,10.26793,2580.62163,322.43598,1.09834,1.45428,124.84873,1.09723,2859.05271,317.10828,20.77143
+"2554","YDL227C",78,88,1,98.09251,0.75115,0.14705,1.90337,7.60341,2477.72986,314.50601,1.0741,1.83736,115.46171,1.10802,2748.72519,306.34752,27.34619
+"2555","YDL227C",85,88,1,86.02076,0.78645,0.15543,2.21261,11.51303,2466.23948,291.82405,1.05581,1.49578,110.90176,1.75474,2718.47912,300.86831,21.22836
+"2556","YDL227C",90,88,1,44.01598,0.74371,0.14041,1.85257,6.5986,2440.37802,308.88622,1.02236,1.43764,110.48027,0.95896,2698.04764,247.79677,15.26287
+"2557","YDL227C",1,89,1,75.23352,0.73301,0.15535,2.17239,15.46737,3145.71705,531.50642,1.44517,1.54526,221.13443,2.07405,3806.31892,809.14239,16.48786
+"2558","YDL227C",6,89,1,52.82938,0.78366,0.16231,2.23015,8.48433,3138.9059,529.7714,1.33739,1.86168,222.10764,2.53013,4060.708,634.05629,17.70808
+"2559","YDL227C",13,89,1,90.69554,0.79487,0.16394,1.96841,8.06757,3367.28147,573.89517,1.43755,1.73559,522.73613,1.34781,4020.53772,2477.687,16.65897
+"2560","YDL227C",18,89,1,75.69951,0.80839,0.16479,2.13873,10.79645,2997.30838,487.88209,1.5166,1.50885,230.19291,1.22871,3887.06194,533.67622,30.62245
+"2561","YDL227C",25,89,1,38.85692,0.80257,0.15829,1.96027,7.64035,3034.38225,445.08834,1.28107,1.70525,173.80586,1.276,3851.24546,466.17496,16.94967
+"2562","YDL227C",30,89,1,44.51897,0.79757,0.15725,1.92668,6.3473,2918.14299,463.12145,1.24621,1.38481,189.56342,0.99745,3783.24142,478.66031,19.56366
+"2563","YDL227C",37,89,1,26.53215,0.75316,0.15239,1.81554,7.07574,2566.92539,347.36153,1.10465,1.47799,140.30063,1.14952,2861.36968,291.03916,14.92151
+"2564","YDL227C",42,89,1,29.83084,0.7649,0.15021,1.85043,6.80307,2678.05805,390.43995,1.1188,1.60507,145.23946,0.90483,3223.65555,381.34198,16.07818
+"2565","YDL227C",49,89,1,41.59944,0.79997,0.16673,1.96055,7.58229,3082.51868,454.32299,1.29862,1.43621,180.54231,1.25434,3766.26789,469.92369,16.78247
+"2566","YDL227C",54,89,1,38.07398,0.79635,0.16258,1.92859,10.17215,2918.8345,458.73267,1.26969,1.66652,174.48986,1.01323,3739.01158,442.20849,16.89394
+"2567","YDL227C",61,89,1,29.82464,0.80492,0.15556,1.9043,6.40528,2760.41459,379.0915,1.17973,1.46195,166.00856,3.09735,3293.34678,464.30918,15.85039
+"2568","YDL227C",66,89,1,61.4777,0.77096,0.14736,1.86575,7.01067,2675.89605,378.30897,1.14595,1.40085,154.02437,0.94212,3238.17366,377.3263,15.82621
+"2569","YDL227C",73,89,1,20.35031,0.75599,0.15068,1.8119,6.01786,2470.90426,323.58946,1.07219,1.53547,131.25423,1.02067,2890.85687,264.23214,14.78142
+"2570","YDL227C",78,89,1,53.16256,0.74497,0.14779,1.74766,6.5977,2391.75248,335.14296,0.99942,1.51737,140.84064,0.91086,2953.30073,264.64314,15.25846
+"2571","YDL227C",85,89,1,38.00559,0.77052,0.15092,2.87712,6.7419,2405.50354,294.34149,1.05306,1.52195,121.4979,1.03713,2861.34472,270.43893,17.52138
+"2572","YDL227C",90,89,1,49.98884,0.76403,0.13782,1.73281,5.41018,2190.27723,274.86328,0.9429,1.42654,126.35063,0.83932,2476.84299,222.61455,15.4991
+"2573","YDL227C",1,90,1,73.61913,0.77793,0.15832,2.73669,8.92659,3115.12746,538.54595,1.36048,1.37507,227.70625,1.29642,3926.556,684.64273,17.84771
+"2574","YDL227C",6,90,1,54.59544,0.75125,0.15901,2.06109,5.42335,3141.24399,530.64049,1.33438,1.40995,209.47404,1.3385,4017.67569,594.01665,17.03766
+"2575","YDL227C",13,90,1,46.93775,0.77095,0.16163,1.98393,7.41046,3047.02708,479.18999,1.56594,1.41858,202.44313,1.16992,3815.4353,532.44808,16.69377
+"2576","YDL227C",18,90,1,42.57201,0.79848,0.16251,1.96928,4.97883,3212.12962,532.17071,1.32598,1.35133,204.45932,1.05313,4183.25831,542.86506,17.23626
+"2577","YDL227C",25,90,1,44.61773,0.81004,0.16444,2.03024,6.29881,2971.12141,450.09442,1.29214,1.49231,193.73188,1.75783,3785.57374,438.38602,18.03794
+"2578","YDL227C",30,90,1,40.07562,0.82662,0.15917,2.02923,6.41121,3104.40306,472.03476,1.32253,1.43605,174.43505,1.04098,3816.90269,466.18885,18.43167
+"2579","YDL227C",37,90,1,34.99692,0.75296,0.15467,1.94069,4.52291,2730.05318,377.25001,1.17091,1.26319,148.01638,5.98012,3158.10972,328.08658,18.13511
+"2580","YDL227C",42,90,1,32.39396,0.76981,0.15094,1.9446,4.51745,2709.27538,370.11763,1.22765,1.25719,138.30525,0.96532,3230.54148,313.9558,16.05309
+"2581","YDL227C",49,90,1,31.99607,0.78334,0.15836,1.95738,6.13276,2810.66764,383.24626,1.18997,1.42406,154.15085,1.04091,3357.85789,355.65913,16.41758
+"2582","YDL227C",54,90,1,29.35403,0.78114,0.15371,1.96196,4.55502,2762.02581,392.80649,1.15606,1.41206,152.49581,0.97383,3379.58081,353.42855,16.50317
+"2583","YDL227C",61,90,1,29.78431,0.78304,0.15103,1.93138,5.49986,2699.61748,363.67957,1.14623,1.48107,148.62798,1.03078,3198.20315,332.75277,16.39565
+"2584","YDL227C",66,90,1,27.56503,0.7765,0.15298,1.95491,5.27486,2735.30568,383.18875,1.15186,1.44879,154.58842,0.96821,3216.56487,325.80864,16.63567
+"2585","YDL227C",73,90,1,23.38691,0.73738,0.15102,1.81134,8.76235,2442.27803,310.26341,1.09986,1.56556,134.49316,2.05294,2861.10195,285.45442,14.75497
+"2586","YDL227C",78,90,1,35.21901,0.77108,0.14714,1.82815,8.49426,2475.97316,334.2914,1.06213,1.53549,133.65416,2.06854,2951.91301,315.44147,15.39119
+"2587","YDL227C",85,90,1,26.93879,0.78906,0.15197,1.8424,6.97721,2529.22586,309.91295,1.10275,1.46727,115.13995,1.12137,2845.81142,253.08,16.42404
+"2588","YDL227C",90,90,1,36.20626,0.74949,0.14043,1.74778,4.88777,2307.59619,271.56936,0.98301,1.74885,90.27657,0.83171,2552.9672,163.24944,15.73097
+"2589","YDL227C",1,94,2,44.0453,0.74553,0.15412,1.95962,10.26669,2843.03799,432.87238,1.23021,0.98787,192.20202,1.34661,3420.83785,348.35124,17.22058
+"2590","YDL227C",6,94,2,35.72816,0.74203,0.15674,1.88241,10.94598,2832.83494,384.88565,1.19435,1.00099,193.84353,1.17317,3146.45559,357.89651,15.60587
+"2591","YDL227C",13,94,2,21.98713,0.68182,0.14437,1.72377,12.37649,2464.82132,307.87567,1.0365,1.02602,138.78152,1.07421,2369.13401,309.90117,12.69778
+"2592","YDL227C",18,94,2,27.76043,0.6648,0.14553,1.81101,10.7602,2365.18562,332.58126,0.9915,1.36119,179.63063,1.29505,2492.33823,298.99239,13.70014
+"2593","YDL227C",25,94,2,21.06577,0.70322,0.14435,1.701,13.85548,2208.86529,252.07388,0.96781,0.95923,124.89245,1.00787,2148.06427,196.49459,13.13302
+"2594","YDL227C",30,94,2,11.47631,0.66214,0.1399,1.5992,11.44575,2051.52438,218.21801,0.83131,1.03684,109.79667,1.15451,1836.05702,124.39038,11.91183
+"2595","YDL227C",37,94,2,4.18035,0.67712,0.13128,1.6029,10.01419,1840.01774,188.11178,0.77806,1.4219,98.24493,0.90262,1575.23856,53.81736,11.00217
+"2596","YDL227C",42,94,2,26.7579,0.67836,0.13991,1.72217,10.81452,2227.99537,274.87236,0.90971,1.84608,136.06378,1.42102,2195.05774,254.71767,13.08879
+"2597","YDL227C",49,94,2,13.98581,0.69323,0.14395,1.6981,15.90896,2256.22508,250.90991,0.89038,0.97631,131.10165,0.98858,2081.09553,252.79214,12.18542
+"2598","YDL227C",54,94,2,8.2263,0.66932,0.13695,1.57218,9.67854,1863.18934,178.97403,0.83481,1.06548,97.15733,8.67908,1358.34312,68.97705,10.70125
+"2599","YDL227C",61,94,2,20.02285,0.6944,0.14503,1.77042,11.75791,2327.64645,309.28079,0.96262,1.03891,152.58351,1.06883,2371.02804,286.39326,13.12667
+"2600","YDL227C",66,94,2,10.84736,0.69273,0.13571,1.56984,9.9475,2049.21798,233.22637,0.84668,1.33751,108.8826,0.87204,1888.06191,109.94607,12.31985
+"2601","YDL227C",73,94,2,32.36803,0.7367,0.14377,1.81426,10.5282,2285.00395,281.62244,0.96967,1.07619,133.87031,1.15659,2346.85369,262.3803,14.47971
+"2602","YDL227C",78,94,2,27.99144,0.71901,0.14893,1.76691,10.38645,2433.94527,322.27172,1.00376,0.97315,169.50055,1.05502,2661.03756,312.44767,14.28759
+"2603","YDL227C",85,94,2,43.20497,0.76515,0.14976,2.23002,15.55673,2316.81711,271.00751,1.00151,1.5717,141.67971,1.27458,2286.10426,248.50701,16.01742
+"2604","YDL227C",90,94,2,32.44068,0.7594,0.15578,1.80467,10.90018,2497.65783,340.43221,1.06547,1.29936,172.23733,1.08352,2891.7969,360.57228,15.9749
+"2605","YDL227C",1,95,2,59.95168,0.7543,0.15584,2.09485,11.4327,2859.10964,469.63085,1.20115,1.0132,237.18038,1.79488,3558.6393,347.02646,18.18528
+"2606","YDL227C",6,95,2,40.3023,0.77148,0.16204,2.01545,18.36594,2946.42546,416.17008,1.32139,1.06378,179.58847,1.27667,3216.04174,350.70138,17.2114
+"2607","YDL227C",13,95,2,26.70073,0.68345,0.14392,1.74347,8.58918,2583.98431,317.93785,1.00744,0.79714,145.29983,1.2059,2428.89268,309.1318,12.2759
+"2608","YDL227C",18,95,2,35.32127,0.71181,0.14977,1.76643,11.17584,2652.23225,355.79626,1.09396,1.18033,239.23976,1.03417,2556.27061,916.06463,13.47154
+"2609","YDL227C",25,95,2,22.02364,0.7234,0.14532,1.81851,9.00361,2295.7348,254.69466,0.99373,1.03893,128.57004,1.24124,2129.00132,240.02211,13.33127
+"2610","YDL227C",30,95,2,15.48643,0.67874,0.13444,1.50625,8.26354,1961.81997,195.41114,0.81479,0.9335,98.59205,0.77239,1691.25069,140.2181,11.50112
+"2611","YDL227C",37,95,2,6.50976,0.67321,0.13118,1.54128,7.78503,1858.11506,181.52355,0.78327,0.85283,90.20593,1.18157,1531.75382,29.17399,11.0137
+"2612","YDL227C",42,95,2,15.91496,0.70962,0.14381,1.6658,8.58066,2280.98497,245.83505,0.9084,0.97791,114.80825,0.91958,2034.91023,199.81588,12.56739
+"2613","YDL227C",49,95,2,11.70173,0.65798,0.13132,1.52666,8.24077,2013.43282,215.25108,0.77956,0.92319,106.94613,0.92319,1761.65381,122.05287,10.73458
+"2614","YDL227C",54,95,2,6.61695,0.67476,0.13034,1.46627,8.03356,1931.50549,184.87391,0.75326,1.20229,90.78163,0.75431,1512.44634,44.22337,10.83804
+"2615","YDL227C",61,95,2,18.50395,0.72469,0.14356,1.73531,9.50607,2267.40629,273.37417,0.94612,0.99844,130.26003,2.13737,2292.81559,195.80107,13.11568
+"2616","YDL227C",66,95,2,12.85021,0.73378,0.13888,1.59727,9.48754,2020.17616,221.66179,0.84985,1.28759,95.99054,0.8453,1722.51114,61.45453,12.47276
+"2617","YDL227C",73,95,2,22.84967,0.75274,0.14664,1.74495,10.51222,2474.35186,307.20114,1.04573,0.93938,141.69541,1.231,2510.7192,250.11127,14.32736
+"2618","YDL227C",78,95,2,17.99747,0.74603,0.14428,1.78547,9.13081,2300.90626,260.78841,0.97662,1.07728,112.58235,0.90451,2220.23533,182.25919,14.52791
+"2619","YDL227C",85,95,2,51.89944,0.77063,0.14373,1.82131,9.38657,2213.36849,245.15755,0.9724,0.91369,116.06688,1.37323,2184.35177,144.20636,15.85123
+"2620","YDL227C",90,95,2,29.41168,0.7495,0.14899,2.52922,10.02846,2359.39045,307.52079,1.95166,0.92495,147.93561,1.43585,2569.22322,260.50141,15.34095
+"2621","YDL227C",1,96,2,50.43512,0.78645,0.16514,1.97941,11.71437,3093.86082,549.05582,1.44245,0.97894,242.77246,1.41522,4041.7752,439.82721,18.80632
+"2622","YDL227C",6,96,2,50.29901,0.77715,0.16407,2.10614,12.02157,2995.27393,519.11335,1.29256,0.93299,231.59404,1.34383,3586.23339,496.31149,17.04743
+"2623","YDL227C",13,96,2,39.43975,0.69666,0.15525,1.98369,9.92847,2834.12631,379.28753,1.12656,0.86715,166.67792,1.50966,2777.96528,375.20917,14.45478
+"2624","YDL227C",18,96,2,25.79572,0.72036,0.15418,1.8373,10.05248,2494.74047,329.35664,1.01939,0.88366,158.35134,1.07241,2493.32662,300.86754,13.9123
+"2625","YDL227C",25,96,2,24.81846,0.73557,0.15093,1.78518,9.20879,2464.87177,292.95549,1.04748,0.9032,130.7054,1.02626,2440.11696,212.467,13.84148
+"2626","YDL227C",30,96,2,10.20488,0.65313,0.13635,1.58495,8.17467,1856.4122,200.25258,0.76979,0.89283,98.89586,1.01126,1697.22524,98.20374,12.01208
+"2627","YDL227C",37,96,2,7.89912,0.69818,0.13951,1.92804,10.17154,2002.34698,199.67538,0.80142,0.93805,99.15852,0.83258,1600.43935,64.17738,11.03448
+"2628","YDL227C",42,96,2,14.10252,0.66346,0.13976,1.84588,8.35734,2172.59344,253.79806,0.85783,0.85704,128.71413,1.0496,2028.17477,164.93717,12.19272
+"2629","YDL227C",49,96,2,19.86698,0.71656,0.14677,1.63366,10.35619,2263.01981,250.8813,0.91977,0.92133,127.04535,0.90646,2052.45172,201.25299,12.03134
+"2630","YDL227C",54,96,2,3.71637,0.65295,0.13193,1.49992,7.2764,1807.37543,187.68565,0.69689,0.82691,95.27587,0.75691,1535.53088,20.59244,10.72613
+"2631","YDL227C",61,96,2,24.49522,0.73425,0.14749,1.73407,26.36722,2343.41609,283.4533,1.0027,0.86628,138.69507,0.99891,2188.8052,180.98569,13.11919
+"2632","YDL227C",66,96,2,8.1581,0.68572,0.13562,1.56054,7.64713,1790.71302,210.00598,0.81185,0.87943,110.66514,0.75707,1506.22442,72.67809,11.06651
+"2633","YDL227C",73,96,2,24.96588,0.76915,0.15676,1.81399,15.45972,2465.87786,304.23894,1.08951,0.98482,148.59479,1.07904,2599.88538,234.86213,14.42675
+"2634","YDL227C",78,96,2,15.36149,0.77098,0.14905,1.77477,9.54472,2374.57605,277.13058,0.99581,1.07995,129.46299,0.93561,2341.21304,175.73603,14.19379
+"2635","YDL227C",85,96,2,25.5487,0.78897,0.15286,1.87677,12.21659,2335.82313,273.74089,1.07563,1.06616,125.34345,1.13039,2288.4982,167.66545,14.94792
+"2636","YDL227C",90,96,2,27.80127,0.77855,0.15586,1.90149,9.52955,2487.24938,325.55004,1.04126,0.93235,161.00892,1.02581,2740.38956,263.51598,16.54242
+"2637","YDL227C",1,97,3,78.29559,0.7588,0.1692,2.47768,13.39143,2781.60679,533.24194,1.25058,0.94129,265.41332,1.55182,3855.73907,468.70007,19.18812
+"2638","YDL227C",6,97,3,53.9526,0.79461,0.17145,2.30241,12.46184,2792.95525,476.9733,1.24688,1.34638,216.60363,1.59478,3652.96837,418.80413,19.32246
+"2639","YDL227C",13,97,3,48.63561,0.76951,0.16444,2.24263,12.53148,2699.74899,482.63029,1.20873,1.13063,210.6492,1.28826,3594.64986,415.20821,17.42513
+"2640","YDL227C",18,97,3,47.2194,0.81588,0.17105,2.13203,12.49547,2912.32957,577.69781,1.24274,1.34869,240.6002,1.54169,4124.7911,461.5225,19.40544
+"2641","YDL227C",25,97,3,128.35654,0.86576,0.17926,2.39427,15.65288,3278.42461,662.37859,1.47187,2.11402,565.65145,1.66459,4181.70157,2737.78245,20.86805
+"2642","YDL227C",30,97,3,54.96327,0.82002,0.17608,2.21624,13.12186,2854.69877,535.37794,1.28443,0.97082,240.45492,1.52751,4033.3405,502.59204,19.83659
+"2643","YDL227C",37,97,3,33.95188,0.78488,0.16292,2.14949,22.05237,2621.45999,456.0612,1.19367,0.97887,198.96933,1.19292,3589.17786,382.10734,17.07256
+"2644","YDL227C",42,97,3,42.81856,0.81822,0.16549,2.18438,14.47907,2690.33721,463.97822,1.19898,0.97214,212.61986,1.5245,3605.7736,434.59293,19.21459
+"2645","YDL227C",49,97,3,53.89236,0.80118,0.16521,2.18673,12.60063,2588.43735,459.25086,1.15537,1.40263,219.41573,1.28011,3642.07837,388.1171,18.85267
+"2646","YDL227C",54,97,3,41.68646,0.867,0.17685,2.40091,12.25565,2625.31349,430.67381,1.20752,1.09924,193.1716,1.54098,3429.54133,350.95718,19.72516
+"2647","YDL227C",61,97,3,36.89247,0.80477,0.16213,2.18658,11.96094,2581.58872,422.57578,1.1563,1.01775,193.45334,1.25358,3468.89469,351.23756,17.44396
+"2648","YDL227C",66,97,3,47.82775,0.86115,0.18026,2.29614,11.72866,2755.05479,438.05371,1.21065,1.71128,199.6234,1.57904,3576.06112,374.21516,20.35592
+"2649","YDL227C",73,97,3,68.30832,0.82165,0.17079,2.35981,15.07365,2470.21528,400.31157,1.23323,2.42816,225.09076,1.47207,3388.00278,333.69311,17.7474
+"2650","YDL227C",78,97,3,38.93413,0.83802,0.17237,2.17196,11.55205,2594.63225,404.65129,1.14202,1.08488,180.2764,1.4658,3393.09333,307.5174,19.27295
+"2651","YDL227C",85,97,3,34.72775,0.86449,0.16446,2.14125,12.13103,2423.98505,336.24928,1.11022,1.04879,148.9178,1.25381,2879.17613,201.24627,18.13363
+"2652","YDL227C",90,97,3,43.86458,0.851,0.1679,2.2441,11.07939,2522.56596,368.91692,1.14061,1.04927,179.70591,1.44879,3222.08234,276.01936,20.0127
+"2653","YDL227C",1,98,3,43.78078,0.77061,0.16211,2.0443,11.23301,2767.65837,472.67798,1.24175,0.96958,229.11872,1.1772,3512.31086,358.0188,18.20705
+"2654","YDL227C",6,98,3,49.24175,0.82129,0.17783,2.10995,12.944,3127.23518,650.71762,1.3504,1.0618,297.64732,1.30589,4485.52925,625.87778,18.85243
+"2655","YDL227C",13,98,3,47.78139,0.76048,0.16507,2.01346,12.16629,2718.35083,488.2198,1.21877,1.19881,224.72365,1.34492,3664.14306,399.1286,17.67569
+"2656","YDL227C",18,98,3,32.29834,0.7964,0.16955,1.98874,10.55864,2808.38862,493.73647,1.22159,1.07086,222.72134,1.23884,3702.2736,402.09826,17.23278
+"2657","YDL227C",25,98,3,44.60856,0.84368,0.17527,2.0972,13.7361,3087.24585,608.96731,1.35034,1.2415,279.60104,1.32032,4382.04261,575.64037,18.555
+"2658","YDL227C",30,98,3,31.76457,0.76592,0.16241,1.93385,12.41879,2535.01441,439.05102,1.14449,0.89699,197.77799,1.14229,3395.39625,380.91118,16.86348
+"2659","YDL227C",37,98,3,55.4367,0.83188,0.16852,2.15567,12.67736,2803.17806,488.1409,1.26995,1.02953,216.45166,1.60845,3734.6208,367.56221,18.84273
+"2660","YDL227C",42,98,3,41.86328,0.83984,0.16925,2.02437,10.93072,2771.23135,469.27998,1.18454,0.96759,212.64249,1.17244,3657.93468,404.1946,19.58609
+"2661","YDL227C",49,98,3,34.85505,0.85155,0.17972,2.13592,12.20631,2774.02624,472.98518,1.24361,0.98051,219.37263,1.25991,3733.04038,338.99001,17.92037
+"2662","YDL227C",54,98,3,28.54511,0.78874,0.1595,1.91213,10.99059,2413.3664,393.15131,1.07548,1.0519,178.51153,1.13253,3242.41443,262.78541,17.69903
+"2663","YDL227C",61,98,3,27.92441,0.82396,0.16487,1.98477,11.71907,2576.27124,420.865,1.1534,1.00608,195.36724,1.17413,3390.60985,338.69083,17.37502
+"2664","YDL227C",66,98,3,31.45264,0.82959,0.17122,1.99444,10.92344,2578.43018,430.62201,1.12353,1.00424,200.69184,1.2093,3616.19569,336.43563,18.20573
+"2665","YDL227C",73,98,3,57.07169,0.85894,0.17978,2.14019,12.8728,2702.00662,456.16629,1.25636,0.94416,225.10438,1.4366,3749.47724,381.28232,23.35505
+"2666","YDL227C",78,98,3,29.78946,0.83561,0.1672,2.00393,11.60618,2586.16883,400.24775,1.12673,1.14445,182.75696,1.17217,3309.34111,299.51193,18.97653
+"2667","YDL227C",85,98,3,32.80333,0.92524,0.17747,2.24362,13.39928,2884.96906,394.99254,1.31243,1.23588,180.73789,1.26487,3463.15194,282.84885,19.49324
+"2668","YDL227C",90,98,3,42.7353,0.87048,0.17542,2.08368,11.48404,2594.25281,388.70854,1.12811,1.05004,161.13565,1.37402,3275.80042,219.37558,22.03905
+"2669","YDL227C",1,99,3,61.06696,0.76155,0.16713,2.00589,12.36544,2833.71993,493.578,1.28658,1.09034,210.5309,1.27553,3607.61593,400.13867,21.3325
+"2670","YDL227C",6,99,3,60.31938,0.79456,0.16947,2.12691,12.21794,3028.45079,577.65951,1.35446,1.13192,266.25546,1.21965,4230.98683,528.7307,20.34183
+"2671","YDL227C",13,99,3,37.16233,0.76033,0.15997,1.94071,18.59528,2662.21761,483.59031,1.21992,0.96506,226.61677,1.15426,3613.86686,352.27966,16.42795
+"2672","YDL227C",18,99,3,51.39945,0.81661,0.17236,2.07993,13.61261,2906.33265,514.06983,1.30853,1.0878,241.96839,1.19628,3918.04979,450.2631,19.53375
+"2673","YDL227C",25,99,3,35.05855,0.80741,0.16603,2.07695,12.17184,2829.72597,521.47699,1.2574,1.11019,242.67803,1.21946,3867.82335,420.85439,18.09841
+"2674","YDL227C",30,99,3,33.65712,0.8151,0.16751,2.01604,11.32458,2774.44828,467.8568,1.22965,0.95427,213.67964,1.14277,3645.51312,438.0359,17.51702
+"2675","YDL227C",37,99,3,32.75395,0.82964,0.17193,1.99216,12.36412,2848.13809,483.37139,1.25543,1.36005,208.94637,1.13911,3747.28057,377.65448,17.78532
+"2676","YDL227C",42,99,3,36.48,0.82878,0.1719,2.04276,12.33693,2746.42605,467.92367,1.18213,1.12526,225.12808,1.19957,3762.49754,375.56732,18.61534
+"2677","YDL227C",49,99,3,36.03023,0.84296,0.17426,2.03931,12.85427,2807.91378,471.10226,1.25524,1.18898,207.97998,1.1507,3677.38053,363.83613,18.11819
+"2678","YDL227C",54,99,3,29.30044,0.83952,0.17136,2.03937,10.80994,2710.38445,429.84004,1.20136,0.8982,184.30313,1.13892,3526.58405,278.10967,18.10684
+"2679","YDL227C",61,99,3,33.47021,0.87554,0.17314,2.10873,12.48486,2798.53197,464.43102,1.21425,1.03069,195.64958,1.16982,3702.48257,311.97586,18.36309
+"2680","YDL227C",66,99,3,28.45103,0.81839,0.1673,1.97046,10.5651,2723.34642,446.57025,1.20293,0.93244,192.73032,1.10506,3607.23956,359.6451,17.67786
+"2681","YDL227C",73,99,3,34.39255,0.86562,0.17739,2.10114,12.81203,2686.70741,464.10849,1.18985,1.18685,222.24492,1.22654,3720.05641,331.86977,18.41308
+"2682","YDL227C",78,99,3,23.13216,0.8403,0.16504,2.03557,10.82594,2579.81398,380.96996,1.15182,1.04945,161.50534,1.07597,3242.6266,239.12806,17.49825
+"2683","YDL227C",85,99,3,37.31471,0.92552,0.18628,2.20242,13.25422,2668.48683,385.20306,1.22912,1.11665,180.10448,1.48127,3292.60399,233.25368,19.8703
+"2684","YDL227C",90,99,3,25.00814,0.82995,0.15582,1.95044,9.79979,2367.61279,334.02735,1.01731,0.94265,141.47127,1.21711,2838.93972,137.88508,17.05267
+"2685","YDL227C",1,100,4,55.90093,0.50691,0.10362,1.2173,4.68214,1888.3567,395.44239,0.93575,0.45241,172.61653,2.7866,2447.41959,406.14259,15.83597
+"2686","YDL227C",6,100,4,49.59243,0.70558,0.13563,1.32919,4.74125,2426.28873,429.44154,1.16213,0.53018,181.23741,0.68121,2844.37303,453.1281,14.37933
+"2687","YDL227C",13,100,4,48.27406,0.74492,0.14763,1.53722,7.28611,2587.13666,418.64971,1.24042,0.66448,169.15407,0.75481,2911.93909,542.74309,15.04336
+"2688","YDL227C",18,100,4,48.56144,0.73238,0.14319,1.36848,23.94141,2418.6898,378.13265,1.25249,0.66036,154.72252,0.68144,2691.5645,530.25514,14.86291
+"2689","YDL227C",25,100,4,43.50996,0.73922,0.1413,1.34864,5.16144,2403.28493,390.04452,1.13301,0.59028,171.47171,0.62404,2794.65091,484.90991,13.93287
+"2690","YDL227C",30,100,4,48.29275,0.75241,0.14174,1.36916,6.26922,2392.27873,390.17203,1.14754,0.63496,162.48806,0.75259,2746.81631,484.76475,15.03627
+"2691","YDL227C",37,100,4,42.38978,0.82615,0.15072,1.56663,6.43387,2420.41224,355.52571,1.16827,0.92562,140.85715,2.2206,2603.49747,444.01595,15.59392
+"2692","YDL227C",42,100,4,51.83644,0.73873,0.13868,1.37042,13.56433,2231.77746,339.61708,1.06709,0.87574,147.73984,0.76504,2604.90474,469.26806,15.00229
+"2693","YDL227C",49,100,4,37.40214,0.80188,0.13682,1.46067,12.41128,2075.11092,286.11452,1.0691,0.73989,117.6633,0.68337,2146.06784,371.57233,13.91243
+"2694","YDL227C",54,100,4,44.47681,0.73667,0.13004,1.39437,4.69236,1908.45964,287.0848,0.98024,0.5656,120.32368,0.75323,2165.36154,359.80758,14.16114
+"2695","YDL227C",61,100,4,39.14656,0.81888,0.13407,1.5439,5.55257,1973.25587,277.28033,1.01692,0.80128,118.15941,0.7942,2110.7171,397.17646,14.42424
+"2696","YDL227C",66,100,4,46.86953,0.77837,0.13997,1.49194,5.24922,2141.47062,322.92372,1.06531,0.95233,138.60449,0.8129,2407.97581,420.26871,14.9289
+"2697","YDL227C",73,100,4,35.3217,0.79954,0.13133,1.37805,4.5227,1798.4114,245.04132,0.94127,0.70007,106.15734,0.91316,1786.16735,300.9233,13.77476
+"2698","YDL227C",78,100,4,36.36461,0.76821,0.12891,1.39615,4.06598,1620.16816,219.75188,0.87888,0.61646,102.57883,0.68746,1695.72994,267.90474,13.76221
+"2699","YDL227C",85,100,4,33.99321,0.76369,0.11923,1.28658,4.05108,1552.81583,189.27789,0.8108,0.73774,79.18326,0.73918,1466.64266,227.53147,13.22415
+"2700","YDL227C",90,100,4,43.89838,0.80175,0.12508,1.71872,5.1522,1583.1,180.78571,0.84665,0.64777,80.03281,0.98262,1397.08396,205.48108,14.07419
+"2701","YDL227C",1,101,4,46.34994,0.50017,0.10252,1.06725,4.20146,1983.44957,400.38618,0.92219,0.48574,172.0496,0.61858,2489.10377,416.6318,10.92118
+"2702","YDL227C",6,101,4,95.35022,0.75759,0.1537,2.35127,5.91654,2611.89686,454.68911,1.27849,0.55774,199.95583,1.47304,3047.90249,484.99985,16.93663
+"2703","YDL227C",13,101,4,40.05042,0.68956,0.13554,1.3095,5.18268,2347.95362,379.77272,1.10018,0.53006,156.07662,0.66671,2597.12509,465.43116,12.94434
+"2704","YDL227C",18,101,4,52.61346,0.72236,0.14279,1.52238,5.62139,2458.62734,449.55025,1.17941,0.58487,194.31434,0.85751,3101.28862,549.28838,14.31999
+"2705","YDL227C",25,101,4,40.54632,0.7166,0.13917,1.48093,5.24435,2057.12408,356.23341,1.04138,0.71371,151.46112,0.70819,2496.02146,422.91458,13.31943
+"2706","YDL227C",30,101,4,36.5039,0.73075,0.13759,1.22119,5.13047,2076.06459,339.61602,1.0272,0.57563,148.97902,0.67818,2460.82167,435.22519,13.10718
+"2707","YDL227C",37,101,4,38.64378,0.72639,0.13394,1.35743,4.51502,1995.06133,335.06803,1.01407,0.539,157.79299,0.76145,2356.68276,414.61247,12.80466
+"2708","YDL227C",42,101,4,33.59416,0.71582,0.13256,1.23174,4.70855,1953.1235,320.59611,0.9996,0.57781,140.46906,0.73159,2310.45509,400.01219,13.14886
+"2709","YDL227C",49,101,4,39.38434,0.75746,0.13204,1.29108,5.61466,1866.29719,284.4919,0.98144,0.63415,126.47325,0.69027,2140.99806,372.84233,12.99306
+"2710","YDL227C",54,101,4,33.5898,0.85755,0.15075,1.42368,5.32345,2084.2401,319.78616,1.10688,0.65462,139.79053,0.80269,2347.28955,392.77795,14.81041
+"2711","YDL227C",61,101,4,36.39418,0.7232,0.12201,1.23614,4.71863,1765.41248,242.68191,0.89798,0.57706,101.92729,0.62053,1831.55978,305.25099,12.54045
+"2712","YDL227C",66,101,4,34.8478,0.75456,0.13378,1.3264,5.58562,1995.64184,328.19447,1.0201,0.78649,138.25184,0.68564,2460.91356,413.99097,13.48347
+"2713","YDL227C",73,101,4,35.23483,0.76195,0.12399,1.31482,4.01807,1708.39889,235.4912,0.89496,0.54342,103.2074,0.74897,1741.88193,275.11506,13.05077
+"2714","YDL227C",78,101,4,36.20316,0.79202,0.13348,1.35172,5.99011,1838.02338,280.08301,0.97047,0.59767,121.32993,0.66959,2161.05675,354.26102,14.09438
+"2715","YDL227C",85,101,4,35.09352,0.78723,0.12379,1.36405,5.45051,1558.28677,204.27089,0.84742,0.57603,87.5884,0.78,1593.2678,229.22968,13.04576
+"2716","YDL227C",90,101,4,32.02039,0.76182,0.1153,1.17275,4.27074,1480.41396,184.47115,0.79995,0.77605,76.94119,0.55308,1438.82803,185.7596,13.48747
+"2717","YDL227C",1,102,4,51.20374,0.46795,0.08995,0.93543,3.10155,1771.32161,341.84782,0.85975,0.34701,157.73028,0.44867,2212.26659,334.72822,9.99765
+"2718","YDL227C",6,102,4,115.71571,0.73131,0.1475,2.82276,5.59828,2741.59734,454.71711,1.4806,0.46392,193.59054,2.06926,2964.11545,485.47474,18.87829
+"2719","YDL227C",13,102,4,49.11476,0.70346,0.13727,1.35068,5.15619,2568.50357,428.09275,1.20397,0.52573,179.40789,0.59924,3005.18346,560.71585,13.95211
+"2720","YDL227C",18,102,4,65.20212,0.73203,0.13512,1.74814,5.32724,2260.98378,357.23621,1.11134,0.52823,146.95126,0.84886,2534.50106,491.51521,14.95996
+"2721","YDL227C",25,102,4,48.06146,0.70796,0.13328,1.23516,5.0529,2351.12999,392.91014,1.15081,0.51912,157.75348,0.5781,2745.24968,477.88581,13.71789
+"2722","YDL227C",30,102,4,40.55,0.69533,0.13014,1.27266,4.18747,2007.15167,308.11576,0.99291,0.49471,124.88311,0.57002,2209.45686,422.18925,12.75654
+"2723","YDL227C",37,102,4,49.34347,0.71873,0.13557,1.31428,4.27893,2136.67244,329.24115,1.09964,0.46498,141.98936,0.65024,2408.77415,446.32427,13.64181
+"2724","YDL227C",42,102,4,41.64581,0.74014,0.12755,1.35704,5.8335,1961.78941,294.58088,1.00184,0.5265,118.27956,0.5666,2161.53523,356.32934,12.96325
+"2725","YDL227C",49,102,4,42.71242,0.74414,0.12623,1.29077,4.475,1817.39608,260.61158,0.97899,0.6647,107.02437,0.58329,1999.69178,339.38048,13.02422
+"2726","YDL227C",54,102,4,49.34265,0.74574,0.12577,1.48654,4.4987,1883.48689,275.70625,0.97487,0.50481,121.70101,0.65048,2122.94163,384.16224,13.47058
+"2727","YDL227C",61,102,4,54.89963,0.77055,0.12565,1.40401,4.97884,1867.62305,273.56292,1.00934,0.66837,114.73041,0.52519,2010.38914,330.41801,13.35439
+"2728","YDL227C",66,102,4,41.46089,0.74587,0.12609,1.37055,3.98489,1741.34262,238.15718,0.90867,0.48779,102.32806,0.60303,1833.11666,312.90399,13.10675
+"2729","YDL227C",73,102,4,37.06074,0.76089,0.12018,1.43879,3.82365,1729.72691,223.33464,0.92509,0.52411,98.50779,0.4955,1714.87566,295.49258,13.25818
+"2730","YDL227C",78,102,4,30.20401,0.73277,0.11452,1.27858,4.13689,1535.74919,204.05629,0.82274,0.52806,83.57978,0.5109,1534.02357,239.7684,12.15413
+"2731","YDL227C",85,102,4,44.94697,0.72927,0.11505,1.35792,4.01752,1286.79225,171.4375,0.80656,0.58294,79.39036,0.59687,1259.55936,181.8176,12.7325
+"2732","YDL227C",90,102,4,35.82569,0.78843,0.12146,1.35318,7.01722,1499.8977,173.40905,0.84673,1.18895,77.27285,0.57594,1335.66985,207.30924,13.45248
+"2733","YDL227C",1,103,5,61.58806,0.8245,0.15996,1.55972,2.88417,2738.11756,527.09534,1.34452,0.89187,235.8102,0.6526,3552.85543,473.47853,21.41252
+"2734","YDL227C",6,103,5,34.01275,0.84597,0.16684,1.4996,3.19019,2985.24842,605.34846,1.42826,0.6652,245.89225,0.89017,4061.69181,462.98456,17.94772
+"2735","YDL227C",13,103,5,23.142,0.804,0.15738,1.50398,2.01187,2454.69429,471.40272,1.2264,0.62006,207.76246,0.67363,3280.85723,354.21049,15.6605
+"2736","YDL227C",18,103,5,23.14921,0.84737,0.16787,1.49857,3.30135,2809.3566,549.77776,1.3783,0.62394,227.13057,0.71778,3777.75825,408.73067,16.61635
+"2737","YDL227C",25,103,5,22.80089,0.80485,0.15811,1.46449,2.44971,2561.19072,483.08605,1.23757,0.71525,226.44401,0.69031,3360.14103,356.12346,15.20062
+"2738","YDL227C",30,103,5,20.23299,0.84382,0.16193,1.47075,3.7694,2768.36759,479.70973,1.33342,0.77202,195.37377,0.69211,3308.30095,347.61685,15.73301
+"2739","YDL227C",37,103,5,25.47472,0.87026,0.16362,1.56646,2.57181,2533.12085,458.7085,1.26573,0.51147,203.25796,0.71921,3151.50227,335.28628,16.19195
+"2740","YDL227C",42,103,5,19.21321,0.83932,0.15719,1.42847,3.29002,2451.13399,403.53048,1.19054,0.6361,174.27959,0.7415,2967.33032,297.57986,15.19581
+"2741","YDL227C",49,103,5,25.88321,0.93388,0.16871,1.62252,4.35041,2704.22667,468.17249,1.30585,0.60294,189.07245,0.74958,3204.46136,396.80353,16.96249
+"2742","YDL227C",54,103,5,14.1343,0.8644,0.15368,1.35454,4.69175,2085.80815,320.5872,1.13026,1.75462,134.88616,0.60441,2291.01345,234.11763,15.61013
+"2743","YDL227C",61,103,5,41.43874,0.91007,0.16661,1.64747,3.64654,2404.59499,389.15466,1.23779,0.87492,173.51033,0.74029,2772.43861,295.81778,17.36965
+"2744","YDL227C",66,103,5,19.45016,0.88038,0.15787,1.48311,4.19104,2488.50578,382.01172,1.23112,0.80848,163.73047,0.69901,2650.4898,270.93799,16.42738
+"2745","YDL227C",73,103,5,11.0052,0.86763,0.14402,2.65084,4.04555,2142.55698,295.54521,1.10857,0.6037,119.11305,0.61096,2117.49474,139.70498,15.32242
+"2746","YDL227C",78,103,5,37.59846,0.89476,0.1553,1.41174,3.847,2204.15717,290.89992,1.09704,0.76029,124.64072,0.64462,2260.70042,217.86429,15.931
+"2747","YDL227C",85,103,5,21.12745,0.94746,0.16032,1.57054,3.66701,2270.83483,313.04299,1.15378,0.81389,135.25909,0.70109,2330.88913,257.24103,16.50696
+"2748","YDL227C",90,103,5,29.36847,0.93072,0.15349,1.46425,3.84693,2168.5017,266.38141,1.11034,0.65863,112.95829,0.80803,2032.3381,174.80757,17.92942
+"2749","YDL227C",1,104,5,41.27985,0.87524,0.16938,1.51667,1.41047,2967.12957,615.62487,1.46413,0.7338,269.87466,0.6856,4086.25003,479.70351,18.89728
+"2750","YDL227C",6,104,5,71.31592,0.81651,0.16055,1.40018,3.56091,2677.45476,517.93764,1.28801,0.64968,219.57735,0.78509,3488.17753,361.79749,22.75415
+"2751","YDL227C",13,104,5,17.3701,0.87013,0.16146,1.35361,0.27494,2778.99392,489.64648,1.31927,0.50992,207.66605,0.62085,3349.86605,307.61566,15.79056
+"2752","YDL227C",18,104,5,19.9529,0.86376,0.1621,1.50647,2.20658,2840.55452,521.64827,1.34891,0.46463,195.13647,0.6726,3568.58715,320.40355,16.47031
+"2753","YDL227C",25,104,5,25.21995,0.9165,0.17152,1.51489,2.61655,2955.34535,519.26551,1.38462,0.55898,218.18996,0.676,3657.2668,428.22074,16.72558
+"2754","YDL227C",30,104,5,28.158,0.89584,0.1696,1.45172,2.308,2826.28993,490.80098,1.35634,0.47374,199.33483,0.72245,3409.75187,379.06394,18.07432
+"2755","YDL227C",37,104,5,21.79819,0.87793,0.16299,1.41851,2.28285,2536.52271,423.60013,1.28677,0.53518,171.35725,0.61712,2921.10234,336.68772,15.64203
+"2756","YDL227C",42,104,5,21.14663,0.91825,0.16674,1.53539,2.94416,2747.14722,435.85039,1.37422,0.55505,172.84672,0.7159,3087.25133,315.69654,17.85299
+"2757","YDL227C",49,104,5,22.12405,0.89573,0.16218,1.4415,2.02528,2527.53585,419.50781,1.24571,0.55705,183.93359,0.67116,2992.58136,288.66661,15.51116
+"2758","YDL227C",54,104,5,25.38696,0.90694,0.16471,1.4707,2.68053,2555.20847,385.64477,1.23449,0.58765,160.44352,1.11735,2808.9025,288.52453,18.16624
+"2759","YDL227C",61,104,5,28.39279,0.91535,0.16602,1.51055,3.64809,2550.24748,433.45174,1.29702,1.44793,186.66594,0.69781,3057.9894,305.67749,16.40844
+"2760","YDL227C",66,104,5,17.86543,0.88846,0.15668,1.46752,2.81193,2428.30612,362.53991,1.21968,0.57217,131.42555,0.68008,2724.41356,222.37957,16.53706
+"2761","YDL227C",73,104,5,16.41881,0.93421,0.16245,1.50008,3.13864,2399.16673,334.80537,1.18942,0.69578,132.89628,0.67083,2457.16006,185.81687,16.05537
+"2762","YDL227C",78,104,5,43.57823,0.90182,0.15896,1.44694,3.12986,2548.40377,363.89327,1.25925,0.57003,145.50085,0.7179,2856.68484,300.68081,16.76147
+"2763","YDL227C",85,104,5,22.29556,0.9655,0.16115,1.48895,2.95551,2517.29133,359.52409,1.28093,0.72797,139.17906,0.69438,2500.42869,266.58365,16.95115
+"2764","YDL227C",90,104,5,26.12387,0.92497,0.1499,1.4018,21.74658,2155.92155,269.55438,1.12609,0.49473,99.93977,3.37396,1978.89268,186.6749,15.70186
+"2765","YDL227C",1,105,5,39.32982,0.90265,0.1784,1.47822,1.78153,2960.19064,600.88989,1.47798,0.50254,278.57416,0.74949,4044.03211,564.07008,17.98806
+"2766","YDL227C",6,105,5,19.20766,0.83238,0.1646,1.36237,2.17169,2594.70058,536.95347,1.27367,0.6845,219.49512,0.66267,3568.44698,395.64906,16.26617
+"2767","YDL227C",13,105,5,23.52398,0.89726,0.17456,1.38822,1.77826,3026.98797,548.68613,1.41649,0.4845,221.28794,0.62919,3724.78808,422.00173,16.89055
+"2768","YDL227C",18,105,5,11.92778,0.87836,0.16362,1.39209,6.45659,2588.40269,480.48849,1.27068,0.59144,191.5286,0.62853,3269.32381,323.70701,15.15465
+"2769","YDL227C",25,105,5,21.48032,0.88391,0.16378,1.36501,1.86452,2777.22994,528.08955,1.35994,0.4881,214.29401,0.62781,3719.86492,355.69006,16.14078
+"2770","YDL227C",30,105,5,17.55405,0.84589,0.16202,1.37634,4.22405,2621.85753,487.7974,1.26584,0.59545,180.45014,0.668,3354.573,382.13807,15.33522
+"2771","YDL227C",37,105,5,20.33589,0.87771,0.16587,1.38096,3.16372,2510.48328,450.00947,1.28304,0.93032,173.07107,0.65001,3135.51479,311.74448,17.14191
+"2772","YDL227C",42,105,5,14.69676,0.88049,0.16032,1.42964,2.09999,2576.80499,443.32042,1.26477,0.51578,170.61144,0.6386,3104.48513,314.22658,15.38167
+"2773","YDL227C",49,105,5,21.95913,0.93287,0.16877,1.50568,4.37877,2840.12379,460.89517,1.39848,1.03739,171.53687,0.66464,3179.17462,338.54142,17.61587
+"2774","YDL227C",54,105,5,15.98743,0.93972,0.1647,1.47584,3.9531,2636.34975,422.13315,1.26994,0.93946,160.12845,0.68972,3047.65826,296.2751,16.16874
+"2775","YDL227C",61,105,5,23.21821,0.96801,0.1695,1.53432,10.20646,2978.70043,481.35564,1.43382,0.63975,168.89933,0.68619,3364.65653,343.65851,18.8164
+"2776","YDL227C",66,105,5,11.5742,0.88182,0.15351,1.36261,3.01941,2260.47567,350.45572,1.14491,0.81609,127.82453,0.62091,2432.13866,263.72333,14.41892
+"2777","YDL227C",73,105,5,16.58495,0.96596,0.16071,1.52576,5.44105,2412.43106,329.13218,1.1963,1.05957,114.89748,0.64624,2383.63909,249.39032,16.0538
+"2778","YDL227C",78,105,5,14.54156,0.95771,0.16764,1.51539,2.94334,2590.51352,361.16909,1.27661,0.55481,136.29738,0.68997,2693.28891,317.98104,16.63471
+"2779","YDL227C",85,105,5,21.06454,0.91483,0.15625,1.59678,3.29117,2350.63198,338.62381,1.23776,0.63858,130.81796,0.68298,2473.60419,259.41706,18.00007
+"2780","YDL227C",90,105,5,21.0301,0.93388,0.15213,1.43453,1.74657,2209.35707,309.46312,1.13744,0.54753,108.79135,0.63875,2205.67325,173.50102,16.1413
+"2781","YDL227C",1,106,6,44.05975,0.6859,0.13137,1.38335,4.07704,2099.46414,421.0375,0.98328,0.42516,173.95848,0.50443,2978.05538,367.80403,14.90581
+"2782","YDL227C",6,106,6,30.01614,0.68869,0.13183,1.22607,2.93999,2045.20691,390.09337,0.91178,0.42067,146.60668,0.50393,2676.31519,328.23807,12.5281
+"2783","YDL227C",13,106,6,29.55516,0.69686,0.1299,1.30227,2.70849,2042.36363,373.69458,0.92157,0.53934,143.82343,0.44418,2580.903,314.2419,11.92665
+"2784","YDL227C",18,106,6,26.38406,0.65632,0.11818,1.07717,2.35391,1968.18743,373.44778,0.83844,0.47367,132.4838,0.488,2399.70295,294.04958,11.93646
+"2785","YDL227C",25,106,6,30.02227,0.67127,0.11837,1.20219,2.3635,1849.60382,355.18444,0.85093,0.42943,132.82912,0.40685,2334.03064,281.47284,13.26112
+"2786","YDL227C",30,106,6,23.79866,0.64616,0.11695,1.44038,1.79993,1780.01606,341.40634,0.80253,0.39512,117.87278,0.45898,2149.43507,248.02572,11.97723
+"2787","YDL227C",37,106,6,26.44933,0.67627,0.11915,1.1445,2.61872,1830.70982,326.19946,0.83406,0.40551,119.93377,0.44635,2169.30718,285.86023,11.48393
+"2788","YDL227C",42,106,6,30.3637,0.65549,0.11716,1.03615,2.32063,1629.40114,353.17148,0.78033,0.3943,116.88249,0.41965,2332.00536,271.1668,11.56525
+"2789","YDL227C",49,106,6,17.87091,0.66312,0.11236,0.87354,1.30676,1737.02945,308.7028,0.75986,0.46502,114.95685,0.32917,1999.72738,178.62611,10.59301
+"2790","YDL227C",54,106,6,19.58997,0.68949,0.11522,1.93906,1.8671,1607.49768,277.2713,0.73449,0.39247,82.32766,0.40244,1863.87025,208.91319,12.05746
+"2791","YDL227C",61,106,6,24.93062,0.67793,0.11516,1.01081,2.59744,1644.76578,302.58297,0.77088,0.57901,110.8229,0.42835,2031.79422,241.52129,11.57584
+"2792","YDL227C",66,106,6,20.76512,0.65704,0.11451,1.42843,2.53449,1437.40448,260.1445,0.7067,0.4453,94.65174,0.46734,1728.67458,152.73625,12.26498
+"2793","YDL227C",73,106,6,20.95979,0.67863,0.11636,1.1359,3.87539,1589.2784,245.66506,0.751,0.52297,78.32626,0.3986,1626.57125,138.6119,11.2216
+"2794","YDL227C",78,106,6,18.70657,0.67031,0.11174,1.92287,2.0963,1610.554,275.61319,0.73208,1.08342,81.69666,0.46183,1753.06086,99.4143,13.88892
+"2795","YDL227C",85,106,6,34.50052,0.6655,0.11568,0.97453,3.88781,1545.52091,257.75626,0.73221,0.65527,85.19294,0.40282,1767.77062,122.71001,12.60171
+"2796","YDL227C",90,106,6,20.35374,0.66613,0.10991,0.88567,1.502,1441.81565,264.75095,0.67977,0.43534,76.35861,0.31475,1693.46774,61.27353,12.21695
+"2797","YDL227C",1,107,6,30.53368,0.6694,0.13697,1.1469,2.99604,2362.17635,516.96965,1.08036,0.35538,205.28387,0.52917,3381.27087,435.70752,12.96626
+"2798","YDL227C",6,107,6,29.18733,0.69895,0.13331,1.10551,3.35955,2232.62448,445.27086,0.97561,0.38121,172.8984,0.57219,2998.9408,388.24397,13.93365
+"2799","YDL227C",13,107,6,18.64256,0.65213,0.12481,0.99948,2.55098,1877.26689,398.14952,0.8805,0.32923,161.34295,0.41088,2621.70296,314.55927,11.43845
+"2800","YDL227C",18,107,6,21.03041,0.69265,0.1221,1.00109,2.21146,1915.94755,383.2751,0.88233,0.33538,132.30673,0.44176,2442.30708,287.59542,12.49663
+"2801","YDL227C",25,107,6,17.57012,0.62999,0.11353,0.85016,1.78045,1874.73721,382.80067,0.83624,0.53419,141.67302,0.42771,2364.78712,286.65729,11.54534
+"2802","YDL227C",30,107,6,16.43519,0.66737,0.11842,0.93819,1.80094,1739.08323,323.69922,0.78278,0.35878,113.97117,0.38028,2047.18928,305.40324,11.39036
+"2803","YDL227C",37,107,6,20.58027,0.70674,0.1308,0.98986,2.17317,1928.54643,368.41544,0.89656,0.33458,138.31365,0.54737,2440.33441,328.12255,13.37889
+"2804","YDL227C",42,107,6,19.29621,0.74299,0.12998,1.05921,2.41348,2009.0142,375.86427,0.88304,0.45843,128.46023,0.44661,2432.34574,297.51264,12.71656
+"2805","YDL227C",49,107,6,13.60069,0.70934,0.12062,0.98226,1.60277,1767.75761,295.93595,0.7998,0.3827,103.39655,0.56907,1926.61151,191.25871,12.0954
+"2806","YDL227C",54,107,6,11.0446,0.67966,0.11382,0.87488,1.86338,1513.34761,260.93669,0.68926,0.3755,78.92586,0.38877,1715.57849,189.50114,11.07951
+"2807","YDL227C",61,107,6,12.19261,0.71322,0.11813,0.93799,1.14276,1697.56377,303.14914,0.78754,0.36014,104.20327,0.36223,2040.06858,171.1929,11.60261
+"2808","YDL227C",66,107,6,11.95383,0.67792,0.1138,0.9318,1.78465,1520.77389,268.07863,0.69364,0.51326,76.42409,0.38939,1641.75289,120.48915,11.58348
+"2809","YDL227C",73,107,6,14.16765,0.69996,0.12011,0.94444,3.16561,1663.43094,270.79485,0.76992,0.41211,87.6929,0.46057,1816.67795,114.76944,11.40833
+"2810","YDL227C",78,107,6,14.57439,0.72085,0.12191,0.99353,1.29257,1742.97636,306.29467,0.80283,0.38476,97.3432,0.47627,2105.64043,147.42404,12.27086
+"2811","YDL227C",85,107,6,13.56785,0.75627,0.12679,0.99338,3.12546,1796.0218,306.59838,0.82511,0.45369,100.03233,0.39202,2003.32308,117.54232,12.3914
+"2812","YDL227C",90,107,6,8.47246,0.69242,0.11494,0.84479,1.46865,1575.21235,249.86712,0.68566,0.40395,69.25305,0.32388,1565.83618,61.76738,11.41069
+"2813","YDL227C",1,108,6,27.60541,0.6686,0.12527,1.07576,3.56744,2176.99988,425.65023,0.99715,0.38172,156.98358,0.5049,2885.09232,391.0294,12.34885
+"2814","YDL227C",6,108,6,27.50003,0.66984,0.12779,1.06785,1.80925,1966.06834,390.05906,0.87202,0.32954,144.34453,0.41132,2457.52557,326.65703,13.1324
+"2815","YDL227C",13,108,6,21.93033,0.65553,0.12597,1.03924,2.34036,1832.76008,389.76702,0.89032,0.38663,144.08864,0.46557,2459.22103,329.77427,11.8484
+"2816","YDL227C",18,108,6,21.84928,0.70508,0.1318,0.94698,2.41566,1906.58357,402.5916,0.87923,0.43706,147.49516,0.44149,2665.66189,331.60097,13.75332
+"2817","YDL227C",25,108,6,23.83581,0.65399,0.12065,0.90825,2.31407,1716.24447,327.35549,0.82634,0.44297,144.88225,0.4372,2164.05451,300.38398,11.33598
+"2818","YDL227C",30,108,6,17.98714,0.66644,0.12409,0.87082,2.13643,1808.95033,359.86239,0.84564,0.50119,123.12458,0.40611,2359.5628,269.57551,13.33674
+"2819","YDL227C",37,108,6,22.12361,0.69481,0.12525,0.93585,2.21526,1815.88688,334.16209,0.87728,0.39182,122.06307,0.39113,2165.65249,275.12998,12.00375
+"2820","YDL227C",42,108,6,15.75431,0.66879,0.11821,0.8579,2.12542,1575.95518,345.21208,0.76998,0.552,99.58875,0.41914,1973.99591,246.63351,11.58332
+"2821","YDL227C",49,108,6,16.14023,0.66415,0.11352,0.78952,2.19869,1487.5676,289.18651,0.7329,0.45842,108.95246,0.35112,1882.46582,195.55191,10.37178
+"2822","YDL227C",54,108,6,10.8931,0.68413,0.12092,0.79328,1.51719,1526.04892,280.08235,0.70846,0.39341,92.30813,0.34718,1813.02276,187.20624,11.42011
+"2823","YDL227C",61,108,6,24.4742,0.66858,0.11051,0.80842,3.35036,1487.91912,258.60481,0.7268,0.42722,94.73429,0.3618,1748.82204,191.55912,10.5935
+"2824","YDL227C",66,108,6,9.80978,0.67266,0.11364,0.77522,1.55969,1514.72102,263.73194,0.70035,0.65261,85.97912,0.3228,1715.28676,124.5724,11.16401
+"2825","YDL227C",73,108,6,10.98281,0.6695,0.12075,0.80496,4.82097,1281.05022,260.15732,0.64654,0.75587,98.8256,0.38402,1665.146,114.2404,10.63186
+"2826","YDL227C",78,108,6,10.35514,0.73018,0.12703,0.81196,1.47585,1597.408,287.41506,0.73775,0.76039,98.38716,0.34901,1871.86948,142.82394,12.04417
+"2827","YDL227C",85,108,6,11.82105,0.67261,0.11436,0.86218,2.14686,1489.98797,279.79552,0.73767,0.50423,105.25996,0.30847,1783.01129,155.8424,10.87523
+"2828","YDL227C",90,108,6,5.64044,0.70001,0.11958,0.76546,2.03286,1644.41739,284.15072,0.75927,2.03251,79.11104,0.32576,1710.66165,70.03887,11.39246
+"2829","YDL227C",1,109,7,43.97307,0.80216,0.16281,3.51276,4.13311,2579.66422,545.59176,1.24915,0.42619,235.00653,0.99302,3452.57287,501.12247,17.5765
+"2830","YDL227C",6,109,7,40.13948,0.79199,0.15294,1.50622,2.86218,2328.78064,532.27802,1.15414,0.47291,211.42674,0.72599,3287.14564,476.13272,17.64315
+"2831","YDL227C",13,109,7,36.59757,0.81792,0.1569,1.62642,3.50042,2147.26838,446.38526,1.09955,0.49367,213.03522,0.7912,2892.73718,465.14441,16.63652
+"2832","YDL227C",18,109,7,47.60864,0.84083,0.16868,1.60689,4.33956,2501.73903,596.71897,1.21194,0.59081,258.34844,0.79887,4027.32854,589.30119,19.3072
+"2833","YDL227C",25,109,7,33.73821,0.78054,0.15342,1.40571,3.57332,2122.83014,481.27432,1.09254,0.96249,204.09718,0.74148,3057.80005,459.63563,15.10465
+"2834","YDL227C",30,109,7,53.61171,0.80726,0.16441,1.56445,4.91982,2261.10421,431.82539,1.14216,0.6426,192.45231,0.79681,2812.4408,431.65566,18.28998
+"2835","YDL227C",37,109,7,37.39905,0.8208,0.16337,1.5655,3.86106,2192.64338,447.77606,1.13433,0.49418,197.30738,0.75513,2990.88202,445.94371,16.89249
+"2836","YDL227C",42,109,7,39.82491,0.78939,0.15135,1.50109,3.82735,2055.16293,410.59849,1.06467,0.45851,171.91847,0.75369,2648.00846,397.92726,18.64982
+"2837","YDL227C",49,109,7,34.09711,0.81634,0.15875,1.37687,3.47519,2002.31657,421.96335,1.05066,0.50513,193.43851,0.73318,2755.89984,405.27802,15.80276
+"2838","YDL227C",54,109,7,37.48693,0.82775,0.16144,1.50496,3.3903,2052.94812,389.21231,1.06459,0.49549,165.93635,0.7495,2532.20329,362.28496,18.81042
+"2839","YDL227C",61,109,7,43.78928,0.90328,0.18038,1.57229,4.50347,2624.50742,572.27955,1.27648,0.44784,248.90425,0.85684,3749.73639,605.54893,18.8049
+"2840","YDL227C",66,109,7,59.27052,0.80442,0.16643,1.5789,4.3044,2270.71169,458.86607,1.1435,0.59558,188.25473,0.80682,2879.00832,388.31879,21.59488
+"2841","YDL227C",73,109,7,64.90008,0.9589,0.18957,1.69918,5.74065,2964.08997,724.42073,1.41358,0.58513,322.08494,0.97527,4541.05881,767.53844,23.62677
+"2842","YDL227C",78,109,7,51.77944,0.82421,0.16268,1.48538,3.6161,2353.33845,456.80433,1.161,0.52358,189.1056,0.96788,2872.73973,458.52081,17.96686
+"2843","YDL227C",85,109,7,42.85014,0.87231,0.1719,1.56693,6.23719,2532.49248,455.76337,1.26209,0.73245,184.26261,0.87993,3016.28669,483.75227,18.50176
+"2844","YDL227C",90,109,7,41.76436,0.80879,0.16878,1.45058,5.28817,2306.23521,444.98382,1.15949,0.71051,185.53324,0.75172,2940.48689,455.42667,18.50964
+"2845","YDL227C",1,110,7,39.19981,0.78526,0.15845,1.43781,4.64914,2320.2748,556.08408,1.16649,0.89537,259.22667,0.76691,3509.76551,506.41947,17.38461
+"2846","YDL227C",6,110,7,42.11859,0.76317,0.14878,1.547,5.24777,2216.04714,495.79645,1.09544,0.70464,204.31803,0.73968,3200.98249,427.03234,21.8077
+"2847","YDL227C",13,110,7,42.21056,0.78399,0.15907,1.55361,3.60662,2164.31989,486.52122,1.15252,0.44449,210.00539,0.74344,3111.55119,434.5548,21.02897
+"2848","YDL227C",18,110,7,41.09967,0.89081,0.17565,1.66667,3.99106,2838.81427,688.65041,1.31728,0.54007,294.40613,0.86489,4514.87835,683.9928,20.9277
+"2849","YDL227C",25,110,7,67.61906,0.88719,0.18497,1.69772,5.36385,2710.28026,624.10238,1.36437,0.53774,273.38965,0.94627,3969.15279,613.6553,28.90456
+"2850","YDL227C",30,110,7,40.53937,0.84917,0.16938,1.60973,5.76825,2675.84916,581.02481,1.25645,0.92917,243.83535,0.88728,3914.60243,600.32264,18.74606
+"2851","YDL227C",37,110,7,39.30833,0.78272,0.1614,1.3662,4.2522,2107.76309,432.81141,1.09852,0.54564,181.7748,0.74029,2717.25211,378.24149,19.45777
+"2852","YDL227C",42,110,7,37.24048,0.87193,0.17628,1.7323,3.94228,2539.08076,521.76254,1.53671,0.46946,203.65519,0.81494,3314.83844,496.01476,17.98149
+"2853","YDL227C",49,110,7,35.46303,0.87914,0.17547,1.4909,3.40067,2410.4356,496.24002,1.21051,0.50361,207.3658,0.87365,3274.87715,443.61903,17.78644
+"2854","YDL227C",54,110,7,42.4634,0.82187,0.16149,1.49578,6.30725,2086.80189,441.10117,1.11329,0.89962,172.31978,0.77005,2784.58773,392.63624,17.25383
+"2855","YDL227C",61,110,7,36.04568,0.83298,0.16587,1.45516,4.78701,2283.09964,457.79794,1.14043,0.55872,193.2098,0.80051,2891.55937,414.21142,17.18815
+"2856","YDL227C",66,110,7,40.96845,0.84979,0.17548,1.60224,4.96034,2401.35328,538.16121,1.15949,0.76143,218.29029,0.83338,3498.88836,472.91427,18.71357
+"2857","YDL227C",73,110,7,103.59123,0.88864,0.18704,1.68427,5.38358,2700.88796,630.65941,1.44117,0.74283,269.95096,1.09903,4064.86214,589.37962,35.37293
+"2858","YDL227C",78,110,7,39.329,0.84079,0.16715,1.53722,5.26496,2384.77645,477.5718,1.14318,0.68307,197.50962,0.80914,3163.76283,453.91952,17.96007
+"2859","YDL227C",85,110,7,75.57357,0.93335,0.18037,1.73126,6.8166,2826.1103,661.45763,1.43324,0.62182,261.89145,0.94422,4207.24765,629.57582,28.64901
+"2860","YDL227C",90,110,7,56.16862,0.82898,0.16447,1.50593,4.17263,2361.24772,497.69309,1.17053,0.49135,196.93948,0.82744,3117.91727,499.36977,23.58383
+"2861","YDL227C",1,111,7,46.99408,0.77426,0.15346,1.4972,16.88329,2498.78846,525.96326,1.23455,0.5355,220.98129,0.77935,3392.43654,507.84028,18.83599
+"2862","YDL227C",6,111,7,38.96231,0.83674,0.15849,1.48825,3.01054,2367.69763,481.69024,1.16981,0.49532,198.9182,0.69461,3012.32402,463.48802,18.76386
+"2863","YDL227C",13,111,7,39.07299,0.76424,0.14711,2.63857,3.10287,2140.58756,439.95915,1.1461,0.5102,196.62153,0.71183,2859.88233,434.99187,18.11579
+"2864","YDL227C",18,111,7,42.07344,0.8118,0.16304,1.51874,8.23629,2491.64031,573.74217,1.2396,0.47568,247.33059,2.5881,3675.71986,588.61588,19.15026
+"2865","YDL227C",25,111,7,48.40054,0.85632,0.1657,1.52669,4.38023,2727.65556,589.20266,1.49658,0.57776,250.41986,0.91367,3932.67453,644.80495,20.41638
+"2866","YDL227C",30,111,7,34.93762,0.77599,0.15602,1.45683,3.84526,2244.80899,441.44101,1.13014,0.49357,186.07464,0.68092,2949.96379,382.92799,17.30916
+"2867","YDL227C",37,111,7,35.99852,0.7401,0.1487,1.39952,4.49352,1993.45238,382.70097,1.22613,0.64122,184.60214,0.76319,2581.3324,428.14717,16.67393
+"2868","YDL227C",42,111,7,37.6317,0.76915,0.14728,1.34155,2.93841,2004.10865,382.97022,1.0604,0.48091,166.40478,0.65403,2583.53519,413.58989,18.01448
+"2869","YDL227C",49,111,7,35.15093,0.77891,0.1518,1.33116,3.98559,1998.69984,378.71834,1.04521,0.6432,163.14479,0.75048,2492.20694,344.30364,17.17445
+"2870","YDL227C",54,111,7,39.93899,0.77348,0.15426,1.37663,2.93545,2059.91747,423.37032,1.08337,0.48148,184.88125,0.70781,2763.16242,396.83716,21.31008
+"2871","YDL227C",61,111,7,33.7578,0.76802,0.15639,1.41111,6.04602,2167.21291,452.46765,1.13117,1.15472,184.81923,0.76244,2840.18121,437.26721,16.82081
+"2872","YDL227C",66,111,7,38.12217,0.83113,0.16596,1.52912,25.17782,2389.41283,534.38258,1.19072,1.25665,220.38806,1.36201,3508.9637,539.86305,19.07789
+"2873","YDL227C",73,111,7,32.95967,0.78196,0.15599,1.42396,4.57781,2164.97479,442.83745,1.09779,0.61938,202.65695,0.78234,2902.86348,428.79589,15.71522
+"2874","YDL227C",78,111,7,32.64775,0.76728,0.15379,1.35126,4.72654,2125.15882,422.91169,1.08323,0.53327,169.90081,0.72267,2678.80874,383.02769,17.18737
+"2875","YDL227C",85,111,7,40.52839,0.78935,0.15488,1.3858,4.88387,2149.53297,421.61527,1.1254,0.59423,185.7871,0.88839,2701.65983,452.78451,17.38387
+"2876","YDL227C",90,111,7,34.94001,0.78822,0.1585,1.39208,6.03565,2239.56924,500.91724,1.13258,0.56738,204.23072,0.79064,3309.77961,537.76156,17.38583
+"2877","YDL227C",1,112,8,79.95928,0.59866,0.164,1.6496,11.05948,2501.12923,431.14849,1.22644,0.56977,167.7756,1.6326,3071.1617,441.68163,19.0199
+"2878","YDL227C",6,112,8,49.43739,0.58717,0.1637,1.78979,7.17545,2308.10074,381.09735,1.11698,0.59491,155.59162,1.49143,2793.57173,395.24476,16.8355
+"2879","YDL227C",13,112,8,50.12198,0.59938,0.1663,1.5158,7.30983,2283.13691,391.83555,1.09457,0.44996,158.98003,1.56778,2928.30262,395.16298,17.36013
+"2880","YDL227C",18,112,8,43.14854,0.58473,0.15916,1.47135,7.23051,2184.08197,342.52277,1.06542,0.61516,135.67557,1.16118,2633.46772,373.71948,16.07361
+"2881","YDL227C",25,112,8,47.09956,0.60932,0.16852,1.46557,7.11006,2382.91899,379.08041,1.13805,0.6099,146.66713,1.15963,2933.8135,369.04203,16.97892
+"2882","YDL227C",30,112,8,58.35841,0.60328,0.16171,1.59876,7.72663,2218.59104,351.54616,1.0842,0.70764,138.08456,1.40999,2670.39059,362.50379,17.09035
+"2883","YDL227C",37,112,8,42.9143,0.59449,0.15708,1.36177,6.90829,2215.93124,345.12925,1.09208,0.46733,141.59738,1.15587,2681.84662,332.92463,16.50239
+"2884","YDL227C",42,112,8,52.74939,0.59401,0.17218,1.59842,8.81444,2264.68561,362.78737,1.09418,0.57369,141.95364,1.73811,2753.36849,381.93361,16.8763
+"2885","YDL227C",49,112,8,44.3512,0.60051,0.15849,1.9544,6.78816,2313.75513,346.17398,1.11105,0.50488,130.15488,1.09175,2679.9931,316.30125,16.23663
+"2886","YDL227C",54,112,8,43.55896,0.58405,0.15487,23.7003,12.25119,2128.34561,337.19909,1.05405,1.75736,133.47075,1.21877,2566.02688,359.91608,31.93004
+"2887","YDL227C",61,112,8,42.03546,0.5896,0.15625,1.40456,6.04977,2207.21539,330.15841,1.06701,0.5202,129.00781,1.27577,2537.38166,305.64166,16.13718
+"2888","YDL227C",66,112,8,41.51499,0.58374,0.15744,1.51385,7.25169,2104.24043,322.45156,1.02904,0.63553,131.44879,1.13924,2454.34561,330.90661,15.88336
+"2889","YDL227C",73,112,8,60.29773,0.64853,0.17086,1.52648,7.77559,2567.77286,414.45632,1.23706,0.48855,160.13485,1.34718,3235.4881,416.78547,19.61348
+"2890","YDL227C",78,112,8,38.77538,0.58977,0.15601,1.42406,7.4958,2215.49798,322.05871,1.07766,0.64643,124.25648,1.07657,2426.17705,334.52274,16.08736
+"2891","YDL227C",85,112,8,67.09209,0.66431,0.18861,1.59828,7.948,2584.22788,428.80353,1.23949,0.50086,163.31507,1.48972,3292.13592,431.91637,19.61094
+"2892","YDL227C",90,112,8,47.41086,0.59419,0.15339,1.41843,6.99179,2250.77481,321.21814,1.08635,0.51189,124.14327,1.10372,2440.03533,306.47581,17.25469
+"2893","YDL227C",1,113,8,53.04247,0.60119,0.15493,1.42245,8.75239,2592.4541,405.42031,1.18899,0.50306,152.8335,1.10317,2956.4452,445.91896,16.21769
+"2894","YDL227C",6,113,8,77.63397,0.65929,0.16454,1.55156,7.25897,2531.90921,469.34826,1.27301,0.53478,186.37675,1.18757,3513.82525,517.4852,21.07474
+"2895","YDL227C",13,113,8,38.93447,0.59946,0.16713,1.41604,6.14564,2245.17651,389.17917,1.12886,0.54809,158.26835,1.0654,2906.48706,383.11709,15.80003
+"2896","YDL227C",18,113,8,74.79981,0.58519,0.15768,1.37823,7.47685,2227.0922,357.20646,1.12759,0.60682,144.27075,1.03095,2776.33362,410.65949,19.66674
+"2897","YDL227C",25,113,8,33.18198,0.56655,0.15302,1.42266,10.18731,2165.77299,320.96754,1.11134,0.77824,131.29519,0.98588,2513.97793,327.22874,16.23716
+"2898","YDL227C",30,113,8,37.3243,0.59391,0.15569,1.36605,7.58449,2218.67543,368.32727,1.14036,0.77247,147.67907,0.9912,2829.03933,373.85651,16.45966
+"2899","YDL227C",37,113,8,39.19028,0.57694,0.15705,1.39848,12.43409,2169.32935,342.36395,1.13518,0.60202,141.38046,1.16481,2655.08027,332.51306,16.05451
+"2900","YDL227C",42,113,8,42.46498,0.61103,0.16666,1.43798,6.71528,2291.72693,381.03306,1.18991,0.48842,158.60425,1.12755,2938.23366,409.47809,16.85016
+"2901","YDL227C",49,113,8,36.64034,0.57323,0.15692,1.39858,7.0075,2158.64947,332.46692,1.10176,0.52203,134.86972,1.13434,2567.52034,351.27393,15.74591
+"2902","YDL227C",54,113,8,34.68611,0.59075,0.15413,1.36784,7.30465,2194.97315,341.26388,1.10751,0.65555,133.98198,1.06093,2599.59469,361.99058,15.9963
+"2903","YDL227C",61,113,8,37.84514,0.59157,0.15695,1.35477,6.43825,2071.57854,327.75868,1.06663,0.5021,140.32136,1.08627,2477.29709,293.82716,15.51258
+"2904","YDL227C",66,113,8,40.0216,0.57924,0.15335,1.32601,6.16235,2141.03114,325.5031,1.07809,0.54769,133.91564,1.01196,2501.65033,335.16985,16.22586
+"2905","YDL227C",73,113,8,38.39257,0.66408,0.16122,1.59481,10.53459,2544.81651,438.03228,1.26851,0.5731,169.90978,1.23021,3430.24202,458.41976,17.10061
+"2906","YDL227C",78,113,8,47.51023,0.57266,0.14888,1.29167,20.2165,2129.04129,309.40384,1.06811,0.50598,121.79935,1.28311,2429.17077,298.41819,15.54162
+"2907","YDL227C",85,113,8,41.31981,0.6201,0.15798,1.46033,11.46684,2396.9827,359.25006,1.19846,0.52351,143.68184,1.24708,2807.59218,367.16281,17.45073
+"2908","YDL227C",90,113,8,63.75472,0.56824,0.15247,1.67536,7.85272,2150.90886,311.06223,1.09768,0.57972,127.62959,1.76386,2429.3233,307.32318,16.21646
+"2909","YDL227C",1,114,8,44.56479,0.57666,0.14976,1.39956,7.78195,2255.82641,392.15635,1.11912,0.48936,162.62644,1.09254,2828.77541,402.60943,15.62833
+"2910","YDL227C",6,114,8,84.73336,0.54876,0.14281,1.36757,6.85393,2102.87539,364.35988,1.05247,0.96713,151.63752,1.10852,2734.0022,369.07959,20.14479
+"2911","YDL227C",13,114,8,31.71439,0.5286,0.13595,1.21838,6.05961,2080.19376,316.0731,1.0131,0.48611,121.94396,2.25973,2393.00885,320.02981,14.41653
+"2912","YDL227C",18,114,8,40.69115,0.56121,0.14316,1.29586,9.21921,2117.25225,328.2239,1.05241,0.47245,131.08417,0.95474,2533.35204,328.86477,15.58386
+"2913","YDL227C",25,114,8,30.70055,0.54104,0.14154,3.18462,5.52517,2150.04303,297.95915,0.99194,0.51859,109.05881,0.86076,2309.88059,267.20451,15.16719
+"2914","YDL227C",30,114,8,35.40839,0.536,0.14281,1.31239,5.09808,2013.62085,303.00852,1.01032,0.47583,119.92199,0.85168,2342.9591,295.82124,14.79461
+"2915","YDL227C",37,114,8,37.23705,0.54123,0.14399,1.33019,10.49371,2065.15302,320.17448,1.00528,0.47513,127.84052,0.84599,2441.85246,310.4744,15.1297
+"2916","YDL227C",42,114,8,33.81598,0.55693,0.14663,1.39696,4.96217,2194.19015,337.70396,1.06717,0.47513,129.78611,1.04512,2575.99314,353.47977,15.4866
+"2917","YDL227C",49,114,8,33.00645,0.55434,0.1398,1.23012,14.83797,2009.58499,313.32978,1.00139,0.52286,125.28263,0.82464,2414.25003,306.33271,14.46683
+"2918","YDL227C",54,114,8,39.47489,0.61688,0.15518,1.40109,4.82988,2341.10611,351.14716,1.133,0.53062,132.33579,1.02683,2772.4711,407.50448,17.54498
+"2919","YDL227C",61,114,8,35.98835,0.53714,0.14123,1.35205,11.38222,2040.27071,285.45373,1.00764,0.50049,110.93137,3.51468,2214.55154,260.8627,14.84897
+"2920","YDL227C",66,114,8,39.22325,0.55575,0.14536,1.34995,3.85469,2063.08281,309.28948,1.04534,0.52573,125.11009,0.92774,2350.47399,322.90962,16.44333
+"2921","YDL227C",73,114,8,36.24195,0.55228,0.14896,1.41003,8.71981,2128.19973,317.25477,1.06841,0.50194,131.17411,1.13401,2452.13027,310.12961,15.32527
+"2922","YDL227C",78,114,8,33.67787,0.55017,0.1432,1.33719,14.27633,2141.52112,311.00275,1.06002,0.43827,124.25405,2.26601,2457.67048,323.28753,15.39203
+"2923","YDL227C",85,114,8,43.03727,0.57214,0.15123,1.41331,52.90632,2115.47401,313.1264,1.14974,0.49308,128.75783,0.98797,2440.35974,320.49633,15.76145
+"2924","YDL227C",90,114,8,40.60191,0.5932,0.1539,1.41419,6.23484,2232.96464,314.7876,1.18592,0.61765,122.36009,0.96312,2440.60559,318.58394,16.64005
+"2925","YDL227C",1,115,9,39.11736,0.75292,0.18731,1.79369,7.14155,2906.12231,544.20966,1.45002,0.61956,280.91016,1.39278,3465.34835,499.00169,15.73953
+"2926","YDL227C",6,115,9,67.44419,0.76871,0.19505,2.20992,9.83028,2958.93507,550.73243,1.60802,0.69874,286.85058,2.90459,3512.42432,571.1357,21.22727
+"2927","YDL227C",13,115,9,29.66369,0.77725,0.19166,1.71391,6.25787,2801.80488,490.2234,1.37124,0.5694,243.15542,1.25921,3107.26537,488.36697,15.07533
+"2928","YDL227C",18,115,9,45.62021,0.75623,0.19049,1.85552,9.5811,2624.30004,469.75594,1.32955,0.96211,243.6188,1.35274,2985.17738,461.23923,18.47137
+"2929","YDL227C",25,115,9,30.79417,0.77407,0.18682,1.80302,8.31517,2750.1365,472.42835,1.34423,0.58704,229.25862,1.16001,3004.3311,424.65882,15.2097
+"2930","YDL227C",30,115,9,56.96285,0.75661,0.18896,2.18406,8.36135,2429.60241,422.91709,1.27455,1.02764,235.43416,2.95259,2668.13832,391.3406,20.54141
+"2931","YDL227C",37,115,9,48.70412,0.81051,0.19427,1.87644,7.29193,2892.44314,483.17338,1.45667,0.91811,343.86168,1.2746,2878.4067,1233.56945,15.69173
+"2932","YDL227C",42,115,9,27.45189,0.77216,0.18121,1.59254,5.48166,2471.56665,397.99665,1.20343,0.58341,201.34904,1.13431,2537.77232,331.95021,15.00329
+"2933","YDL227C",49,115,9,28.07851,0.80548,0.19172,1.75769,7.23642,2774.74427,449.54176,1.36017,1.51602,218.95127,1.19864,2889.6207,401.82816,15.64609
+"2934","YDL227C",54,115,9,29.09103,0.78819,0.18997,1.71604,8.21323,2592.38568,392.34215,1.24545,0.76256,183.98426,1.20964,2418.5825,285.21844,15.89162
+"2935","YDL227C",61,115,9,26.12319,0.79544,0.18855,1.80726,7.74173,2594.98267,379.79703,1.26758,0.60989,179.7829,1.14462,2375.65656,288.53479,15.37113
+"2936","YDL227C",66,115,9,25.29619,0.80668,0.19273,1.75131,5.76298,2607.25018,405.18571,1.25954,0.60159,195.66415,1.16698,2508.44668,330.03692,15.95195
+"2937","YDL227C",73,115,9,35.63446,0.83041,0.20107,1.86899,8.10263,3002.0116,504.53111,1.42605,0.66661,244.26959,1.25475,3346.10473,511.9755,16.57104
+"2938","YDL227C",78,115,9,29.13775,0.79018,0.19315,1.72814,6.31443,2815.50363,468.44875,1.3409,1.08088,234.30405,1.16903,2905.04852,474.58789,15.53581
+"2939","YDL227C",85,115,9,48.02943,0.77951,0.19367,2.32901,10.22385,3146.79174,509.29343,1.45619,0.58217,251.42729,1.71369,3297.88654,562.44692,16.79557
+"2940","YDL227C",90,115,9,46.88071,0.84122,0.20356,2.19574,7.34546,3410.45904,622.4077,1.55798,0.59495,294.98152,1.40614,3905.85224,704.67887,18.63303
+"2941","YDL227C",1,116,9,89.50095,0.79405,0.19339,2.78668,11.2121,3276.64789,539.29082,1.61307,0.8877,248.70578,2.81327,3510.95511,503.00469,19.26276
+"2942","YDL227C",6,116,9,84.48516,0.82013,0.20331,2.10087,7.08699,3274.38836,597.18552,1.58522,0.59556,257.54216,1.35059,3810.72426,562.5039,29.21928
+"2943","YDL227C",13,116,9,38.34575,0.75805,0.18231,1.89947,5.75849,2801.95841,475.67045,1.47834,0.4657,232.05895,1.66176,3177.65737,461.28719,16.10444
+"2944","YDL227C",18,116,9,50.56385,0.82684,0.19564,3.0392,6.74645,3031.5393,489.73413,1.45613,0.72803,226.24243,1.4201,3104.38366,468.17675,17.8565
+"2945","YDL227C",25,116,9,36.23593,0.74666,0.1828,1.91507,6.23597,2800.46829,435.14549,1.34519,0.49126,203.11364,1.3013,2763.57341,379.72201,15.25433
+"2946","YDL227C",30,116,9,31.58275,0.796,0.18987,1.95756,5.62742,2841.34052,429.08793,1.33352,0.5309,193.84456,1.45853,2747.69207,382.10117,16.51827
+"2947","YDL227C",37,116,9,31.08568,0.8042,0.19081,2.34958,7.356,2914.46087,450.27425,1.4093,0.74267,213.44825,1.75547,3072.67931,425.87774,16.47996
+"2948","YDL227C",42,116,9,32.18541,0.77546,0.18572,1.58729,4.25198,2631.16153,397.80361,1.27079,0.46283,173.65567,1.04521,2459.7908,277.76959,15.66569
+"2949","YDL227C",49,116,9,32.30555,0.7755,0.18152,2.06368,6.79791,2743.30987,405.64014,1.33042,0.7994,187.41874,1.34886,2694.70299,350.67516,15.70528
+"2950","YDL227C",54,116,9,25.94914,0.75802,0.17765,1.88637,4.99902,2474.02865,369.98906,1.21943,0.53943,168.3922,1.46488,2320.98924,262.60098,15.24102
+"2951","YDL227C",61,116,9,22.51945,0.82978,0.18915,2.11988,6.76687,2736.51469,373.80729,1.32241,0.61087,169.24444,1.25528,2448.25342,256.26683,15.08257
+"2952","YDL227C",66,116,9,27.33418,0.79089,0.18881,1.88891,5.70168,2650.29712,396.47413,1.30642,0.5673,175.21057,2.10074,2477.56801,322.99533,16.42362
+"2953","YDL227C",73,116,9,31.57294,0.83371,0.19476,1.87661,7.15428,3085.90976,491.99155,1.43977,0.58706,217.74805,1.67433,3122.92376,448.70028,15.9105
+"2954","YDL227C",78,116,9,31.5256,0.76719,0.19297,1.85925,7.43389,2957.82911,477.59831,1.35978,0.57756,210.87292,1.52188,2989.72785,472.32389,16.27778
+"2955","YDL227C",85,116,9,35.23553,0.83046,0.20197,1.99949,6.42722,3247.25673,537.32618,1.5072,0.50912,274.89867,1.55585,3407.91928,593.2987,16.96878
+"2956","YDL227C",90,116,9,44.96161,0.83431,0.19589,2.59529,7.72933,3478.38001,590.79194,1.58781,0.68408,263.54178,2.13318,3927.58246,662.19264,18.68123
+"2957","YDL227C",1,117,9,45.33797,0.7965,0.19944,1.83585,6.0628,3148.89938,553.14954,1.55669,0.50719,265.31801,1.42369,3654.41605,499.05313,17.74595
+"2958","YDL227C",6,117,9,34.63511,0.74396,0.18166,1.74775,5.08917,2834.95356,520.79192,1.39831,0.4741,246.07522,1.12037,3375.86068,491.18186,17.38863
+"2959","YDL227C",13,117,9,35.16922,0.80287,0.19409,1.83888,4.9252,3074.01914,499.15747,1.47212,0.55373,217.80821,1.18941,3112.75914,482.46202,16.18341
+"2960","YDL227C",18,117,9,27.07761,0.75773,0.18415,1.8541,5.14014,2747.32345,470.83557,1.3466,0.55909,218.4134,1.76701,3013.53696,415.36703,15.36104
+"2961","YDL227C",25,117,9,28.48034,0.77066,0.1889,1.74393,5.08901,2824.83835,450.80921,1.36595,0.51425,214.1051,1.13586,2874.17472,410.89093,15.06063
+"2962","YDL227C",30,117,9,24.18206,0.73107,0.17778,1.65158,5.31243,2574.85168,409.61569,1.24866,0.50049,187.3439,1.20923,2623.68611,358.36959,14.62982
+"2963","YDL227C",37,117,9,23.77785,0.7944,0.18148,1.68042,4.4581,2785.18657,424.00557,1.29294,0.56266,185.8477,1.03492,2602.62653,353.42359,14.36194
+"2964","YDL227C",42,117,9,25.68219,0.76641,0.17997,1.64168,3.45042,2639.74075,409.22225,1.26447,0.49857,191.45668,0.98354,2623.93487,378.23481,16.05301
+"2965","YDL227C",49,117,9,29.91034,0.79057,0.18548,1.91475,4.90898,2658.09285,422.39951,1.31738,1.92919,205.16844,1.22586,2643.70404,347.48976,14.94254
+"2966","YDL227C",54,117,9,21.44375,0.7568,0.17524,1.55363,3.33377,2329.40031,362.82331,1.13343,0.57658,160.21072,0.88739,2296.96899,240.35267,17.28232
+"2967","YDL227C",61,117,9,23.94699,0.78702,0.18032,1.68086,5.58419,2528.68485,373.1674,1.22547,0.68445,170.66943,1.0739,2421.49652,244.67738,15.16851
+"2968","YDL227C",66,117,9,22.91374,0.78512,0.18126,1.72578,6.48234,2667.05451,403.05267,1.31977,0.46845,173.22719,1.0262,2589.65114,329.78529,15.43588
+"2969","YDL227C",73,117,9,30.8161,0.79854,0.19023,1.93489,7.30024,3073.65894,454.40813,1.45005,0.50192,212.36657,1.17861,3001.72417,433.04729,15.47938
+"2970","YDL227C",78,117,9,28.92491,0.77597,0.1878,2.73855,4.57423,3087.62251,487.72778,1.44419,0.47362,206.71677,1.01679,3124.41255,474.88012,16.40598
+"2971","YDL227C",85,117,9,41.18907,0.7977,0.1923,1.97641,6.16626,3384.96849,526.23454,1.54028,0.47763,240.3019,1.26932,3440.55329,591.0274,17.31372
+"2972","YDL227C",90,117,9,43.24108,0.84248,0.20039,2.34676,6.98355,3558.16838,561.50943,1.58236,0.49417,245.70375,1.27144,3680.15792,645.63313,16.74391
+"2973","YDL227C",1,118,10,54.27972,0.84352,0.19086,8.32415,15.88768,3116.39933,616.02935,1.83854,0.68212,192.03619,16.6271,4160.05041,388.18342,22.0563
+"2974","YDL227C",6,118,10,18.89052,0.73106,0.18247,2.1319,7.53372,2559.04897,444.87759,1.29389,0.62279,144.89356,2.97715,3124.40752,328.1155,15.31868
+"2975","YDL227C",13,118,10,27.75005,0.71622,0.186,5.22303,14.09385,2467.34348,420.21716,1.36563,1.19021,129.26516,7.50048,2944.88493,283.22598,18.71038
+"2976","YDL227C",18,118,10,17.37193,0.72636,0.18136,1.58375,7.36293,2522.37508,406.64258,1.18852,0.86555,119.53665,1.54276,2969.25764,282.13919,15.2592
+"2977","YDL227C",25,118,10,38.62187,0.75575,0.19712,14.02431,22.20895,2605.76302,432.93138,1.88216,0.73962,144.9187,23.39774,3391.87853,340.06809,23.29144
+"2978","YDL227C",30,118,10,18.86976,0.69675,0.17922,1.65829,7.84298,2448.3578,403.65291,1.22612,0.91215,130.19295,2.27645,2880.05058,312.25856,15.37562
+"2979","YDL227C",37,118,10,42.82662,0.71403,0.1975,9.71987,20.83335,2543.55402,407.45979,1.88724,0.5095,132.16347,24.08081,2978.11174,299.79699,20.81431
+"2980","YDL227C",42,118,10,22.50395,0.72075,0.1815,1.59593,6.60215,2445.06773,394.46336,1.20995,0.54782,132.1103,1.36909,3029.26644,310.32661,16.56223
+"2981","YDL227C",49,118,10,24.58966,0.69168,0.18064,4.29537,8.01955,2186.07122,358.8186,1.24327,0.47121,135.51386,5.26128,2751.4579,272.83507,15.49772
+"2982","YDL227C",54,118,10,17.54432,0.71329,0.18732,1.64928,6.88113,2383.85108,395.80739,1.17441,0.56745,132.211,2.02256,2997.08796,286.57851,15.71754
+"2983","YDL227C",61,118,10,19.57376,0.70323,0.17219,2.35528,7.18016,2239.85435,333.08679,1.15184,0.74101,115.84164,3.26671,2641.60826,247.2585,14.50628
+"2984","YDL227C",66,118,10,21.31777,0.7504,0.18759,1.81608,7.96648,2530.24865,402.18674,1.23213,0.52122,131.51172,2.51821,3188.0206,322.5587,16.19422
+"2985","YDL227C",73,118,10,24.01724,0.73808,0.18299,2.24176,6.43913,2393.91752,380.99553,1.26989,0.4472,122.61968,3.44457,2806.05777,240.22498,16.215
+"2986","YDL227C",78,118,10,21.68753,0.73044,0.18347,4.14034,12.25681,2316.55153,369.23102,1.58182,0.71183,132.26696,15.84829,2801.90253,261.20731,16.70984
+"2987","YDL227C",85,118,10,27.94366,0.68236,0.17791,2.00013,7.71069,2227.1292,338.129,1.17363,0.50761,115.57151,3.08616,2601.66526,236.04268,16.43173
+"2988","YDL227C",90,118,10,16.5128,0.77434,0.1813,2.22361,6.67524,2563.31456,378.84556,1.25434,0.94804,124.80829,2.55466,3016.84693,295.66798,15.90008
+"2989","YDL227C",1,119,10,62.12475,0.7458,0.18524,2.43846,6.72037,2675.90629,512.86832,1.37565,0.48802,188.87613,2.75726,3427.57389,350.92234,19.32149
+"2990","YDL227C",6,119,10,21.18302,0.75238,0.18676,2.35769,7.37732,2670.7893,462.2598,1.3546,0.72559,140.71953,3.52123,3256.91638,280.31882,16.7395
+"2991","YDL227C",13,119,10,16.1669,0.68482,0.17897,1.75974,8.94025,1969.37898,415.61126,1.10946,0.85385,154.35152,1.78012,2811.32851,241.01191,14.48315
+"2992","YDL227C",18,119,10,14.44255,0.71904,0.17736,1.7388,6.74473,2433.19404,385.35252,1.19057,0.62858,131.88679,1.60983,2958.6181,280.17386,14.73186
+"2993","YDL227C",25,119,10,17.3433,0.71315,0.1836,1.87773,6.16498,2268.25116,397.12139,1.16745,0.4471,138.09766,1.61775,2926.14398,237.74624,14.85998
+"2994","YDL227C",30,119,10,13.98778,0.67396,0.17351,1.97996,6.56158,2361.8792,378.6619,1.14928,0.62847,119.20058,1.4832,2907.17685,221.41517,13.73207
+"2995","YDL227C",37,119,10,26.40311,0.76695,0.19085,1.989,6.41815,2741.42445,457.33252,1.33369,0.47304,157.9902,2.12777,3436.96691,331.13317,15.8605
+"2996","YDL227C",42,119,10,18.62562,0.72968,0.1855,3.15748,9.02115,2580.84153,424.35057,1.27325,0.63938,137.37692,2.53676,3194.93749,301.89874,15.84819
+"2997","YDL227C",49,119,10,28.25491,0.75737,0.18935,1.74828,5.71073,2544.73447,396.47698,1.26015,0.56919,145.35763,1.27053,2908.85753,368.72797,15.48869
+"2998","YDL227C",54,119,10,18.13124,0.76322,0.18873,2.46399,7.49965,2463.75449,423.11467,1.2198,0.93025,145.02628,2.34462,3241.45743,309.35267,16.30993
+"2999","YDL227C",61,119,10,17.96088,0.71847,0.18111,1.59936,4.86373,2297.19016,358.94331,1.14755,0.42263,122.88608,1.22905,2725.77544,217.19145,14.32255
+"3000","YDL227C",66,119,10,15.85679,0.70025,0.18044,1.52529,5.26967,2236.2422,339.02751,1.06342,0.643,110.78998,1.11044,2591.86667,217.13112,14.61621
+"3001","YDL227C",73,119,10,14.8366,0.73582,0.17955,1.65616,6.20225,2440.53068,374.9253,1.21545,0.66435,119.55187,1.3584,2851.86513,207.41584,14.70439
+"3002","YDL227C",78,119,10,15.12714,0.72995,0.18088,1.52861,4.99648,2419.96138,360.62453,1.1637,0.49405,113.61517,1.07928,2814.05047,227.09342,14.66773
+"3003","YDL227C",85,119,10,40.44646,0.72475,0.1811,2.37318,6.78142,2340.18204,362.20052,1.27808,0.4957,132.3448,2.45255,2747.6746,202.0685,23.13825
+"3004","YDL227C",90,119,10,21.54417,0.75243,0.18139,1.73625,8.17268,2461.3407,386.26285,1.19209,1.75372,130.27559,1.25405,2994.37446,237.50336,15.36339
+"3005","YDL227C",1,120,10,29.34107,0.80513,0.18684,1.79461,6.0358,2761.33526,573.67422,1.37131,0.67204,209.75939,1.36362,3797.01304,414.06356,16.27527
+"3006","YDL227C",6,120,10,25.93621,0.72323,0.18201,1.64983,5.13215,2476.73455,447.70604,1.21255,0.51021,145.66913,1.06886,3149.82255,278.02086,16.2165
+"3007","YDL227C",13,120,10,12.72234,0.69532,0.17914,1.46206,3.71659,2329.72215,401.26287,1.18992,0.56796,126.45001,0.9691,2867.69539,220.43463,14.35171
+"3008","YDL227C",18,120,10,16.57777,0.73516,0.18767,1.57151,3.71664,2354.36681,420.51439,1.15577,0.46128,144.48061,1.02238,3044.69158,283.67423,17.2292
+"3009","YDL227C",25,120,10,15.84051,0.71562,0.18193,1.61413,5.19485,2466.82012,390.85114,1.21768,0.76155,125.38631,1.19219,2857.35422,237.56512,14.75491
+"3010","YDL227C",30,120,10,17.65387,0.69733,0.17685,1.50427,3.88183,2186.64891,375.91819,1.08894,0.43734,129.28165,0.9877,2856.52814,277.40609,14.73301
+"3011","YDL227C",37,120,10,25.39077,0.75709,0.18908,2.06842,6.75738,2635.65211,455.87724,1.3436,0.46324,155.1638,1.92192,3409.87357,342.58201,15.9256
+"3012","YDL227C",42,120,10,19.01424,0.72698,0.18543,1.49208,2.97271,2365.96789,394.68771,1.15365,0.42838,125.3919,0.95361,2823.4055,237.76728,14.76902
+"3013","YDL227C",49,120,10,15.95529,0.70974,0.17958,2.47036,5.50266,2273.77087,386.46751,1.18325,0.53938,128.9994,1.67987,2853.78676,252.25202,14.76962
+"3014","YDL227C",54,120,10,16.46068,0.69558,0.17446,1.44838,3.20013,2160.16941,362.295,1.09661,0.44925,116.92484,0.93583,2714.62436,219.30508,14.16947
+"3015","YDL227C",61,120,10,14.16008,0.72089,0.17832,1.75629,5.53888,2393.2865,351.99879,1.19257,0.45189,107.79367,1.28875,2765.72984,233.99429,15.01945
+"3016","YDL227C",66,120,10,11.51156,0.69635,0.1743,1.44695,2.83625,2064.3234,330.36324,1.04559,0.3963,118.9186,0.91632,2512.34265,209.25414,13.73713
+"3017","YDL227C",73,120,10,34.81529,0.71865,0.18304,2.01328,5.98504,2340.07659,346.92168,1.19248,0.48219,116.15355,2.002,2706.38157,191.61681,15.88299
+"3018","YDL227C",78,120,10,11.9636,0.71515,0.17263,1.42684,2.93634,2230.09483,366.92736,1.08394,0.41026,120.40708,0.9922,2707.43583,213.45557,14.10425
+"3019","YDL227C",85,120,10,16.13743,0.74,0.1819,1.77193,5.01282,2351.45376,360.01362,1.19402,0.63027,122.69613,1.38946,2787.52364,211.57512,14.90691
+"3020","YDL227C",90,120,10,12.7913,0.75329,0.17852,1.61502,3.42081,2399.49012,392.39618,1.18002,0.48174,131.96362,1.07361,3084.16009,256.0801,15.33772
+"4158","YDR049W",5,110,7,30.47008,0.90732,0.1714,1.45014,4.74579,2248.2892,468.31414,0.9487,0.57955,217.98639,0.73531,3065.36744,513.93099,18.01936
+"4159","YDR049W",17,110,7,31.40696,0.94856,0.17881,1.61697,4.12459,2366.34525,561.79366,1.01107,0.88268,262.50038,0.77479,3714.75348,578.19532,19.08946
+"4160","YDR049W",29,110,7,26.33517,0.89578,0.17032,1.48311,4.79016,2153.30333,442.93794,0.93084,0.41475,210.83375,0.74855,2921.04856,489.40035,16.56462
+"4161","YDR049W",41,110,7,23.39102,0.87,0.16774,1.42094,3.90921,1983.90512,393.44056,0.94719,0.46526,173.03268,0.68862,2504.56412,347.15803,16.20123
+"4162","YDR049W",53,110,7,24.21401,0.89901,0.17058,1.38835,3.77091,1952.46413,384.98645,0.89278,0.40999,185.2851,0.74449,2508.63096,350.86565,16.17487
+"4163","YDR049W",65,110,7,28.69975,0.90049,0.17445,1.46097,4.52777,2129.50352,463.46118,0.92527,0.44756,215.1355,0.78372,2813.65693,463.06545,16.94652
+"4164","YDR049W",77,110,7,32.11576,0.97153,0.18773,1.58953,5.90776,2480.0823,542.54295,1.07065,0.46093,239.59834,0.80122,3525.76725,564.81935,19.00243
+"4165","YDR049W",89,110,7,36.99847,0.93125,0.17985,1.54068,5.88169,2109.42158,426.38757,0.97658,0.5918,195.31543,0.85165,2671.2807,396.77981,20.0088
+"4166","YDR050C",7,110,7,33.56401,0.82692,0.16441,1.44181,4.05289,2752.81347,484.36642,1.07751,0.58355,177.59632,0.77808,3218.05088,476.10071,18.97231
+"4167","YDR050C",19,110,7,32.72135,0.87706,0.17261,1.44778,3.7385,2857.3462,457.08968,1.12493,0.46284,149.36803,0.80628,3089.65808,480.41073,18.00434
+"4168","YDR050C",31,110,7,36.23689,0.81786,0.16501,1.49547,3.60875,2692.39068,428.80875,1.19169,0.39584,144.14303,0.82973,2892.24666,451.00678,16.51812
+"4169","YDR050C",43,110,7,29.56232,0.83343,0.16473,1.37124,3.82628,2493.83384,389.70518,1.03012,0.48292,150.16365,0.77184,2705.59178,408.22757,16.06597
+"4170","YDR050C",55,110,7,25.44116,0.81157,0.15639,1.35546,3.65909,2366.51335,373.68288,0.97714,0.53217,122.56103,0.74454,2560.05746,333.75671,15.19368
+"4171","YDR050C",67,110,7,42.12229,0.86713,0.17459,1.52546,4.7482,2825.76538,520.88754,1.11018,0.83376,188.5777,0.93695,3413.63831,520.88754,18.65123
+"4172","YDR050C",79,110,7,29.26425,0.86908,0.17188,1.4171,3.593,2682.60824,430.5804,1.05685,0.54276,147.94361,0.85239,2895.37566,385.0151,16.00452
+"4173","YDR050C",91,110,7,53.28374,0.92568,0.1867,1.48801,5.57099,2912.27797,525.61337,1.15551,0.45192,188.55995,0.95083,3569.86323,543.40583,22.17235
+"4174","YDR051C",9,110,7,30.77994,0.87564,0.16766,1.44818,2.69908,2579.47022,474.86374,1.0831,0.4461,198.58725,0.76881,3073.6661,447.03411,16.14955
+"4175","YDR051C",21,110,7,29.56649,0.84439,0.17187,1.49938,2.71833,2664.76935,452.30673,1.08982,0.43016,184.65291,0.80331,3117.69548,476.037,15.75228
+"4176","YDR051C",33,110,7,36.70464,0.9758,0.19283,1.58982,4.69599,3180.77713,607.47866,1.24695,0.47158,260.63663,0.94954,4386.37309,671.32453,17.86607
+"4177","YDR051C",45,110,7,26.67572,0.84712,0.16387,1.41642,2.99267,2443.55003,390.35568,1.04357,0.43282,160.02599,0.79644,2530.08312,388.58392,15.56178
+"4178","YDR051C",57,110,7,28.55341,0.83753,0.16585,1.3698,3.34582,2297.8416,408.75455,0.981,0.42234,180.06324,0.8002,2802.53208,385.33533,15.32775
+"4179","YDR051C",69,110,7,29.79178,0.86792,0.17347,1.45081,4.76117,2574.51115,429.51686,1.08884,0.60677,170.37875,0.82865,2806.27945,418.79223,15.76248
+"4180","YDR051C",81,110,7,55.0773,0.91023,0.18057,1.47141,4.03727,2609.49517,498.8688,1.10449,0.41187,210.99085,0.92702,3361.9263,490.56269,21.39199
+"4181","YDR051C",93,110,7,45.15674,0.92858,0.18149,1.48111,15.56002,2728.50391,489.42864,1.18342,0.47169,187.55132,1.42597,3213.81573,471.07844,20.35327
+"4182","YDR055W",10,110,7,27.16523,0.85723,0.15923,1.31821,2.77822,2350.31948,424.37067,1.0422,0.52016,151.68653,0.76535,2749.38996,369.79562,15.1098
+"4183","YDR055W",22,110,7,32.64284,0.88901,0.17323,1.49662,3.35759,2736.949,494.82173,1.14408,0.4347,180.6218,0.85729,3387.28819,506.64739,16.06822
+"4184","YDR055W",34,110,7,26.58444,0.83467,0.168,1.37182,4.31736,2459.89072,427.4673,1.0972,0.54367,148.27534,0.81185,2914.32976,390.26707,14.77082
+"4185","YDR055W",46,110,7,29.02704,0.89373,0.16948,1.38655,4.31313,2666.20635,433.13509,1.176,0.42947,123.72714,0.99292,2979.11024,424.83856,15.6834
+"4186","YDR055W",58,110,7,32.07744,0.92386,0.17931,1.43286,4.50807,2819.34172,539.19114,1.19613,0.54302,185.59195,0.89682,3493.49549,508.09551,16.54281
+"4187","YDR055W",70,110,7,31.12284,0.88187,0.17511,1.45575,4.10598,2587.63759,466.37613,1.15141,0.44759,159.59694,0.90154,3086.44978,445.75913,15.85779
+"4188","YDR055W",82,110,7,30.14061,0.87155,0.16894,1.36074,5.56845,2652.59983,480.81625,1.1547,0.54021,143.98836,0.82545,3199.65752,382.284,15.51015
+"4189","YDR055W",94,110,7,39.26344,0.95591,0.17957,1.42324,5.49111,2748.71979,491.57692,1.18487,0.58545,158.09894,0.97424,3152.92074,480.78383,20.4142
+"4190","YDR056C",2,111,7,31.75324,0.8796,0.16504,1.24147,2.66658,2649.9111,452.16097,1.18397,0.39015,121.52068,0.71322,3094.00468,438.37541,15.48164
+"4191","YDR056C",14,111,7,28.3711,0.84672,0.15713,1.23005,2.84758,2347.465,393.5094,1.10546,0.49443,121.51115,0.6975,2768.79758,387.45376,15.02736
+"4192","YDR056C",26,111,7,39.28135,0.86008,0.16208,1.36993,4.21253,2455.10031,399.04454,1.31334,0.62042,120.79255,0.8216,2793.69718,471.05499,16.68767
+"4193","YDR056C",38,111,7,27.18734,0.83942,0.16106,1.20244,2.97499,2180.17328,349.26534,1.08728,0.50568,121.08206,0.70778,2513.42601,366.11623,14.03626
+"4194","YDR056C",50,111,7,24.22383,0.83462,0.15443,1.09189,16.96499,2171.15325,353.99356,1.08251,0.46581,100.91843,0.66307,2316.96136,296.73229,13.85836
+"4195","YDR056C",62,111,7,30.31643,0.84442,0.16059,1.26261,4.30344,2420.76688,398.10872,1.1436,0.57591,116.62696,0.71827,2712.59667,421.27179,15.4052
+"4196","YDR056C",74,111,7,30.5305,0.87694,0.17178,1.35395,3.90632,2544.81394,476.73615,1.16744,0.59763,148.74868,0.80028,3229.3944,493.89946,15.62736
+"4197","YDR056C",86,111,7,31.51421,0.87159,0.16847,1.27522,4.80745,2459.17766,404.28725,1.15704,0.58411,108.61055,0.77459,2663.7957,415.28687,16.63998
+"4198","YDR057W",3,111,7,41.36787,0.97309,0.16996,1.34771,4.0355,2552.84131,537.26653,1.0918,0.64209,111.27029,0.78939,3581.77686,529.70133,19.30363
+"4199","YDR057W",15,111,7,35.03596,0.94635,0.16789,1.32251,3.47197,2372.92997,450.92174,1.04764,0.52015,110.7645,0.79507,2933.5492,439.18535,17.3192
+"4200","YDR057W",27,111,7,43.14502,0.95454,0.17605,1.61063,3.95835,2445.44334,456.11986,1.04745,0.47484,100.56223,0.85137,3313.63975,477.63875,20.52539
+"4201","YDR057W",39,111,7,29.9369,0.93444,0.16563,1.16838,3.18082,2308.88091,412.68789,1.00085,0.53212,91.10213,0.76755,2721.21401,375.5843,16.41101
+"4202","YDR057W",51,111,7,33.07201,0.95171,0.17962,1.22214,3.26714,2477.88205,492.43386,1.03186,0.57575,127.12312,0.89615,3258.33332,487.29149,16.65855
+"4203","YDR057W",63,111,7,30.23812,0.91114,0.1736,1.18145,3.53194,2257.96838,451.24461,0.96678,0.58805,105.14981,0.81188,3057.26403,419.40659,15.55394
+"4204","YDR057W",75,111,7,38.85431,0.96496,0.18536,1.29088,5.693,2663.08078,528.69418,1.09963,0.81794,129.84004,0.90016,3534.70222,537.90169,20.30433
+"4205","YDR057W",87,111,7,34.28643,0.93945,0.17293,1.24605,4.83666,2337.76927,452.01538,1.0141,0.8255,121.95367,0.85073,3066.6918,439.12793,19.04346
+"4206","YDR059C",4,111,7,36.83789,0.96837,0.1698,1.34549,4.03964,2583.10319,347.05467,1.14633,0.52094,89.77212,0.74194,2372.77438,619.57574,21.24976
+"4207","YDR059C",16,111,7,30.60435,0.93446,0.17065,1.33497,3.03113,2429.45511,379.87859,1.12185,0.53465,108.06412,0.72083,2601.36947,602.88853,18.20702
+"4208","YDR059C",28,111,7,40.57867,0.94332,0.17316,1.45287,3.76808,2608.39158,385.72734,1.1783,0.45663,112.90537,0.76723,2758.53491,696.11908,22.32769
+"4209","YDR059C",40,111,7,27.53653,0.918,0.15984,1.09599,3.51988,2143.20963,287.70466,1.03743,0.5713,81.76549,0.67509,1937.08259,457.46619,17.30338
+"4210","YDR059C",52,111,7,22.73272,0.96113,0.15924,1.12016,2.10604,1935.45211,263.14912,0.95522,0.57108,81.14149,0.65044,1797.46266,387.57039,16.85225
+"4211","YDR059C",64,111,7,26.29371,0.95225,0.17044,1.23496,2.24909,2170.34198,307.29808,1.04114,0.48662,98.77782,0.7285,2058.87262,451.95429,17.32174
+"4212","YDR059C",76,111,7,26.49266,0.91778,0.16247,1.17231,2.62571,2182.97744,305.98801,1.01273,0.63665,83.14482,0.67922,2049.48311,429.88939,18.52962
+"4213","YDR059C",88,111,7,22.23272,1.00922,0.1686,1.09347,8.22123,2130.19157,282.83851,1.03126,0.62344,81.50449,1.24739,1809.51071,457.02259,16.68342
+"4214","YDR061W",5,111,7,35.65167,0.8643,0.16504,1.42343,2.90002,2951.56322,545.30163,1.24687,0.45256,148.69336,0.76223,3705.52194,398.86647,17.64031
+"4215","YDR061W",17,111,7,39.66287,0.94709,0.17635,1.56278,3.6554,3349.63674,698.06103,1.33638,0.39952,223.58803,0.84737,4786.56705,542.71536,19.13392
+"4216","YDR061W",29,111,7,45.13852,0.92242,0.18131,1.50849,13.58316,3458.76997,649.52722,1.40593,0.49109,193.11504,0.83748,4605.90463,517.12786,23.20775
+"4217","YDR061W",41,111,7,38.39273,0.88,0.17154,1.33691,3.33424,2867.27932,480.76361,1.22363,0.51859,149.45539,0.79263,3376.45298,378.28805,19.9497
+"4218","YDR061W",53,111,7,30.08188,0.87175,0.1728,1.30248,14.80991,2698.10611,471.58404,1.17392,0.50596,140.98219,0.76471,3157.58867,275.79412,17.60541
+"4219","YDR061W",65,111,7,38.12142,0.87486,0.17423,1.3643,3.20951,2944.14781,508.07547,1.26686,0.58038,157.47328,0.82253,3435.27109,388.56951,21.06275
+"4220","YDR061W",77,111,7,33.94831,0.90871,0.18542,1.42072,4.57192,3211.6303,535.69627,1.31876,0.56669,148.7089,0.84496,3637.17183,425.21107,17.96073
+"4221","YDR061W",89,111,7,30.99249,0.94718,0.16345,1.26552,51.56577,2666.34306,475.99737,1.1505,47.05305,121.39474,0.75837,3243.74354,338.91372,16.83073
+"4222","YDR063W",7,111,7,34.87082,0.88371,0.16822,1.32998,3.051,2526.22735,458.492,1.1427,0.41972,157.89363,0.7824,3096.41055,472.72009,17.15848
+"4223","YDR063W",19,111,7,29.04333,0.86159,0.1653,1.22861,3.67006,2504.20968,429.52951,1.11503,0.44842,127.65527,0.72181,2921.4298,427.33433,15.42641
+"4224","YDR063W",31,111,7,33.22032,0.86991,0.17021,1.33934,3.37514,2585.21621,450.30951,1.14343,0.47144,138.69,0.76732,3062.904,473.29128,16.58551
+"4225","YDR063W",43,111,7,27.35129,0.88081,0.16488,1.27051,5.92828,2251.21591,370.42353,1.10394,0.48713,116.63432,0.7375,2570.05337,377.19731,15.92978
+"4226","YDR063W",55,111,7,25.51961,0.77769,0.16167,1.15544,3.89754,2145.43161,351.43378,1.00884,0.49156,108.05113,2.01357,2283.57882,297.31514,15.1163
+"4227","YDR063W",67,111,7,28.79797,0.8625,0.16958,1.2401,3.77166,2398.39102,434.91793,1.09741,0.53833,138.43596,0.77974,2897.62442,427.82129,16.2832
+"4228","YDR063W",79,111,7,26.62512,0.8837,0.17014,1.19738,2.53998,2447.06425,423.76558,1.08774,0.45552,128.70557,0.7992,2673.76796,352.17494,15.44227
+"4229","YDR063W",91,111,7,35.07264,0.93812,0.17803,1.35328,5.39341,2645.31032,564.57261,1.19861,0.69749,191.15451,0.91065,3724.22855,578.43977,18.19849
+"4230","YDR065W",8,111,7,33.14125,0.6286,0.15851,1.3375,3.29754,1128.09672,449.83539,0.60498,0.28372,105.33321,0.67429,2722.40065,495.73887,17.04853
+"4231","YDR065W",20,111,7,33.24482,0.62589,0.16734,1.43391,3.49365,1181.67962,488.18708,0.633,0.22152,114.75842,0.74262,3005.52541,598.39212,17.00956
+"4232","YDR065W",32,111,7,38.64722,0.63267,0.17073,1.55645,3.86018,1234.90325,478.22765,0.62378,0.22987,115.24028,0.77815,3018.02574,608.3773,18.98594
+"4233","YDR065W",44,111,7,26.64688,0.59982,0.15092,1.24292,2.90863,978.92448,366.15865,0.51886,0.23361,81.75229,0.65606,2281.23631,438.36285,14.86473
+"4234","YDR065W",56,111,7,30.63326,0.62771,0.16576,1.35855,6.01202,1083.48801,416.20171,0.59386,0.23825,91.61766,0.75725,2517.89887,476.82563,16.75308
+"4235","YDR065W",68,111,7,34.92506,0.62463,0.16948,1.32267,3.79383,1136.02549,437.44897,0.61121,0.25715,95.66134,0.75278,2650.47487,480.81695,15.76113
+"4236","YDR065W",80,111,7,29.18086,0.60003,0.15971,1.26825,3.10088,1013.82859,384.78671,0.55589,0.27399,88.44588,0.70914,2395.73658,391.09418,15.41755
+"4237","YDR065W",92,111,7,36.0528,0.685,0.17036,1.388,5.67688,1203.34204,479.66521,0.61623,0.39036,103.1861,0.81377,2857.30871,552.4083,18.30123
+"4238","YDR066C",9,111,7,38.91035,0.89497,0.16494,1.41756,9.90236,2767.98838,501.74974,1.18815,1.36327,134.68753,0.8475,3322.22736,557.65461,17.12557
+"4239","YDR066C",21,111,7,60.03291,0.80029,0.15896,1.71597,3.40478,2292.3831,395.50838,1.09477,0.46916,158.65271,0.869,2622.95186,404.66951,17.95117
+"4240","YDR066C",33,111,7,31.19995,0.85272,0.17126,1.36157,4.35991,2603.96093,423.90705,1.11458,0.54268,159.56168,0.79442,2912.50219,450.79807,15.87179
+"4241","YDR066C",45,111,7,27.67452,0.81337,0.15539,1.12152,3.09296,2273.68545,375.69054,0.98294,0.63963,118.66582,0.68398,2470.54757,395.84302,15.00842
+"4242","YDR066C",57,111,7,26.83229,0.85077,0.16353,1.18901,2.39694,2308.60396,398.66742,1.00987,0.46931,146.61087,0.7653,2594.04926,405.43078,15.36596
+"4243","YDR066C",69,111,7,28.14897,0.8742,0.17024,1.23785,3.01381,2580.6612,466.15818,1.06672,0.46112,181.79398,0.79301,3222.23338,500.72217,15.29649
+"4244","YDR066C",81,111,7,30.30719,0.87627,0.17542,1.32334,6.00516,2678.71231,481.21336,1.10594,0.80042,165.59236,0.83616,3234.72967,509.60663,16.55783
+"4245","YDR066C",93,111,7,32.52064,0.90627,0.18062,1.33371,4.04815,2663.90753,502.03111,1.1301,0.58386,191.01316,0.88598,3317.7016,580.92929,17.60822
+"4246","YDR067C",10,111,7,38.32779,0.91982,0.15307,1.51938,3.16777,2552.94595,327.0219,1.10814,0.4549,118.24239,0.59472,2378.14405,408.59853,16.39481
+"4247","YDR067C",22,111,7,36.37693,0.93814,0.16292,1.39779,4.57926,2793.23346,376.0655,1.17738,0.50409,147.9101,0.66769,2837.37194,498.5018,16.35327
+"4248","YDR067C",34,111,7,44.40484,0.95909,0.17028,1.43402,4.89625,2973.2624,407.1471,1.21213,0.47925,183.6167,0.68675,3128.74098,572.21044,18.13437
+"4249","YDR067C",46,111,7,34.47847,0.95207,0.16821,1.29371,5.64415,2917.17782,381.48624,1.20975,0.56955,124.46364,0.65203,2864.81697,534.93361,16.41992
+"4250","YDR067C",58,111,7,31.51999,0.89334,0.15634,1.17835,4.98072,2509.62431,314.96769,1.07087,1.26916,111.65901,0.59905,2156.97489,373.44261,15.27591
+"4251","YDR067C",70,111,7,38.61046,1.02607,0.18061,1.47207,4.82365,3238.11288,508.56579,1.31012,0.48789,220.64126,0.75891,3677.35438,638.90953,17.42468
+"4252","YDR067C",82,111,7,30.36335,0.9065,0.16357,1.25158,5.17429,2531.60716,328.47496,1.11241,0.53543,125.82197,0.6297,2368.11758,424.15139,15.04747
+"4253","YDR067C",94,111,7,28.6465,0.89268,0.16038,1.1858,3.97187,2297.99853,298.42437,1.02309,0.52453,138.70141,0.67634,2196.7108,355.83084,15.55852
+"4254","YDR068W",2,112,8,45.48057,0.65907,0.16833,1.3504,8.85051,2585.12988,363.75155,1.04197,0.52091,93.01407,1.34246,2722.13599,400.04049,14.9305
+"4255","YDR068W",14,112,8,34.18159,0.64157,0.16738,1.6172,7.12204,2463.72147,356.58518,1.01823,0.48893,91.57808,1.41565,2773.88384,381.38277,14.91847
+"4256","YDR068W",26,112,8,34.64991,0.61005,0.15925,1.65695,8.74825,2242.16675,290.24306,0.92128,0.48964,81.65029,1.88938,2279.97575,303.83714,13.8035
+"4257","YDR068W",38,112,8,36.08186,0.64793,0.16833,1.30192,6.07333,2289.18831,325.00113,0.92773,0.42887,104.68725,1.21142,2508.20276,340.19389,14.87772
+"4258","YDR068W",50,112,8,31.22019,0.64477,0.16459,1.2155,6.16199,2331.06539,313.5974,0.95372,0.48975,87.63673,1.13429,2451.61235,333.94102,14.65848
+"4259","YDR068W",62,112,8,30.31229,0.66897,0.16266,1.25778,6.67169,2405.0075,317.83122,0.97321,0.47969,84.43225,1.1591,2478.15795,317.12744,14.59668
+"4260","YDR068W",74,112,8,44.22896,0.72178,0.17286,1.36032,6.54506,2570.96176,398.00753,1.04017,0.43936,123.57955,1.31465,3082.02097,434.78866,16.67663
+"4261","YDR068W",86,112,8,37.58318,0.6484,0.16919,1.26873,13.6439,2406.82224,300.61818,1.01536,0.46129,78.3056,1.20068,2384.47621,315.07221,15.23243
+"4262","YDR069C",3,112,8,68.52626,1.25281,0.16802,1.66141,8.41132,1190.15231,370.07692,1.74756,0.63519,171.64565,2.30258,2421.58888,474.62861,15.70838
+"4263","YDR069C",15,112,8,58.29591,1.17479,0.15804,1.90668,6.60531,1079.19773,309.65257,1.6093,0.55065,145.42309,1.96001,2095.6814,412.95871,14.60956
+"4264","YDR069C",27,112,8,58.30796,1.14517,0.15322,1.32048,6.98521,1062.45999,273.16433,1.53446,0.64138,130.25469,1.94823,1882.77019,357.51211,14.27589
+"4265","YDR069C",39,112,8,54.60146,1.18551,0.16376,1.3814,7.25251,1052.27945,305.25054,1.60934,0.60978,144.94543,1.69521,2048.76413,382.82299,14.55582
+"4266","YDR069C",51,112,8,55.18032,1.23482,0.15702,1.41115,6.22661,1131.62178,297.93937,1.63254,0.50941,138.41511,1.67976,2035.99836,359.83091,14.8919
+"4267","YDR069C",63,112,8,58.67389,1.25047,0.16878,1.49572,9.18053,1181.08974,322.15662,1.68925,0.55912,142.14443,2.23785,2187.488,384.44429,15.54154
+"4268","YDR069C",75,112,8,56.52607,1.3111,0.17201,1.94738,7.68221,1113.05835,380.28057,1.75829,0.58578,192.2201,2.81019,2586.46849,469.62653,15.41913
+"4269","YDR069C",87,112,8,69.91369,1.19086,0.16046,1.52479,8.33341,1084.27569,300.39896,1.63173,0.63008,151.34503,2.00181,2059.66558,357.25723,16.15657
+"4270","YDR070C",4,112,8,43.70223,0.66211,0.17777,1.58426,7.76226,2475.85749,405.6571,1.02464,0.4705,136.64287,2.14704,3047.47724,440.57113,15.6555
+"4271","YDR070C",16,112,8,39.72014,0.62669,0.17182,1.29681,6.82526,2236.13808,350.44265,0.9254,0.42156,129.85916,1.31845,2715.43224,385.34688,14.84263
+"4272","YDR070C",28,112,8,42.30236,0.63298,0.17284,3.84696,6.97875,2367.29824,348.23082,0.97751,0.62455,112.96579,1.45633,2752.92915,384.15875,16.40937
+"4273","YDR070C",40,112,8,44.01409,0.62602,0.18815,1.548,8.2716,2296.5899,340.2528,0.98031,0.48171,121.24036,1.7997,2629.45153,372.81391,15.6132
+"4274","YDR070C",52,112,8,35.99812,0.6511,0.17653,1.35404,8.16401,2316.8655,354.02634,0.99837,0.75939,116.24333,1.4788,2692.07011,421.72461,15.23972
+"4275","YDR070C",64,112,8,34.45708,0.68305,0.17888,1.39749,6.88494,2443.51002,367.01217,1.03465,0.55703,116.68208,1.47462,2865.06784,382.92042,15.75212
+"4276","YDR070C",76,112,8,36.98782,0.63849,0.17694,1.43101,6.72321,2436.29784,331.54031,0.99932,0.62909,100.59032,1.54919,2616.69148,352.17126,15.33448
+"4277","YDR070C",88,112,8,50.5127,0.73151,0.18541,1.54504,7.90339,2738.05135,414.67267,1.12015,0.56159,125.93006,1.4317,3279.47694,435.84793,19.2661
+"4278","YDR072C",5,112,8,48.14172,0.73722,0.17794,2.01844,8.00779,2073.26988,374.86614,1.11905,0.90901,109.71344,1.49128,2863.80115,410.8401,15.14897
+"4279","YDR072C",17,112,8,66.2335,0.75388,0.18454,1.78991,6.99332,2052.95263,355.59898,1.09186,0.65788,105.55399,1.86301,2801.8393,439.9775,17.10205
+"4280","YDR072C",29,112,8,68.91367,0.75464,0.19585,2.14549,8.07554,2038.87426,372.48149,1.13058,0.86077,113.03581,3.17626,2933.26729,396.17215,17.91321
+"4281","YDR072C",41,112,8,45.89483,0.79186,0.18291,1.51313,6.41629,2127.71955,406.74667,1.11131,0.59812,123.43253,1.55025,3202.70688,481.42092,16.37092
+"4282","YDR072C",53,112,8,46.88705,0.75057,0.18757,1.7305,8.0898,1960.85808,345.75439,1.07839,0.75596,107.15677,2.20708,2665.52196,382.09975,15.76336
+"4283","YDR072C",65,112,8,52.2639,0.77847,0.20118,1.92374,13.05353,2159.06019,357.52432,1.18869,0.70274,94.59004,2.59754,2844.03236,387.9778,22.02596
+"4284","YDR072C",77,112,8,43.76643,0.71598,0.17635,1.37931,6.45902,1929.6795,321.64141,1.03837,0.57711,96.49453,1.38086,2525.17616,347.06213,15.48263
+"4285","YDR072C",89,112,8,42.72856,0.72754,0.16751,1.28698,6.58757,1906.97832,310.59932,1.02187,0.72089,93.06723,1.23858,2447.50566,318.15551,15.7278
+"4286","YDR073W",7,112,8,40.45634,0.78438,0.1741,1.40266,7.43201,2476.03998,440.38583,1.19226,0.78857,108.55921,1.27586,3327.68418,433.22681,15.51441
+"4287","YDR073W",19,112,8,36.83939,0.7171,0.17479,1.28971,6.7049,2274.72658,347.77549,1.11835,0.45603,84.94416,1.13063,2659.34147,337.06818,14.96568
+"4288","YDR073W",31,112,8,35.235,0.69874,0.16964,1.30292,7.09713,2181.96595,320.39231,1.05653,0.52009,81.69372,1.23947,2525.33695,326.1613,14.97469
+"4289","YDR073W",43,112,8,50.21681,0.70087,0.17489,1.42699,8.3166,2269.54857,356.51725,1.10474,0.732,88.86899,1.50368,2767.37213,359.83423,17.2628
+"4290","YDR073W",55,112,8,43.51107,0.74055,0.18225,1.51629,6.79329,2231.64421,344.97556,1.1126,0.49906,92.58866,1.70648,2717.31455,379.80002,15.97841
+"4291","YDR073W",67,112,8,38.73046,0.72329,0.17881,1.45732,6.25713,2179.92797,319.72904,1.07617,0.46645,82.13203,1.43501,2549.19984,322.48826,15.42773
+"4292","YDR073W",79,112,8,37.66703,0.73567,0.17726,1.44767,6.05427,2300.0301,338.17005,1.10247,0.44125,88.67246,1.35071,2616.03376,367.0986,15.38564
+"4293","YDR073W",91,112,8,43.1539,0.75219,0.17889,1.37595,5.94201,2327.51529,328.99903,1.12827,0.50911,78.43374,1.20429,2571.50865,316.80278,16.06375
+"4294","YDR075W",8,112,8,37.40947,0.76951,0.19284,1.45503,7.88877,2973.36525,438.77829,1.24479,0.56457,91.02826,1.43762,3366.26717,445.81086,16.48959
+"4295","YDR075W",20,112,8,30.51411,0.65407,0.17122,1.2899,7.79558,2603.866,317.77928,1.06264,0.58009,62.3215,1.32668,2544.1598,340.20324,15.23406
+"4296","YDR075W",32,112,8,29.23417,0.71269,0.17487,1.37719,6.47428,2678.58045,309.82773,1.10328,0.49751,55.77817,1.1993,2455.35893,291.78186,16.28327
+"4297","YDR075W",44,112,8,32.5439,0.75475,0.18171,1.41759,7.69349,2996.82258,414.3567,1.2104,0.60505,81.95212,1.34351,3343.60072,458.25529,16.17418
+"4298","YDR075W",56,112,8,28.68949,0.66551,0.16339,1.29608,6.18852,2531.73452,312.01353,1.03438,0.50707,60.85421,1.10641,2451.78357,310.99622,14.76327
+"4299","YDR075W",68,112,8,31.33992,0.68328,0.17123,1.27802,6.76057,2651.16321,310.41737,1.06473,0.50682,62.38235,1.14602,2454.6142,323.08479,14.86259
+"4300","YDR075W",80,112,8,33.98878,0.72799,0.18376,1.34958,6.79776,2844.55529,361.35915,1.14993,0.50361,72.92873,1.26394,2866.80071,390.65477,15.76217
+"4301","YDR075W",92,112,8,30.93474,0.67029,0.16837,1.29884,6.28839,2595.40985,304.98391,1.05609,0.50664,56.64758,1.12729,2463.98434,309.99771,15.0889
+"4302","YDR076W",9,112,8,42.76791,0.74186,0.17815,1.53257,7.34706,2399.27809,434.03682,1.20929,0.54161,105.68833,2.95231,3261.90023,489.11208,18.90934
+"4303","YDR076W",21,112,8,33.4868,0.67262,0.17696,1.38146,6.16659,2236.38215,315.83284,1.09697,0.4947,69.40789,1.23679,2453.54178,328.59742,15.52472
+"4304","YDR076W",33,112,8,32.21757,0.6453,0.17138,1.40083,6.16877,2166.58937,297.37938,1.07443,0.5428,63.41443,1.25286,2349.16583,313.66467,14.85247
+"4305","YDR076W",45,112,8,34.03297,0.65145,0.17287,1.3454,6.69999,2235.13012,335.80626,1.09791,0.58499,79.05243,1.23154,2656.30382,365.05669,15.6528
+"4306","YDR076W",57,112,8,36.67233,0.7248,0.17787,1.45088,6.73078,2389.41398,377.01273,1.13473,0.6055,83.89501,1.23875,2957.7646,441.33741,16.88549
+"4307","YDR076W",69,112,8,32.65402,0.66478,0.16954,1.43138,6.19288,2192.27951,307.7754,1.05172,0.5015,72.08083,1.16018,2410.56958,346.65809,14.70039
+"4308","YDR076W",81,112,8,31.3954,0.67567,0.17413,1.37084,6.59959,2303.16311,311.91865,1.11301,0.5763,65.15069,1.20463,2441.71398,347.42527,15.3312
+"4309","YDR076W",93,112,8,33.33479,0.65415,0.17458,1.3426,5.92618,2248.60249,299.19299,1.11049,0.53096,64.16224,1.20493,2353.39969,307.73676,15.4628
+"4310","YDR077W",10,112,8,46.02098,1.13055,0.19305,1.5644,10.69263,2553.36257,486.38244,1.46638,0.65103,83.67316,1.75355,3677.70693,527.13064,19.0048
+"4311","YDR077W",22,112,8,40.40845,1.03979,0.19097,1.37492,7.34176,2301.56448,367.15632,1.33156,0.69497,54.81357,1.61566,2942.30442,415.96271,15.53467
+"4312","YDR077W",34,112,8,34.28397,1.00558,0.18347,1.31654,6.62858,2201.64676,310.83783,1.27008,0.70573,38.23666,1.50389,2520.02453,327.25267,14.61972
+"4313","YDR077W",46,112,8,38.02006,1.03656,0.18801,1.41504,7.43056,2339.48697,344.62067,1.31486,0.76252,46.86912,1.75327,2721.59853,392.76863,15.26756
+"4314","YDR077W",58,112,8,38.40967,1.09466,0.19496,1.97655,7.05749,2386.1717,363.70969,1.34898,0.68224,49.42634,1.50962,2968.48143,390.91412,16.13192
+"4315","YDR077W",70,112,8,34.7262,0.97507,0.18271,1.30404,6.52793,2207.28129,307.47959,1.26069,0.61732,39.85659,1.3399,2505.19449,343.68895,14.33476
+"4316","YDR077W",82,112,8,36.94243,0.99638,0.18078,1.36965,7.9982,2185.2306,309.1371,1.23948,0.7725,47.32558,1.44445,2460.9854,333.26996,14.95463
+"4317","YDR077W",94,112,8,38.41191,1.0022,0.18416,1.30451,5.79308,2187.50292,305.92416,1.2586,0.73933,46.0971,1.38622,2475.01214,309.44683,14.98578
+"4318","YDR078C",2,113,8,54.33576,0.67335,0.18576,2.69073,8.50984,792.15451,391.26584,0.65051,0.414,119.78062,1.60761,2665.63206,496.4878,16.16454
+"4319","YDR078C",14,113,8,37.09156,0.67724,0.18128,1.09168,8.05818,746.45859,357.82302,0.60787,0.40537,107.36525,1.24902,2526.75754,414.55738,15.09752
+"4320","YDR078C",26,113,8,32.02415,0.66856,0.18581,1.06826,6.69099,753.80675,326.26641,0.58847,0.38716,97.57256,1.17522,2353.7098,352.20043,14.7753
+"4321","YDR078C",38,113,8,35.40663,0.68728,0.18752,1.17139,27.24412,761.86148,356.20387,0.64788,0.33804,108.09338,1.28875,2504.87444,428.67604,14.99871
+"4322","YDR078C",50,113,8,37.51916,0.66241,0.17818,1.0865,9.99425,725.80465,331.22155,0.58694,0.43309,99.60915,1.24405,2355.51174,359.99477,14.81925
+"4323","YDR078C",62,113,8,37.0186,0.67043,0.17933,1.23258,8.20752,726.81382,314.73476,0.58623,0.42222,98.48222,1.19804,2215.30528,338.13064,15.10201
+"4324","YDR078C",74,113,8,40.72932,0.83936,0.20293,1.39594,8.09409,922.93908,515.02909,0.71781,0.45654,150.66575,1.5225,3609.97788,552.65175,17.72095
+"4325","YDR078C",86,113,8,33.07816,0.68131,0.18187,1.11602,9.05187,756.41356,329.35507,0.60734,0.42442,99.23447,1.86825,2321.96857,333.76898,14.93932
+"4326","YDR079W",3,113,8,52.47531,0.73083,0.19578,1.64659,8.52869,834.91341,442.42737,0.6862,0.68083,126.38817,1.79949,2964.76798,546.83498,17.03058
+"4327","YDR079W",15,113,8,36.12585,0.7392,0.19401,1.14038,7.53743,828.44459,417.8573,0.65286,0.34795,120.07522,1.33751,2967.25199,500.57365,16.22381
+"4328","YDR079W",27,113,8,34.49308,0.69447,0.19423,1.11549,6.60876,770.63451,375.11225,0.59664,0.41364,109.09159,1.31637,2664.86344,427.14894,15.29787
+"4329","YDR079W",39,113,8,60.35826,0.68709,0.18466,1.08355,7.13522,933.40167,400.98633,0.7046,0.45116,238.75491,1.46492,2639.51774,1441.68175,15.21865
+"4330","YDR079W",51,113,8,34.25801,0.71192,0.18933,1.1056,7.13432,770.28389,383.12586,0.61525,0.44051,113.83548,1.29887,2738.32369,468.02548,15.72161
+"4331","YDR079W",63,113,8,37.20209,0.76415,0.19092,1.18523,7.73765,822.2246,421.34169,0.64451,0.43169,120.21507,1.39409,2939.17033,479.13694,16.48481
+"4332","YDR079W",75,113,8,35.01819,0.73133,0.19121,1.3227,6.27294,823.6748,407.09872,0.62752,0.36556,115.32799,1.44226,2880.00807,451.18875,16.2835
+"4333","YDR079W",87,113,8,45.32165,0.73543,0.19924,1.2817,7.72766,835.04922,408.90186,0.67759,0.49124,122.45648,1.86366,2876.98513,470.37252,18.73956
+"4334","YDR080W",5,113,8,54.45712,0.88693,0.16458,1.41232,10.03841,1902.52685,275.96145,1.43666,0.51481,337.0477,1.31846,2440.504,486.06646,16.31188
+"4335","YDR080W",17,113,8,49.68524,0.81268,0.15688,1.23175,7.37245,1790.89677,215.67911,1.34975,0.41165,258.55878,1.11064,1956.79212,382.03676,15.05335
+"4336","YDR080W",29,113,8,47.75726,0.81485,0.15787,1.19534,7.09393,1691.38325,185.94963,1.27494,0.74053,229.91886,1.0374,1724.9589,300.48252,14.69267
+"4337","YDR080W",41,113,8,52.92796,0.84983,0.16599,1.54937,7.12637,1850.73324,224.34413,1.43552,0.37257,266.06565,4.65895,2068.99515,399.02049,16.22149
+"4338","YDR080W",53,113,8,45.30347,0.82217,0.1588,1.16133,7.03311,1706.60456,200.10734,1.3001,0.42892,240.65912,1.06025,1853.83895,324.99595,14.86168
+"4339","YDR080W",65,113,8,49.27975,0.8451,0.16298,1.22274,6.4364,1773.17609,212.71894,1.3393,0.38767,251.60884,1.05908,1933.11913,340.43828,15.48088
+"4340","YDR080W",77,113,8,47.60114,0.81612,0.16262,1.32997,6.08988,1783.88135,197.94388,1.31498,0.35245,236.5063,1.13934,1819.00849,325.15481,15.20745
+"4341","YDR080W",89,113,8,57.17362,0.8317,0.16524,1.30307,6.84406,1787.01029,194.18878,1.2634,0.48012,233.63393,1.65905,1820.76203,306.23188,15.73649
+"4342","YDR083W",7,113,8,34.16565,0.59144,0.1558,1.30767,7.65261,2476.35737,342.61047,1.05215,0.5936,86.04554,0.98043,2557.96234,377.82621,15.28669
+"4343","YDR083W",19,113,8,30.75358,0.57122,0.15099,1.2061,6.5503,2358.32164,320.87188,0.98968,0.68156,78.36812,0.92082,2430.31784,317.23996,14.26581
+"4344","YDR083W",31,113,8,29.82504,0.57487,0.15123,1.23894,5.80015,2385.32894,302.28954,1.00866,0.6069,75.77659,0.89812,2272.09869,306.10385,14.63001
+"4345","YDR083W",43,113,8,38.79259,0.63414,0.16294,1.30353,6.6578,2626.66748,398.26246,1.0893,0.63531,92.7869,0.99621,3001.1108,402.62109,15.9743
+"4346","YDR083W",55,113,8,31.60644,0.59173,0.15071,1.24747,6.351,2330.12864,313.98451,0.98537,0.65319,87.94385,0.94909,2390.86774,331.68107,14.90699
+"4347","YDR083W",67,113,8,39.25645,0.6146,0.16394,1.30092,5.98674,2515.34246,324.76192,1.05778,0.68832,78.50554,0.97718,2472.5748,330.5845,17.08719
+"4348","YDR083W",79,113,8,32.82772,0.59863,0.15812,1.31619,7.12455,2491.60443,330.53098,1.02141,0.67771,77.5822,0.98476,2490.16582,330.88036,15.18282
+"4349","YDR083W",91,113,8,41.05179,0.63103,0.16167,1.65429,7.71781,2515.14141,319.88855,1.04391,0.62969,64.94211,1.66605,2450.43845,331.8531,16.62691
+"4350","YDR084C",8,113,8,42.53194,0.71324,0.16757,1.35112,7.28315,2306.51359,432.79478,1.16764,0.56438,136.30678,1.2126,3273.64166,471.72291,16.04421
+"4351","YDR084C",20,113,8,35.16204,0.66884,0.16483,1.2752,6.2606,2155.95729,340.70374,1.09316,0.56304,109.14483,1.14176,2658.30402,354.66317,14.51084
+"4352","YDR084C",32,113,8,32.28077,0.64643,0.16114,1.2089,5.56787,2046.12017,318.80496,1.02145,0.47813,99.61529,1.09783,2476.86994,309.22491,14.34501
+"4353","YDR084C",44,113,8,39.732,0.67368,0.16647,1.27866,6.31641,2196.01577,356.45463,1.10014,0.58766,136.19615,1.19651,2741.68105,529.27871,15.32035
+"4354","YDR084C",56,113,8,37.40523,0.68721,0.16465,1.33222,6.44238,2099.24945,327.46137,1.05832,0.50185,108.35799,1.14676,2577.38716,350.25097,15.30929
+"4355","YDR084C",68,113,8,36.0974,0.67259,0.16695,1.25896,5.8055,2135.15125,314.75154,1.05625,0.49862,95.93752,1.09894,2534.43816,353.84764,15.27789
+"4356","YDR084C",80,113,8,34.89115,0.65074,0.16205,1.30314,6.83696,2147.84899,319.55434,1.06772,0.5202,93.99625,1.08726,2496.82902,312.84081,14.64976
+"4357","YDR084C",92,113,8,34.6218,0.69073,0.1673,1.33643,6.1921,2273.66759,341.20046,1.10841,1.07532,94.1844,1.25305,2718.56643,335.86221,15.51567
+"4358","YDR085C",9,113,8,33.77547,0.65025,0.16516,1.25463,6.94191,2315.69733,344.85074,1.03919,0.62989,90.54383,1.17593,2657.99804,367.44585,14.67724
+"4359","YDR085C",21,113,8,33.44971,0.63724,0.16435,1.25589,7.80791,2265.7825,323.47374,0.98101,0.42387,84.45047,1.65723,2541.85055,331.81756,14.7472
+"4360","YDR085C",33,113,8,29.17282,0.62957,0.16372,1.2584,5.84214,2259.47262,316.58083,0.97319,0.48127,80.51517,1.10923,2463.28067,321.06779,14.47878
+"4361","YDR085C",45,113,8,31.4203,0.62677,0.16174,1.20418,5.71719,2257.41129,344.45775,0.98388,0.45529,96.62829,1.15654,2639.59512,374.72694,14.63361
+"4362","YDR085C",57,113,8,39.14023,0.66272,0.16704,1.25581,5.96375,2262.84297,332.64945,0.9824,0.54852,90.64537,1.1781,2569.24087,368.61175,15.50958
+"4363","YDR085C",69,113,8,42.74615,0.63901,0.16531,1.34983,5.86424,2264.14985,329.52707,1.00349,0.46947,120.90992,1.27519,2446.40141,591.83685,15.27879
+"4364","YDR085C",81,113,8,32.06603,0.64235,0.17101,1.25003,6.58928,2274.96722,313.58413,0.97505,0.51726,82.55935,1.13278,2444.30092,330.86431,14.74784
+"4365","YDR085C",93,113,8,32.50335,0.65529,0.16765,1.36283,6.93277,2260.3981,303.62669,1.00163,0.4645,80.49263,1.57286,2429.88864,314.98303,15.42644
+"4366","YDR089W",10,113,8,20.84166,0.60253,0.16237,1.19788,6.67016,2039.28795,206.40435,0.98884,0.4646,52.7749,0.94977,1668.57747,360.8221,13.86655
+"4367","YDR089W",22,113,8,19.66202,0.6183,0.16383,1.2127,6.1388,2030.24875,198.25562,0.99996,0.64326,51.70539,0.92467,1613.76715,323.0416,14.06499
+"4368","YDR089W",34,113,8,18.5482,0.60116,0.16215,1.21133,6.23013,1950.80974,193.81388,0.95474,0.66484,50.66904,0.90796,1578.71126,297.53882,13.67504
+"4369","YDR089W",46,113,8,26.35498,0.67348,0.17102,1.30791,6.58009,2245.61051,249.20521,1.08468,0.47001,78.67706,1.05385,2018.35509,550.78791,15.46875
+"4370","YDR089W",58,113,8,20.89406,0.62168,0.16167,1.42969,5.75774,1969.36312,192.87203,0.96509,0.48519,55.42653,1.29855,1578.92629,340.22684,14.15726
+"4371","YDR089W",70,113,8,19.89798,0.61297,0.15667,1.21671,6.36909,1926.26082,183.57424,0.92125,0.50607,52.32258,0.92092,1507.07765,295.72465,13.76723
+"4372","YDR089W",82,113,8,23.42922,0.74049,0.17267,1.36631,7.60091,2356.41077,267.71961,1.13854,0.50757,69.24566,1.71548,2190.77608,424.73056,16.04119
+"4373","YDR089W",94,113,8,19.31573,0.60146,0.15768,1.19119,6.60784,1915.15259,179.03818,0.92853,0.51965,49.00485,0.98689,1439.61231,256.44619,13.87053
+"4374","YDR090C",2,114,8,29.92476,0.57527,0.15308,1.19977,6.51289,2248.73585,329.40055,0.95596,0.43171,88.30024,0.96861,2495.37457,366.78182,13.86641
+"4375","YDR090C",14,114,8,26.73422,0.575,0.14879,1.13057,5.14259,2209.03525,310.28338,0.98697,0.39946,70.89953,0.8845,2457.98102,324.69971,13.97076
+"4376","YDR090C",26,114,8,28.23459,0.58533,0.15293,1.15828,6.77472,2125.23335,280.46508,0.94548,0.44678,71.02608,1.3775,2257.03803,296.4128,13.6006
+"4377","YDR090C",38,114,8,37.09711,0.6059,0.15901,1.29622,7.91715,2194.02677,312.38558,0.98819,0.39701,86.96499,0.97327,2478.47672,341.3545,14.62854
+"4378","YDR090C",50,114,8,28.50254,0.59978,0.15258,1.19958,6.21632,2134.61522,298.9971,0.96802,0.43116,79.04248,0.91456,2433.6892,320.67105,13.841
+"4379","YDR090C",62,114,8,31.96376,0.67964,0.16458,1.38121,7.10153,2493.18713,365.75616,1.09005,0.51433,84.08758,2.06668,2969.54093,419.19686,15.57027
+"4380","YDR090C",74,114,8,29.49705,0.61621,0.16085,1.26465,7.26039,2277.43887,330.31395,1.02448,0.50434,71.82896,1.07308,2660.78498,356.83343,14.66559
+"4381","YDR090C",86,114,8,29.90003,0.59836,0.15183,1.21504,6.01095,2174.12579,282.64779,0.98008,0.41314,73.89243,1.05844,2276.97651,283.69715,13.83204
+"4386","YDR092W",3,114,8,32.24379,0.68971,0.16687,1.40642,6.55903,1905.03258,405.25907,1.16035,0.53561,237.94371,1.08145,3086.22755,410.84216,14.37472
+"4387","YDR092W",15,114,8,29.46161,0.65598,0.1614,1.25004,5.78566,1654.4846,327.12319,1.05856,0.58296,211.17464,1.0192,2563.63826,342.79926,13.46407
+"4388","YDR092W",27,114,8,34.55297,0.69871,0.1612,1.28571,5.04203,1823.34124,366.22838,1.13163,0.56487,218.97206,1.01624,2936.21135,381.11793,14.8989
+"4389","YDR092W",39,114,8,33.01004,0.61165,0.15367,1.20261,9.91092,1681.83729,317.80335,1.04787,0.47771,202.14964,0.92174,2449.3404,445.09287,13.45628
+"4390","YDR092W",51,114,8,30.77841,0.70062,0.16242,1.32693,4.75336,1816.10456,354.06942,1.122,0.4908,213.03796,0.9904,2812.49766,379.68362,14.67449
+"4391","YDR092W",63,114,8,27.35259,0.66539,0.16085,1.27773,5.41717,1725.28924,314.46823,1.06051,0.52483,190.1632,1.33194,2477.16093,312.67308,13.91637
+"4392","YDR092W",75,114,8,33.56797,0.7265,0.16447,1.43581,5.97257,1872.0886,377.2657,1.15217,0.52929,230.48183,1.07534,2999.6035,390.79534,15.39619
+"4393","YDR092W",87,114,8,32.19871,0.65369,0.15861,1.29134,5.20676,1665.73453,321.91093,1.04883,0.52939,208.15278,1.14402,2516.49766,304.40276,14.69953
+"4398","YDR093W",4,114,8,35.68598,0.62979,0.15767,1.28272,6.71744,2712.8009,358.17317,1.13675,0.44319,82.67661,1.06228,2839.67183,381.05267,14.69353
+"4399","YDR093W",16,114,8,32.18167,0.63071,0.16194,1.27134,6.61893,2616.64483,332.56748,1.14373,0.48586,73.76233,1.00749,2687.34966,358.54921,14.34834
+"4400","YDR093W",28,114,8,32.99522,0.63392,0.1634,1.21957,5.13538,2543.69298,318.08916,1.09577,0.58473,80.12407,0.95889,2621.22313,380.89649,14.30823
+"4401","YDR093W",40,114,8,35.1153,0.66775,0.1719,1.36301,6.14226,2837.75934,339.8009,1.19228,0.50825,72.28651,1.00492,2843.19132,406.50416,15.42474
+"4402","YDR093W",52,114,8,33.48204,0.65842,0.15875,1.25229,4.94126,2650.26571,349.97537,1.09487,0.48587,82.77582,0.96247,2870.98727,381.91327,14.5911
+"4403","YDR093W",64,114,8,35.2936,0.66636,0.16152,1.31552,5.44428,2747.4787,346.6463,1.14185,0.50897,72.24672,1.21663,2918.82478,391.9994,15.52495
+"4404","YDR093W",76,114,8,34.83981,0.61893,0.15762,1.25878,5.70057,2546.3934,301.8478,1.06182,0.49738,66.06334,0.92307,2464.22979,327.63672,14.54181
+"4405","YDR093W",88,114,8,36.16347,0.61333,0.15399,1.24375,5.61733,2445.78031,287.13333,1.0826,0.56507,68.45767,0.96797,2385.93487,293.57772,15.14399
+"4406","YDR094W",5,114,8,53.88769,0.63821,0.15824,1.36446,6.66221,2113.41289,379.90521,1.10507,0.54702,168.42471,1.34669,2971.81078,418.36043,16.17691
+"4407","YDR094W",17,114,8,42.1269,0.63703,0.16241,1.32144,5.79945,2051.15676,362.7722,1.07793,0.5556,160.01764,1.15221,2952.47155,402.89682,15.05875
+"4408","YDR094W",29,114,8,38.87259,0.66484,0.15894,1.33518,5.97319,2104.31876,379.3494,1.09404,0.50847,161.16133,1.69953,3089.0957,399.85649,15.43702
+"4409","YDR094W",41,114,8,43.52041,0.72088,0.16944,1.5014,6.59114,2294.8469,440.55338,1.18192,0.57629,187.80377,1.10968,3604.26493,508.57207,16.95922
+"4410","YDR094W",53,114,8,38.8253,0.64893,0.15916,1.33274,5.31245,2063.78975,334.11218,1.07491,0.5174,138.59526,1.12538,2739.86246,371.17302,15.27533
+"4411","YDR094W",65,114,8,37.83622,0.6291,0.15369,1.28702,4.17039,1955.12709,305.38762,1.03748,0.52611,134.36061,0.95157,2499.74927,345.60734,15.69965
+"4412","YDR094W",77,114,8,38.15164,0.62375,0.16059,1.32239,6.66887,2047.09614,313.25256,1.07602,0.46531,132.60677,0.96453,2581.62819,330.37476,15.32407
+"4413","YDR094W",89,114,8,40.00835,0.66192,0.16081,1.35533,6.32171,2150.12108,312.44714,1.12916,0.63317,126.88478,1.0071,2548.85956,309.49477,16.21653
+"4414","YDR095C",7,114,8,41.06253,0.66358,0.16618,1.33523,9.26248,2389.17349,368.03156,1.08826,0.57563,109.89884,1.13576,2851.20387,380.20609,15.57396
+"4415","YDR095C",19,114,8,31.00498,0.64167,0.1646,1.22406,5.20279,2234.53463,316.1033,1.02814,0.57861,95.63642,1.0453,2558.67761,334.14694,14.13187
+"4416","YDR095C",31,114,8,36.47928,0.65823,0.16533,1.24493,4.72954,2190.98759,309.47382,1.00314,0.56356,94.55995,1.03199,2462.46665,303.90423,14.79557
+"4417","YDR095C",43,114,8,36.33283,0.70322,0.17306,1.40576,5.77137,2511.43354,387.06233,1.13242,0.48503,106.49834,1.57258,3096.83476,449.25814,16.22162
+"4418","YDR095C",55,114,8,31.363,0.67068,0.16366,1.34181,4.78635,2279.7919,340.99379,1.01754,0.50862,102.65481,1.17531,2765.44692,363.69172,15.08445
+"4419","YDR095C",67,114,8,32.98087,0.65115,0.1672,1.29685,4.24304,2201.75362,316.20702,1.01957,0.49595,97.72355,1.18913,2466.91565,324.41529,14.54217
+"4420","YDR095C",79,114,8,32.86747,0.6657,0.16815,1.34539,30.81894,2299.60458,327.05969,1.05853,0.41277,95.13459,1.51263,2572.90591,332.31038,14.99906
+"4421","YDR095C",91,114,8,31.64644,0.68003,0.16629,1.33426,6.00732,2326.51292,323.31812,1.0576,0.49659,91.81477,1.11703,2530.2212,311.84552,15.44827
+"4422","YDR096W",8,114,8,36.57637,0.82631,0.18199,1.36043,6.66725,2597.68145,456.50761,1.1525,0.51247,139.38358,1.77533,3317.4078,435.1898,16.10948
+"4423","YDR096W",20,114,8,30.00437,0.76198,0.17349,1.27846,5.76772,2334.57517,333.03507,1.01455,0.47985,103.51805,1.65106,2524.44889,309.86884,14.31912
+"4424","YDR096W",32,114,8,26.71574,0.74413,0.16806,1.23789,4.95666,2211.4737,322.792,0.94516,0.49279,104.49441,1.56287,2428.70356,284.54932,13.6421
+"4425","YDR096W",44,114,8,32.72992,0.83512,0.1841,1.38059,5.42315,2579.69245,421.88772,1.06694,0.54251,132.56822,1.76491,3216.39063,437.74327,15.90012
+"4426","YDR096W",56,114,8,28.34654,0.78314,0.17641,1.27189,5.02465,2293.74948,333.46509,0.98321,0.54449,119.03573,1.63738,2530.66422,367.46824,14.41872
+"4427","YDR096W",68,114,8,25.58734,0.72705,0.17205,1.25771,4.60947,2176.41584,306.18058,0.95076,0.47509,109.49049,1.58889,2361.64124,307.43669,13.61813
+"4428","YDR096W",80,114,8,31.92284,0.76066,0.17614,1.32345,4.83987,2341.98465,330.80508,1.00572,0.5718,112.13535,1.67586,2532.02262,331.83397,14.44057
+"4429","YDR096W",92,114,8,30.55957,0.7682,0.17415,1.26978,5.32665,2267.30273,317.83473,0.98936,0.53888,110.81562,1.71824,2404.22233,288.45825,14.39282
+"4430","YDR097C",9,114,8,33.57117,0.60233,0.16249,1.22274,8.48356,2238.399,326.59094,1.08471,0.73446,114.07974,1.06137,2513.94784,341.41679,14.06492
+"4431","YDR097C",21,114,8,30.28729,0.59042,0.15599,1.19844,7.14458,2220.54573,298.98816,1.03567,0.59283,103.32125,0.9928,2392.71054,297.83244,13.48314
+"4432","YDR097C",33,114,8,30.02742,0.5986,0.15586,1.16982,5.46499,2268.9743,295.72613,1.05169,0.68322,91.23209,1.02276,2322.36451,292.18143,14.03452
+"4433","YDR097C",45,114,8,33.03169,0.64433,0.17156,1.27777,6.13208,2439.44349,343.77311,1.13081,0.66364,117.29388,1.07143,2734.36117,373.05309,14.73681
+"4434","YDR097C",57,114,8,33.54792,0.65979,0.16386,1.28389,7.30733,2446.34571,364.02962,1.1129,0.66723,116.86829,1.07195,2898.43426,379.22523,15.39369
+"4435","YDR097C",69,114,8,30.84366,0.59596,0.16128,1.24519,5.89167,2220.1532,304.11155,1.0406,1.20862,107.42027,1.03376,2397.83166,324.62841,13.94153
+"4436","YDR097C",81,114,8,32.94163,0.63482,0.16556,1.28733,5.78848,2319.70435,307.98087,1.06222,0.60344,108.18121,1.11491,2432.07929,320.71764,14.66956
+"4437","YDR097C",93,114,8,37.98806,0.67469,0.16934,1.33807,6.09652,2352.1981,358.97847,1.09263,0.67276,139.85788,1.38465,2785.98461,380.38847,16.46415
+"4438","YDR098C",10,114,8,30.83699,0.63214,0.16561,1.18787,7.69293,2075.93187,334.9725,0.91721,0.77617,106.34519,1.14669,2527.57448,326.64151,13.86541
+"4439","YDR098C",22,114,8,28.82701,0.60448,0.1594,1.13637,6.13858,2010.58662,295.2057,0.91269,0.75971,89.27262,1.04395,2271.59188,285.05187,16.60699
+"4440","YDR098C",34,114,8,30.65938,0.63612,0.16347,1.18124,5.74753,2083.05571,303.19943,0.90491,0.71868,94.1502,1.0356,2371.6102,314.1187,13.64578
+"4441","YDR098C",46,114,8,32.22234,0.64477,0.17064,1.21583,5.74797,2148.4712,333.26714,0.93933,0.70041,107.07095,1.10037,2583.89451,373.33422,14.41935
+"4442","YDR098C",58,114,8,31.04636,0.63671,0.16428,1.17028,6.10399,2034.26451,304.16815,0.89945,0.6879,94.79951,1.05101,2342.25517,310.11035,13.99206
+"4443","YDR098C",70,114,8,29.50862,0.62743,0.16807,1.2026,7.8911,2058.67999,304.33367,0.9191,0.79298,97.96409,1.06781,2303.04271,314.37239,13.9758
+"4444","YDR098C",82,114,8,35.01687,0.72016,0.17679,1.31275,14.09207,2384.52006,388.49192,1.0639,0.83691,121.90243,1.44354,3045.06098,393.69812,15.54061
+"4445","YDR098C",94,114,8,33.46042,0.65869,0.16998,1.23248,5.87947,2066.04013,295.44282,0.94758,0.76304,99.09485,1.82732,2252.25156,272.91328,14.33526
+"4446","YDR099W",2,115,9,30.11679,0.82558,0.20111,1.7322,7.05841,3124.22684,506.89384,1.32268,0.54585,261.78584,1.42811,3293.53526,480.61535,15.23951
+"4447","YDR099W",14,115,9,23.54195,0.84781,0.19522,1.6628,6.36094,3102.1508,444.45657,1.26647,0.71229,218.46584,1.22429,2904.78812,490.05921,14.27058
+"4448","YDR099W",26,115,9,24.44187,0.84591,0.19674,1.64728,7.80185,3038.06346,464.41492,1.21072,0.62205,219.86703,1.2441,3063.1821,448.97772,14.74299
+"4449","YDR099W",38,115,9,21.39088,0.85132,0.20301,1.63113,6.20132,2899.45918,414.02449,1.16047,0.59911,204.67121,1.20775,2798.9696,398.90639,14.05566
+"4450","YDR099W",50,115,9,20.56156,0.8676,0.20475,1.63029,7.58491,2976.05772,398.06159,1.20146,0.72495,194.66497,1.23757,2699.44135,376.77581,14.41042
+"4451","YDR099W",62,115,9,16.93901,0.89094,0.19535,1.61329,7.05242,2796.96058,374.53132,1.19727,0.58358,165.1687,1.11262,2466.24157,273.79718,14.59035
+"4452","YDR099W",74,115,9,22.45065,0.88781,0.20746,1.77262,6.44651,3007.67862,408.51057,1.17889,0.72373,203.62995,1.19999,2704.26141,417.16166,15.23206
+"4453","YDR099W",86,115,9,39.34841,0.91225,0.21653,1.85993,9.16718,3509.55239,520.36824,1.34159,0.69886,253.89346,1.37325,3487.99238,613.06933,17.59763
+"4454","YDR100W",3,115,9,32.5037,0.94064,0.21981,2.47034,13.64989,2934.45263,547.68515,1.40043,0.62583,200.83301,1.65455,3475.55643,544.32545,15.12375
+"4455","YDR100W",15,115,9,22.99495,0.94302,0.20556,1.63452,7.14634,2869.79083,466.93054,1.30231,0.60318,156.63378,1.43876,2995.17765,455.59586,14.07944
+"4456","YDR100W",27,115,9,26.32316,0.99246,0.21158,1.68394,7.96306,2962.86184,497.6719,1.29571,1.13574,176.14719,1.44654,3189.95978,504.42214,14.4219
+"4457","YDR100W",39,115,9,24.74104,0.95539,0.20939,2.16124,7.44841,2754.88728,418.15334,1.21361,0.64289,145.035,1.47945,2718.24718,408.72412,14.03742
+"4458","YDR100W",51,115,9,21.29615,0.9877,0.21022,2.17959,7.23436,2651.43931,391.93676,1.16279,0.7911,140.92734,1.48735,2482.01085,354.32983,14.43059
+"4459","YDR100W",63,115,9,16.02201,1.01253,0.21549,1.61862,7.71418,2734.90592,410.69805,1.22394,0.73202,136.06798,1.41082,2694.2672,319.93029,14.40897
+"4460","YDR100W",75,115,9,20.74649,0.99828,0.21275,1.62439,8.14466,2889.42276,451.42704,1.22505,0.72159,165.85173,1.43656,2900.20937,425.53149,14.12483
+"4461","YDR100W",87,115,9,38.74579,1.04212,0.22918,1.8366,9.35098,3363.57532,547.83658,1.39027,0.68073,185.15377,1.60387,3470.19516,606.04961,16.80855
+"4462","YDR101C",4,115,9,45.90207,0.73602,0.18872,1.94768,7.65243,3290.45876,504.31287,1.35929,0.53487,200.44613,1.82611,3368.75289,566.8758,17.14095
+"4463","YDR101C",16,115,9,27.39449,0.74049,0.1801,1.74383,6.46252,3096.09798,435.05453,1.20811,0.49064,145.91545,1.04925,2813.3493,441.18789,14.1822
+"4464","YDR101C",28,115,9,22.67986,0.72415,0.17641,1.62946,6.50543,2793.33385,383.62999,1.09049,0.66957,143.37818,0.96232,2487.9971,394.48896,13.57004
+"4465","YDR101C",40,115,9,26.30116,0.74739,0.18162,1.74655,7.27648,2843.82158,386.39954,1.12504,0.55456,143.98755,1.00417,2584.82961,397.47032,14.97265
+"4466","YDR101C",52,115,9,19.69674,0.7597,0.17895,1.57292,5.47914,2798.74906,337.90609,1.09811,0.67568,112.40744,0.94875,2190.67927,299.77759,13.18925
+"4467","YDR101C",64,115,9,45.96311,0.78352,0.19043,1.81226,6.54071,3069.70049,410.74095,1.36589,0.56043,134.70397,1.27646,2734.90775,377.99659,17.69925
+"4468","YDR101C",76,115,9,27.27546,0.76895,0.1871,1.61054,6.18154,3144.51692,413.23681,1.18292,0.69864,146.7566,1.03219,2662.4277,447.04782,14.56535
+"4469","YDR101C",88,115,9,35.94471,0.76443,0.18959,2.03165,7.23853,3374.5654,464.7525,1.27996,0.54714,183.44637,1.15287,3053.19141,552.4308,15.75889
+"4470","YDR102C",5,115,9,48.87536,0.76805,0.191,2.00888,8.36593,2845.34628,522.34233,1.26085,0.73658,245.12653,2.48248,3387.07999,533.94909,16.84715
+"4471","YDR102C",17,115,9,29.57565,0.84555,0.20076,1.77334,7.21733,3025.54738,480.4186,1.26064,0.61182,203.08373,1.37815,3151.05404,526.01239,14.81864
+"4472","YDR102C",29,115,9,25.35976,0.85277,0.20396,1.6238,6.49211,2947.75872,452.71044,1.1945,0.7679,182.78871,1.31264,2802.03411,404.34901,14.78788
+"4473","YDR102C",41,115,9,23.43345,0.83898,0.1962,1.55956,5.82725,2722.48673,414.12313,1.12712,0.57399,181.48384,1.33064,2680.48719,373.71957,14.61027
+"4474","YDR102C",53,115,9,19.28315,0.82682,0.19288,1.53435,10.70216,2609.00068,392.74893,1.13511,0.53496,156.89777,2.19495,2485.93461,325.93399,14.06676
+"4475","YDR102C",65,115,9,17.47644,0.84917,0.19451,1.52933,6.05023,2676.8616,373.64105,1.09155,0.68721,152.10043,1.18382,2395.7997,327.46437,14.00848
+"4476","YDR102C",77,115,9,31.74338,0.89295,0.20986,1.69977,6.33548,3183.30586,455.20585,1.26767,0.60683,184.05953,1.31754,2872.66595,499.24785,18.26728
+"4477","YDR102C",89,115,9,41.88838,0.89818,0.21816,2.13024,8.47159,3285.15888,546.08069,1.30754,0.49417,244.81927,1.72758,3480.58688,614.33286,17.83646
+"4478","YDR103W",7,115,9,48.81589,0.89018,0.21807,1.96175,33.88265,3305.31717,555.13288,1.57661,0.54881,194.1201,1.96592,3701.6446,581.03475,18.16458
+"4479","YDR103W",19,115,9,29.90646,0.88132,0.21639,1.65689,9.7125,2939.71294,478.318,1.34494,0.68553,178.27304,1.48933,3146.50844,458.16692,16.19339
+"4480","YDR103W",31,115,9,49.72692,0.90165,0.2184,1.73119,5.55319,2924.28276,434.87252,1.25082,0.57835,157.44037,1.64185,2786.98893,436.00273,22.5683
+"4481","YDR103W",43,115,9,29.23347,0.8835,0.21053,1.61124,5.53656,2808.79998,430.55711,1.22781,0.70094,142.15209,1.39618,2679.17058,357.74452,18.56611
+"4482","YDR103W",55,115,9,23.62391,0.89065,0.20474,1.67482,5.21505,2653.57233,382.2079,1.17784,0.68153,132.25438,1.58937,2396.71529,315.09339,15.42122
+"4483","YDR103W",67,115,9,18.20906,0.91645,0.22368,1.69643,6.28583,3037.67845,461.34665,1.27771,0.85642,149.20127,1.5617,3003.95372,416.19383,14.86395
+"4484","YDR103W",79,115,9,25.56542,0.96211,0.21996,1.69784,6.24312,3408.20045,547.5172,1.37305,0.49146,174.50282,1.5051,3598.9606,605.02284,15.45492
+"4485","YDR103W",91,115,9,26.04189,0.91086,0.21948,1.74892,8.11018,3429.49051,581.62242,1.423,0.70573,187.32646,1.55951,3663.76539,644.22254,15.67352
+"4486","YDR104C",8,115,9,42.46763,0.83682,0.20334,2.02525,7.54964,2983.05993,516.28212,1.42358,0.61326,256.9225,1.49453,3485.41857,512.20216,16.19272
+"4487","YDR104C",20,115,9,33.14342,0.83852,0.19594,1.71326,6.81944,2942.37889,509.18173,1.35747,0.59086,246.5764,1.35714,3464.59153,466.36587,16.17723
+"4488","YDR104C",32,115,9,30.34572,0.89609,0.2021,1.69125,5.75448,2892.37316,472.00471,1.26407,0.70775,232.31396,1.301,3147.52665,459.4225,15.27463
+"4489","YDR104C",44,115,9,22.24589,0.84682,0.19481,1.64796,5.50868,2535.95541,393.7608,1.2122,0.56012,201.71915,1.23581,2562.25719,340.37593,14.42165
+"4490","YDR104C",56,115,9,18.45903,0.83322,0.19341,1.52838,4.53031,2447.93558,381.58727,1.13086,0.65004,192.97071,1.19989,2471.57461,298.0805,13.32379
+"4491","YDR104C",68,115,9,21.79652,0.87987,0.20115,1.57489,5.6988,2690.55,409.18813,1.23278,0.53751,198.55338,1.24165,2665.90985,389.46832,13.90836
+"4492","YDR104C",80,115,9,45.37556,0.9523,0.22475,1.89466,6.46404,3383.8442,562.75538,1.45531,0.53415,269.0415,1.85168,3755.80401,618.82514,16.73303
+"4493","YDR104C",92,115,9,30.92103,0.90969,0.20838,1.80093,6.80962,3358.94029,584.59411,1.40882,0.62273,263.3335,1.41803,3857.85354,640.40832,14.60119
+"4494","YDR105C",9,115,9,45.74244,0.96948,0.20592,2.28948,7.42887,3161.38548,512.46262,1.53484,0.53614,187.62483,1.75114,3310.35916,481.431,17.80352
+"4495","YDR105C",21,115,9,33.0426,0.97322,0.20849,1.72345,7.1152,2982.97195,491.55987,1.41722,0.65696,204.53082,1.42185,3233.61203,460.87953,16.41068
+"4496","YDR105C",33,115,9,25.78674,1.01925,0.22172,1.70702,6.60648,3027.32808,516.32279,1.39522,0.60456,208.52687,1.40554,3313.70315,467.28774,15.68014
+"4497","YDR105C",45,115,9,21.25258,0.99221,0.19616,1.59149,6.15608,2928.87009,432.93202,1.32073,0.62348,159.55206,1.26794,2781.44629,395.30855,14.1137
+"4498","YDR105C",57,115,9,19.17181,0.94896,0.19579,1.48141,5.85254,2539.97812,373.98978,1.1848,0.48422,138.81647,1.27335,2264.86829,265.93697,12.98237
+"4499","YDR105C",69,115,9,18.45036,1.02347,0.20371,1.57139,5.83866,2803.25575,426.53071,1.26602,0.66758,158.37312,1.23991,2709.36463,362.91948,13.44968
+"4500","YDR105C",81,115,9,23.65761,1.00087,0.21131,2.25268,5.59134,3009.07167,500.8375,1.33738,0.54071,209.70865,1.42094,3099.31139,521.62788,13.91151
+"4501","YDR105C",93,115,9,32.22234,1.0237,0.21625,2.23096,6.50211,3552.24164,599.41692,1.54179,0.5191,197.64946,1.42566,3737.1514,630.27251,15.12358
+"4502","YDR107C",10,115,9,43.60522,0.88539,0.20879,1.99006,7.34377,3347.55303,546.01788,1.46792,0.68729,200.06751,1.55712,3410.71179,535.87778,19.01891
+"4503","YDR107C",22,115,9,29.11911,0.87691,0.2052,1.75868,7.274,3284.67625,517.74848,1.38956,0.58555,201.02034,2.24116,3353.97912,486.17017,17.71962
+"4504","YDR107C",34,115,9,18.02403,0.82818,0.19597,1.68429,6.71639,2802.75635,410.31051,1.18923,0.68516,156.08014,1.45029,2505.26448,345.20839,14.38322
+"4505","YDR107C",46,115,9,17.29105,0.85977,0.19287,1.52502,4.66503,2676.28965,401.89283,1.11648,0.55472,160.89349,1.16724,2527.52942,293.73174,13.40601
+"4506","YDR107C",58,115,9,18.05971,0.87835,0.25234,1.54435,4.60618,2742.96535,380.35862,1.15379,0.56543,149.06994,1.17218,2336.32188,295.72289,13.81012
+"4507","YDR107C",70,115,9,21.72118,0.88951,0.20513,1.64437,5.92467,3020.79068,435.65214,1.24503,0.61176,162.89513,1.22588,2718.72726,397.06471,14.29143
+"4508","YDR107C",82,115,9,26.2198,0.87149,0.20457,1.70492,7.22511,3134.23628,515.57314,1.29772,0.54159,222.47783,1.36709,3111.70403,534.6481,14.15497
+"4509","YDR107C",94,115,9,30.01501,0.92171,0.21522,2.1224,7.44361,3718.29035,639.18513,1.46473,0.83268,239.96367,1.45712,4033.10764,730.90631,15.94811
+"4510","YDR108W",2,116,9,64.87174,0.90551,0.20644,2.5307,7.85282,2702.87454,563.28005,2.05636,0.69049,230.2342,1.90346,3424.56666,485.66868,16.68844
+"4511","YDR108W",14,116,9,40.35971,0.90133,0.20428,3.03994,11.07255,2548.1036,513.55338,1.93901,0.63193,197.10741,2.91716,3078.68892,447.69034,14.61101
+"4512","YDR108W",26,116,9,36.54397,0.89875,0.20382,1.71545,20.01165,2421.77055,473.72426,1.88975,0.70268,192.17989,1.70207,2980.72169,411.35193,14.19021
+"4513","YDR108W",38,116,9,32.93395,0.89091,0.19844,1.61478,7.7585,2316.08712,425.24094,1.74283,0.71775,170.5336,1.35382,2565.06345,372.17407,13.77166
+"4514","YDR108W",50,116,9,36.25054,0.91133,0.20712,1.86625,6.03124,2402.98984,456.73324,1.81148,0.72191,184.23286,1.38648,2841.63949,386.75966,14.68869
+"4515","YDR108W",62,116,9,29.98678,0.9338,0.19741,1.73911,6.18726,2239.80227,399.32247,1.65676,0.66926,158.57137,1.31575,2453.60453,276.97555,13.99283
+"4516","YDR108W",74,116,9,38.99363,0.90189,0.20508,1.73156,5.90784,2393.57353,483.94712,1.82075,0.66677,198.36097,1.82116,2892.49617,409.25777,15.16591
+"4517","YDR108W",86,116,9,42.16985,0.95211,0.21566,4.42377,7.45347,2842.51016,571.06065,2.00576,0.66849,233.59449,1.46094,3396.06482,576.07332,15.26298
+"4518","YDR109C",3,116,9,43.09189,0.87848,0.21173,2.30706,7.74326,3514.86978,562.74719,1.47212,0.50643,196.85105,2.21042,3755.55323,585.79041,16.50573
+"4519","YDR109C",15,116,9,23.09927,0.85884,0.20447,2.02114,7.12038,3201.49188,478.95981,1.34181,1.04857,151.50529,1.7178,3131.50923,443.81852,14.26268
+"4520","YDR109C",27,116,9,24.09894,0.87318,0.20699,2.1702,6.93384,3187.03117,437.95689,1.26802,0.67439,141.70765,1.66886,2815.85024,418.69501,14.46119
+"4521","YDR109C",39,116,9,19.43391,0.89206,0.202,1.63787,5.66053,3279.20304,448.11705,1.25706,0.42532,129.44381,1.31548,2927.25695,419.92368,14.48684
+"4522","YDR109C",51,116,9,18.0001,0.87767,0.20646,1.57359,4.91909,2674.41197,384.104,1.07054,0.54949,157.80566,1.32322,2400.23877,296.03957,13.57596
+"4523","YDR109C",63,116,9,15.36925,0.90934,0.20413,1.65947,5.691,2813.09209,395.92919,1.13144,0.67075,155.41608,1.40401,2553.32309,315.10392,14.24417
+"4524","YDR109C",75,116,9,20.71999,0.87898,0.20641,3.20786,6.20076,3200.96143,453.41143,1.42039,0.65643,151.78645,1.55115,2886.41346,444.1569,14.62284
+"4525","YDR109C",87,116,9,32.57247,0.9218,0.22249,2.19995,8.1283,3565.4235,550.01168,1.38912,0.52669,200.58989,1.65088,3461.86467,599.21284,16.32137
+"4526","YDR110W",4,116,9,54.37784,1.22125,0.2286,1.87745,8.06925,3361.70181,591.43108,1.82847,0.79626,130.9263,1.83898,4005.96814,612.76436,16.87063
+"4527","YDR110W",16,116,9,35.115,1.1922,0.21868,1.92522,7.24527,2905.33222,479.34076,1.55503,0.67667,121.79372,2.11847,3156.64324,485.67144,14.41737
+"4528","YDR110W",28,116,9,30.88993,1.19828,0.21957,2.70558,6.68758,3117.12165,483.2564,1.62507,0.60357,104.58295,2.36321,3315.80504,492.93421,14.9281
+"4529","YDR110W",40,116,9,26.45641,1.1925,0.22113,2.17618,6.59296,2860.76749,440.88533,1.56986,0.77046,94.31135,1.67201,2934.84574,400.92049,14.79522
+"4530","YDR110W",52,116,9,22.5661,1.19298,0.208,1.65081,4.71097,2675.69356,369.97712,1.41385,0.93186,87.71367,1.46661,2510.63664,315.8626,13.79449
+"4531","YDR110W",64,116,9,22.40498,1.18597,0.21687,1.63943,4.77141,2672.98423,382.70047,1.40066,0.55847,89.70985,1.55127,2486.65759,307.79234,15.14924
+"4532","YDR110W",76,116,9,28.67718,1.20885,0.22453,1.75202,6.36479,3095.21935,461.75677,1.64536,0.70804,111.58441,1.67048,3111.7104,495.33104,15.04636
+"4533","YDR110W",88,116,9,36.77124,1.24597,0.23687,1.88932,6.84046,3492.38751,570.28923,1.7757,0.81643,130.57488,1.91313,3742.87753,608.96907,16.20023
+"4534","YDR111C",5,116,9,47.11848,0.85717,0.20316,1.92881,8.43954,3342.29282,521.88243,1.39942,0.53373,179.47757,1.56866,3470.7388,518.92175,16.15382
+"4535","YDR111C",17,116,9,31.70081,0.70594,0.16906,7.12829,6.25316,2966.21152,427.67802,1.27287,0.55248,143.97442,1.36835,2881.58651,438.44148,17.64026
+"4536","YDR111C",29,116,9,23.17031,0.87434,0.20274,1.95341,6.17955,2997.84118,418.9455,1.22795,0.55152,147.65232,1.96068,2739.73759,405.35773,14.2225
+"4537","YDR111C",41,116,9,19.70403,0.86083,0.20048,1.69273,5.38959,3000.13918,408.07296,1.19624,0.44574,138.73802,1.50507,2780.53928,386.75588,14.52877
+"4538","YDR111C",53,116,9,16.57336,0.86847,0.20104,1.90642,5.72688,2786.36111,384.56183,1.15276,0.63602,128.58158,1.5148,2481.21908,323.07383,13.94816
+"4539","YDR111C",65,116,9,19.52081,0.88113,0.19646,1.67903,4.4717,2783.47633,373.03638,1.12212,0.56111,125.69713,1.53684,2436.36159,287.26544,15.35039
+"4540","YDR111C",77,116,9,23.41782,0.85658,0.20115,1.62881,5.29003,3087.97912,445.49136,1.20703,0.60255,156.63286,1.37963,2927.28199,449.59166,14.92588
+"4541","YDR111C",89,116,9,43.7958,0.95711,0.2233,2.05003,7.42002,3807.64486,561.94649,1.45993,0.56958,190.10068,1.61375,3704.87252,647.60654,16.72704
+"4542","YDR112W",7,116,9,30.45465,0.87141,0.20029,1.81079,7.02964,3450.59771,532.7813,1.39246,0.62665,191.16933,1.35946,3523.2882,492.42808,15.64026
+"4543","YDR112W",19,116,9,24.91133,0.88854,0.19849,1.74205,6.74692,3271.0771,454.46711,1.28696,0.50762,152.3918,1.28662,2884.07919,409.32202,15.57278
+"4544","YDR112W",31,116,9,25.90889,0.89306,0.20069,1.59578,6.24946,3082.62314,432.23614,1.18726,0.59765,161.87109,1.28562,2857.52604,408.15714,15.73031
+"4545","YDR112W",43,116,9,21.37512,0.87937,0.19807,1.65615,5.92139,2950.44039,403.65805,1.20108,0.55009,153.99769,1.24697,2594.27832,359.63118,14.80362
+"4546","YDR112W",55,116,9,28.16852,0.86028,0.19179,1.50296,5.11455,2769.37701,366.12268,1.11547,0.54821,132.37565,1.19809,2322.29331,259.04688,14.8126
+"4547","YDR112W",67,116,9,18.75422,0.92092,0.20115,1.63572,6.32268,3027.85288,413.1785,1.23572,1.17866,151.9737,1.26633,2752.81891,360.02334,15.54345
+"4548","YDR112W",79,116,9,27.46985,0.97726,0.21305,1.85439,15.06416,3714.89316,562.22436,1.42116,0.6079,201.85871,1.42082,3851.18825,615.88346,18.09651
+"4549","YDR112W",91,116,9,37.63007,0.91667,0.2082,6.79284,7.44102,3738.06895,547.47624,1.43478,0.57914,188.8848,2.23519,3560.43005,610.39457,17.74524
+"4550","YDR114C",8,116,9,31.22213,0.91376,0.22342,2.59277,7.2383,1239.93468,543.15291,0.73775,0.37839,167.38972,1.71538,3206.39588,552.5479,16.26281
+"4551","YDR114C",20,116,9,28.53588,0.89581,0.22449,2.00467,6.3183,1175.56047,490.65267,0.72189,0.40237,148.08207,1.48227,2905.92042,467.7544,15.40058
+"4552","YDR114C",32,116,9,25.06243,0.89302,0.21472,1.73142,5.21763,1137.58885,429.31258,0.63485,0.43353,138.01311,1.3287,2610.17811,403.46121,17.05717
+"4553","YDR114C",44,116,9,17.67391,0.88316,0.21622,1.63295,4.57046,1030.0612,428.70495,0.61959,0.39477,128.86607,1.35124,2486.57062,358.02376,14.50623
+"4554","YDR114C",56,116,9,15.06901,0.87856,0.20506,1.62397,4.87033,1000.93575,390.72623,0.60617,0.44591,123.39941,1.35298,2343.15034,292.78218,13.76748
+"4555","YDR114C",68,116,9,19.23212,0.93504,0.21815,1.50729,6.9708,1098.28105,425.8523,0.64584,0.418,133.75541,1.53675,2492.11552,385.17914,14.90999
+"4556","YDR114C",80,116,9,27.82826,0.94274,0.23282,2.0185,7.43448,1281.93392,523.35055,0.72058,0.66556,172.27564,1.59727,3169.42521,598.36839,16.73558
+"4557","YDR114C",92,116,9,37.80386,0.94014,0.23061,2.52723,7.68237,1413.17146,639.69712,0.79984,0.40347,200.94218,1.98244,3820.4242,716.71929,16.89591
+"4558","YDR115W",9,116,9,30.08163,0.88792,0.22714,2.43639,6.3489,1519.4362,513.82601,0.69837,0.32548,142.54656,1.47843,3095.43148,514.92332,15.87977
+"4559","YDR115W",21,116,9,24.42695,0.85957,0.21548,1.85102,5.95276,1389.97468,454.15402,0.61614,0.31912,128.13661,1.39559,2803.57325,426.1505,14.51389
+"4560","YDR115W",33,116,9,24.18915,0.8982,0.22326,1.82931,5.45427,1403.93886,434.32495,0.58105,0.31996,120.80842,1.33043,2571.53388,419.95757,14.84815
+"4561","YDR115W",45,116,9,20.32428,0.85734,0.21093,1.61577,5.80384,1269.27308,387.01094,0.63255,0.43118,108.73054,1.32418,2290.0284,345.61007,14.31686
+"4562","YDR115W",57,116,9,16.98935,0.86918,0.21974,1.63299,4.5937,1256.05302,374.2503,0.5291,0.39297,103.44857,1.25716,2275.56565,275.09176,13.96589
+"4563","YDR115W",69,116,9,17.44493,0.90427,0.22049,1.5898,5.7335,1401.57653,428.95542,0.57737,0.34256,115.82785,1.36324,2595.55378,364.14296,14.72387
+"4564","YDR115W",81,116,9,27.60623,0.9198,0.22832,1.81792,6.42011,1527.07702,504.31118,0.65357,0.37559,146.69841,1.60933,3023.43654,547.24857,15.36822
+"4565","YDR115W",93,116,9,37.3296,0.90998,0.22789,2.15833,9.06748,1688.70505,581.59222,0.74438,0.39663,165.58503,1.77847,3444.95267,655.68458,16.35877
+"4566","YDR116C",10,116,9,28.65196,0.94797,0.21487,1.89033,31.76674,2925.28282,521.89263,1.20451,0.41078,235.17851,1.46398,3346.2368,524.52533,15.79807
+"4567","YDR116C",22,116,9,27.29506,0.98473,0.21653,1.91087,7.54296,2917.36523,528.31413,1.13831,0.51901,246.24592,1.52764,3562.1523,509.90458,15.21189
+"4568","YDR116C",34,116,9,21.40957,0.94962,0.21285,1.73085,18.62474,2604.46196,442.03186,1.10144,0.47856,199.84401,1.37758,2801.7466,381.0869,13.84245
+"4569","YDR116C",46,116,9,14.58923,0.90626,0.19821,1.5607,5.21258,2339.71131,390.241,0.93337,0.44186,184.87726,1.94926,2487.8526,289.65076,13.37317
+"4570","YDR116C",58,116,9,16.56147,0.95802,0.21169,1.66661,5.58104,2517.81729,405.25067,1.00984,0.59525,179.15357,1.39046,2530.13236,328.65859,14.13363
+"4571","YDR116C",70,116,9,20.224,0.96617,0.2175,1.6584,13.3983,2667.78316,427.54153,1.07923,0.52518,198.37286,1.4975,2768.72872,382.55396,14.74302
+"4572","YDR116C",82,116,9,25.04508,1.00896,0.22032,1.76172,7.18712,2930.84998,528.60148,1.12428,0.40779,254.65452,1.5366,3362.45592,574.28153,14.96423
+"4573","YDR116C",94,116,9,52.45847,1.02581,0.22647,2.06699,12.69359,3231.66759,608.98525,1.22573,0.43102,297.86134,2.5014,3928.63874,672.51015,19.31595
+"4574","YDR117C",2,117,9,37.81291,0.86399,0.20354,1.69662,6.19445,3130.9095,543.45077,1.38386,0.46416,201.25723,1.34456,3516.98385,500.29865,15.16985
+"4575","YDR117C",14,117,9,28.2218,0.81667,0.19887,2.25728,4.80598,2817.58649,460.8187,1.2416,0.40439,172.25494,1.2992,2902.38544,451.48375,14.2128
+"4576","YDR117C",26,117,9,23.17812,0.85039,0.21782,1.64614,5.59448,2881.74019,451.56971,1.21327,0.6162,159.31412,1.17793,2847.43542,397.58521,14.12985
+"4577","YDR117C",38,117,9,23.4116,0.87068,0.1985,1.60226,4.1348,2739.98718,421.03792,1.18639,0.56065,165.48171,1.15912,2667.47306,398.22961,13.89931
+"4578","YDR117C",50,117,9,18.47718,0.87763,0.19823,1.60966,4.11349,2663.48237,416.99593,1.10115,0.47716,173.02881,1.12898,2764.07165,374.00925,13.77974
+"4579","YDR117C",62,117,9,20.00498,0.91113,0.19918,1.66955,4.40421,2760.36097,421.1733,1.1676,0.51833,169.04929,1.19255,2685.18022,379.12578,15.4755
+"4580","YDR117C",74,117,9,22.5137,0.89925,0.20406,1.7617,6.83332,3011.38816,454.14432,1.25264,0.54889,153.63255,1.36689,2824.71698,424.94722,14.82032
+"4581","YDR117C",86,117,9,25.65729,0.90126,0.21105,1.70477,5.37841,3271.43842,522.96291,1.31435,0.41233,190.88137,1.30692,3361.39133,569.48604,14.71778
+"4582","YDR119W",3,117,9,26.3908,0.80058,0.19268,2.81242,5.41756,3159.56084,519.70377,1.35423,0.45193,222.00203,1.29322,3219.60372,484.0631,15.13648
+"4583","YDR119W",15,117,9,23.85026,0.82053,0.19428,1.68194,5.29428,3134.66122,483.85288,1.33137,0.55854,177.92821,1.17078,3013.94256,534.63103,14.22447
+"4584","YDR119W",27,117,9,16.40283,0.78272,0.18922,1.51495,4.08596,2908.8433,420.89489,1.20924,0.47329,146.89865,1.08101,2591.25916,371.72264,13.29498
+"4585","YDR119W",39,117,9,14.80224,0.82968,0.19087,1.59009,4.27313,2855.35011,425.75695,1.23259,0.44753,149.95017,1.10793,2603.02653,380.86717,13.92819
+"4586","YDR119W",51,117,9,13.18114,0.80161,0.18978,1.49164,3.93658,2749.91098,382.51237,1.15451,0.55515,132.95749,1.00339,2353.79212,288.98986,13.1163
+"4587","YDR119W",63,117,9,14.01202,0.88136,0.20513,1.75352,4.17774,3043.43648,428.59457,1.24592,0.64771,149.09445,1.16983,2676.64716,340.09105,14.67382
+"4588","YDR119W",75,117,9,18.81652,0.86557,0.20762,1.82408,4.486,3380.08544,474.26968,1.33665,0.50242,149.10698,1.18902,2894.36831,446.36884,14.40244
+"4589","YDR119W",87,117,9,25.99922,0.85983,0.2088,1.90279,6.41838,3674.47245,535.87032,1.44536,0.55119,162.41165,1.4285,3377.00008,575.18212,15.79819
+"4590","YDR120C",4,117,9,28.19364,0.73217,0.18207,1.62292,5.16328,3240.52771,488.59413,1.16207,0.48288,168.25064,1.11817,3239.89581,481.19454,14.40911
+"4591","YDR120C",16,117,9,21.78667,0.76176,0.18141,1.6514,5.30536,3165.55759,443.15164,1.08666,0.58077,134.0836,1.07937,2839.49098,416.37803,13.69807
+"4592","YDR120C",28,117,9,21.02526,0.77796,0.18888,1.57073,5.13916,3250.72732,416.10186,1.11958,0.58294,101.46861,1.02382,2775.75586,361.17622,14.77409
+"4593","YDR120C",40,117,9,15.95645,0.75896,0.18202,1.46059,4.18997,2989.73869,381.94567,0.99311,0.5497,106.97203,0.96933,2436.78864,350.0064,12.89194
+"4594","YDR120C",52,117,9,19.64346,0.77015,0.18308,3.7223,4.54133,2950.39681,363.10317,1.01956,0.72157,103.46946,1.02296,2340.46842,306.77139,14.50477
+"4595","YDR120C",64,117,9,18.63318,0.80437,0.18168,1.5171,3.79067,2949.88189,347.81387,0.98249,0.54389,94.50946,0.98212,2290.6016,270.48658,16.85116
+"4596","YDR120C",76,117,9,22.07427,0.80287,0.1929,1.59271,4.27242,3482.45386,442.76347,1.12842,0.52557,103.17774,1.05223,2875.52596,440.77455,14.89482
+"4597","YDR120C",88,117,9,33.01412,0.84108,0.19776,1.73619,6.04927,3800.33038,518.29032,1.26569,0.83333,151.1908,1.18868,3401.06997,596.6271,17.33023
+"4598","YDR121W",5,117,9,29.8638,0.81132,0.20093,1.72996,5.74458,2897.78345,536.4575,1.25418,0.59347,154.57216,1.43896,3540.68139,544.68475,15.41552
+"4599","YDR121W",17,117,9,21.6358,0.79696,0.18669,1.84499,4.86729,2711.42458,435.02902,1.09286,0.61685,112.58226,1.41224,2793.4775,422.85548,14.09238
+"4600","YDR121W",29,117,9,17.9551,0.80183,0.18978,1.57655,4.53098,2724.71332,405.95037,1.09695,0.55735,87.5353,1.14861,2736.82253,376.66747,14.21955
+"4601","YDR121W",41,117,9,18.45895,0.84042,0.19299,1.56841,4.04461,2797.81357,402.72203,1.13911,0.64805,82.63126,1.16988,2526.70466,361.93419,14.27893
+"4602","YDR121W",53,117,9,19.10422,0.84617,0.19357,1.64783,4.53053,2606.47061,367.28911,1.02881,0.66278,80.73713,1.19502,2382.61954,327.10897,16.44039
+"4603","YDR121W",65,117,9,17.9348,0.8115,0.18983,1.53445,2.85359,2571.5595,375.0897,1.03038,0.55109,81.2804,1.15938,2373.35151,311.68584,17.25824
+"4604","YDR121W",77,117,9,20.90493,0.84697,0.19702,1.73415,4.48903,3053.30516,453.13908,1.20667,0.58175,92.90473,1.27524,2920.97389,483.00911,15.06305
+"4605","YDR121W",89,117,9,30.94894,0.86116,0.20161,1.75024,5.42892,3378.00868,531.32679,1.30278,0.61438,118.22575,1.28947,3500.87609,605.43079,16.80014
+"4606","YDR122W",7,117,9,28.62607,0.85379,0.20208,1.63496,57.28287,2920.47761,510.44602,1.28493,0.46706,192.28777,1.27807,3218.65901,482.91002,15.16586
+"4607","YDR122W",19,117,9,24.9572,0.85266,0.19682,1.66482,10.79476,2711.80393,489.14546,1.11919,0.46551,193.74073,1.26921,3070.48318,471.06991,14.45012
+"4608","YDR122W",31,117,9,20.14794,0.87592,0.19875,1.63252,5.43938,2677.58743,453.06409,1.04584,0.48441,170.16085,1.16762,2686.10754,400.16129,14.34411
+"4609","YDR122W",43,117,9,13.52965,0.86258,0.19601,1.4526,3.73789,2512.12505,405.49909,0.97527,0.57803,152.23297,1.0725,2442.63011,308.27644,13.68246
+"4610","YDR122W",55,117,9,16.42937,0.85703,0.19698,1.47758,3.68261,2296.85511,376.89331,0.90114,0.50928,154.84366,1.12383,2261.16657,307.14452,15.85367
+"4611","YDR122W",67,117,9,17.39046,0.83578,0.1939,2.0508,3.84027,2375.92446,385.42271,0.94052,0.4209,161.40092,1.31798,2378.84759,342.8107,14.9392
+"4612","YDR122W",79,117,9,25.9247,0.87375,0.20271,2.43737,4.41698,2965.96199,526.53459,1.11084,0.43739,197.883,1.42585,3280.59425,532.80583,16.06173
+"4613","YDR122W",91,117,9,42.47712,0.90275,0.21589,2.85203,10.66961,3303.1133,593.45481,1.27477,0.44411,235.58256,1.47249,3651.96907,624.07149,17.95604
+"4614","YDR123C",8,117,9,30.59322,1.30959,0.05235,3.41257,15.57435,2230.234,357.41364,1.60658,1.25325,22.40779,1.38706,2414.39213,631.93729,43.42724
+"4615","YDR123C",20,117,9,17.8395,1.31063,0.05519,3.44009,8.95555,2273.06585,337.67234,1.4986,1.20209,22.89341,1.27839,2336.64659,425.14469,42.29899
+"4616","YDR123C",32,117,9,33.81544,1.12133,0.22788,2.91971,8.68668,3025.39091,366.74499,1.38081,0.72665,19.4869,1.35144,2516.07412,498.49073,25.86284
+"4617","YDR123C",44,117,9,2.39794,1.13998,0.10385,2.90538,7.38488,2255.6539,301.92847,1.1823,1.02813,22.7813,4.19915,2040.03152,371.09145,32.3104
+"4618","YDR123C",68,117,9,21.25235,1.06515,0.14429,3.30867,5.11691,2379.29337,298.98108,1.3152,0.74114,13.23901,1.59866,2195.93612,339.49061,28.53334
+"4619","YDR123C",80,117,9,72.8479,1.32689,0.04376,4.93003,9.95296,2232.84969,341.2583,1.49079,0.77334,29.24343,1.85931,2240.68976,569.82728,61.47138
+"4620","YDR123C",92,117,9,54.39554,1.19585,0.12039,5.09233,9.13521,2782.13103,431.81861,1.7275,0.74143,51.1117,2.24607,3006.51964,828.65561,41.02672
+"4625","YDR124W",9,117,9,27.80649,0.8037,0.19263,1.71639,7.60637,3313.31789,467.45537,1.34844,0.62617,149.44539,1.26616,3074.2432,476.6594,15.8092
+"4626","YDR124W",21,117,9,27.59518,0.78176,0.18714,1.65394,6.18642,3051.62154,453.5563,1.24977,0.4787,151.80962,1.20665,2912.05712,430.7561,15.76075
+"4627","YDR124W",33,117,9,18.6174,0.77668,0.18781,1.56816,3.7588,2884.42073,410.97425,1.15416,0.44367,133.80099,1.04846,2651.76949,374.59124,14.0369
+"4628","YDR124W",45,117,9,14.79884,0.7788,0.18846,1.54305,5.23667,2721.62002,356.39758,1.1386,0.7367,109.22142,0.99091,2261.49382,315.74177,14.01738
+"4629","YDR124W",57,117,9,14.99484,0.82176,0.19037,1.58207,3.95958,2750.1415,351.68071,1.11596,0.67001,123.61515,1.06417,2248.95753,296.61188,14.46963
+"4630","YDR124W",69,117,9,18.36684,0.80632,0.18937,1.61793,4.53003,2888.8033,381.67307,1.14492,0.60245,135.23651,1.11858,2447.33317,363.56363,13.98704
+"4631","YDR124W",81,117,9,24.97952,0.80542,0.1952,2.17475,4.7668,3226.07231,449.26841,1.24637,0.48132,159.6788,1.26568,3073.7458,544.24568,15.15324
+"4632","YDR124W",93,117,9,33.96414,0.87289,0.20374,2.34291,5.57554,3761.46067,548.9936,1.39845,0.47917,166.4663,1.30555,3655.63179,637.99695,15.93903
+"4633","YDR125C",10,117,9,51.39253,0.88144,0.208,2.20612,6.21768,2668.84013,518.76225,1.39046,0.52096,270.32705,1.71491,3419.47755,493.31585,16.83372
+"4634","YDR125C",22,117,9,45.94938,0.88153,0.21007,1.89082,7.7188,2556.17824,520.49592,1.29658,0.9627,252.93327,1.44403,3475.77982,499.06949,16.34485
+"4635","YDR125C",34,117,9,27.63613,0.88573,0.19906,1.68507,5.45002,2634.81806,475.20618,1.30246,0.57922,234.92198,1.18384,3246.50335,464.24229,14.8551
+"4636","YDR125C",46,117,9,22.90922,0.85932,0.19292,1.60824,4.46185,2321.62074,401.81479,1.19998,0.58317,201.1833,1.12733,2616.1756,304.50288,13.70395
+"4637","YDR125C",58,117,9,17.02845,0.88599,0.19706,1.51188,4.24933,2295.1349,429.40848,1.06971,0.64307,193.96809,1.2177,2708.34214,305.01555,14.10544
+"4638","YDR125C",70,117,9,29.73791,0.8998,0.19539,1.64302,4.79798,2608.92457,490.45782,1.2783,0.66137,256.28361,1.33593,3290.83058,481.75464,14.74881
+"4639","YDR125C",82,117,9,34.89569,0.88896,0.20699,1.76083,5.34227,2949.82953,547.94829,1.38987,0.51596,264.75757,1.23666,3674.29381,619.53507,15.3507
+"4640","YDR125C",94,117,9,41.72779,0.89295,0.21,2.2181,42.73768,2962.44142,609.67781,1.47482,0.48698,320.48424,1.43914,4079.06012,705.65766,17.2647
+"4641","YDR126W",2,118,10,56.69727,0.62906,0.12798,2.61516,9.13874,2458.38741,429.93844,1.31528,0.77673,155.53527,3.81845,2950.88121,387.96499,16.13974
+"4642","YDR126W",14,118,10,42.97849,0.56473,0.1236,5.58124,6.98968,2087.67659,316.81586,1.16023,0.53277,118.63248,2.87054,2337.49867,274.78628,16.4811
+"4643","YDR126W",26,118,10,42.58793,0.52684,0.11772,2.95675,7.40523,1992.0458,282.40215,1.16418,0.53273,101.82358,4.54988,2176.2113,247.05995,14.47853
+"4644","YDR126W",38,118,10,45.90361,0.58369,0.12335,1.60776,6.9112,2228.80765,339.54465,1.17908,0.45597,138.62503,1.65557,2634.61636,330.75612,14.68909
+"4645","YDR126W",50,118,10,40.11373,0.55617,0.11961,1.64168,5.90471,1984.79277,292.18908,1.0692,0.61508,115.2199,1.63834,2203.43463,264.21376,13.58348
+"4646","YDR126W",62,118,10,37.10971,0.55455,0.11906,1.46005,5.38521,1891.05885,272.07777,1.02453,0.67776,109.12411,0.9051,2057.87412,202.78678,13.30608
+"4647","YDR126W",74,118,10,41.57518,0.58158,0.12418,1.50056,5.22768,2076.88879,303.54854,1.09007,0.44411,124.02338,1.09644,2328.13934,274.10049,14.13556
+"4648","YDR126W",86,118,10,44.80607,0.57908,0.11988,1.65165,13.33096,1873.8837,264.75809,1.0342,0.60837,111.04194,1.57627,2094.88496,190.51015,14.92752
+"4649","YDR127W",3,118,10,21.42524,0.8483,0.18572,3.55942,10.03692,2691.28357,450.86904,1.28634,0.63503,167.68026,10.88965,3125.62018,358.79684,16.36929
+"4650","YDR127W",15,118,10,10.82361,0.78838,0.1793,1.53778,5.66645,2399.17738,366.49902,0.94763,0.6622,119.95518,1.35451,2716.13915,286.21196,13.68049
+"4651","YDR127W",27,118,10,10.98296,0.77981,0.18479,1.46701,5.67062,2454.67244,372.11659,1.00379,0.60782,123.08067,1.36909,2742.8586,263.98368,12.99243
+"4652","YDR127W",39,118,10,9.97196,0.79441,0.1851,1.45976,6.16485,2522.60453,372.09953,0.98518,0.74889,133.01571,1.30736,2756.31235,302.24518,13.29894
+"4653","YDR127W",51,118,10,6.24994,0.77496,0.18126,1.41109,5.76081,2191.08884,334.08689,0.88497,0.60954,125.48266,1.14854,2500.07919,227.45454,13.02928
+"4654","YDR127W",63,118,10,6.8203,0.77443,0.18028,2.62304,5.07108,2227.48122,323.06508,0.84715,0.72726,118.92836,1.17783,2492.76449,215.34281,13.16177
+"4655","YDR127W",75,118,10,8.87893,0.78064,0.18242,1.59222,7.67653,2388.68344,332.01791,0.92749,0.84376,114.28855,1.22265,2593.69138,261.34568,13.48295
+"4656","YDR127W",87,118,10,9.82847,0.82088,0.18399,1.51833,6.03374,2332.9043,326.61842,0.91578,0.67092,111.13817,1.63382,2540.50996,211.72763,14.02882
+"4657","YDR128W",4,118,10,16.4998,0.72533,0.19017,1.78726,8.78634,3397.43739,509.28975,1.10142,0.53325,97.51313,2.09234,3546.03016,393.00981,14.66103
+"4658","YDR128W",16,118,10,8.56374,0.63626,0.18088,1.34423,5.59122,2905.53826,386.67035,0.92215,0.3806,67.37573,1.23605,2753.62364,277.86336,13.00512
+"4659","YDR128W",28,118,10,12.20261,0.68182,0.18922,1.53389,6.83292,3199.19581,399.90802,0.98872,0.56734,72.5459,1.31542,2959.33985,308.30814,14.29124
+"4660","YDR128W",40,118,10,13.99361,0.65618,0.18384,1.53142,8.34449,3019.20532,389.06746,0.97174,0.40201,79.63178,1.83512,2891.68983,311.80338,13.31084
+"4661","YDR128W",52,118,10,13.1588,0.67406,0.19077,1.42094,8.60774,2933.72078,370.82611,0.9772,0.71803,69.07928,1.67903,2675.19024,283.50564,14.03684
+"4662","YDR128W",64,118,10,11.01978,0.67155,0.18432,1.49524,6.5399,2817.5437,341.3531,0.88836,0.54906,67.23028,1.57458,2589.55217,253.25899,13.61073
+"4663","YDR128W",76,118,10,12.61065,0.69017,0.18993,1.68217,6.37988,2938.43436,369.27416,0.92201,0.5489,81.09121,1.9559,2784.407,283.17968,14.16965
+"4664","YDR128W",88,118,10,14.73047,0.67873,0.18553,1.9512,6.58766,2853.67387,354.51347,0.89172,0.56845,71.4476,1.69262,2713.1734,254.83098,14.55559
+"4665","YDR129C",5,118,10,17.99717,0.73118,0.17892,1.52407,7.14644,2990.97969,392.63648,1.21826,0.45192,86.31981,1.49598,2932.91837,285.07853,13.91396
+"4666","YDR129C",17,118,10,10.81148,0.71591,0.17497,1.40034,5.99271,2800.88832,359.61242,1.17231,0.52123,82.23268,1.00381,2731.94513,316.00386,13.70978
+"4667","YDR129C",29,118,10,12.33245,0.69675,0.17903,1.45482,7.04276,2718.67923,339.49724,1.16413,0.84699,87.58426,1.20709,2646.67243,284.2731,14.21372
+"4668","YDR129C",41,118,10,11.59436,0.66782,0.17206,1.53147,5.45181,2624.03903,313.11541,1.11254,0.56267,82.15493,1.85534,2517.85423,232.9707,13.85841
+"4669","YDR129C",53,118,10,22.92496,0.71572,0.18037,1.97334,7.94361,2686.96429,353.88607,1.22117,0.6175,100.90125,4.25715,2884.01262,306.46569,15.48397
+"4670","YDR129C",65,118,10,13.04916,0.69684,0.17503,2.56325,13.32115,2553.09061,341.19562,1.20422,0.44793,96.04893,4.87363,2685.20849,296.36332,14.51642
+"4671","YDR129C",77,118,10,14.49087,0.71555,0.18169,1.71875,5.48021,2529.17764,330.45862,1.13383,0.43689,98.86568,1.79295,2663.34782,259.74084,14.26327
+"4672","YDR129C",89,118,10,10.52664,0.71234,0.17689,1.83109,7.26447,2580.7759,295.41539,1.16339,0.56341,74.65303,3.09424,2334.09371,207.31353,14.42748
+"4673","YDR130C",7,118,10,16.36937,0.82925,0.19635,2.40122,6.57076,2969.78355,440.89072,1.24161,0.52947,99.26603,3.47502,3305.61263,337.25282,15.0363
+"4674","YDR130C",19,118,10,12.13446,0.78273,0.19382,1.56216,5.95572,2660.7832,405.47215,1.07934,0.50177,83.3014,1.94594,3001.11898,268.55537,14.92488
+"4675","YDR130C",31,118,10,19.02177,0.78748,0.19576,1.89266,7.50751,2748.59332,395.85114,1.15346,0.66921,94.14747,3.04115,3077.84972,320.00019,15.86177
+"4676","YDR130C",43,118,10,11.77752,0.76242,0.18991,1.46658,6.90835,2542.55268,368.22765,1.04364,0.72685,94.93012,1.51111,2873.65881,289.05712,14.3756
+"4677","YDR130C",55,118,10,9.79638,0.79379,0.19517,1.45626,6.54669,2476.69979,369.72011,1.00197,0.44717,92.12516,2.34931,2790.8344,258.68952,14.22792
+"4678","YDR130C",67,118,10,46.66202,0.79261,0.19594,1.96655,9.70529,2432.25659,354.82771,1.02467,0.79694,97.47048,3.46787,2743.63466,240.81545,20.10295
+"4679","YDR130C",79,118,10,18.1301,0.81616,0.20071,5.51754,11.92613,2567.00442,380.41256,1.32989,0.79163,95.00215,11.0512,2876.9751,266.9902,16.22499
+"4680","YDR130C",91,118,10,17.32618,0.85364,0.19686,21.6148,9.41566,2728.28589,400.95047,1.19465,1.25188,94.35192,6.27861,3216.52907,291.3518,15.80447
+"4681","YDR131C",8,118,10,15.86847,0.78699,0.19566,2.66561,6.82801,2834.8495,434.41981,1.21229,0.53302,72.20244,4.46343,3116.09204,292.98777,15.44197
+"4682","YDR131C",20,118,10,14.57269,0.79461,0.19163,2.04571,5.95952,2702.26093,382.42403,1.09188,0.48761,59.19325,4.43721,2995.03431,282.29226,14.91859
+"4683","YDR131C",32,118,10,12.00152,0.74022,0.18294,1.38157,5.92044,2620.17001,356.4832,1.01545,0.55772,62.34339,1.25678,2789.58272,219.8117,13.89441
+"4684","YDR131C",44,118,10,15.65661,0.78457,0.19521,1.5523,6.39419,2728.34291,398.25508,1.0515,0.54064,75.32664,1.66799,3008.26553,322.66253,15.74484
+"4685","YDR131C",56,118,10,11.16667,0.79639,0.19159,1.54022,36.06145,2610.3681,392.67443,1.08401,0.50488,81.5535,1.47776,3097.45793,306.54198,14.6272
+"4686","YDR131C",68,118,10,13.35818,0.79403,0.19214,1.80182,10.03499,2747.24627,408.90674,1.06954,0.61914,76.25057,2.02261,3144.54512,327.54358,14.26611
+"4687","YDR131C",80,118,10,9.96764,0.79715,0.19174,24.68564,7.74434,2642.45387,360.15726,1.19923,0.61015,58.41853,10.80706,2729.91186,248.50093,26.09946
+"4688","YDR131C",92,118,10,10.01868,0.78437,0.18441,1.67948,5.67451,2645.74625,348.31263,1.01989,0.4802,58.0104,2.35883,2754.43266,247.28231,14.3908
+"4689","YDR132C",9,118,10,14.88305,0.78987,0.19205,3.70559,6.10002,2939.22076,430.5877,1.36842,0.47378,98.51944,7.29796,3234.38914,313.88593,16.28694
+"4690","YDR132C",21,118,10,11.12218,0.74953,0.18998,1.52116,6.53113,2661.95839,375.15014,1.073,0.58366,95.54645,1.66139,2909.8761,277.94138,13.82423
+"4691","YDR132C",33,118,10,10.1323,0.73383,0.18474,1.74711,6.08836,2799.13862,382.54181,1.08518,0.47388,89.30924,1.27507,2890.99561,255.82419,13.37471
+"4692","YDR132C",45,118,10,10.39031,0.72881,0.18421,1.44009,5.4582,2750.469,382.77674,1.09243,0.49849,84.94711,1.57735,2957.09673,258.65385,14.02256
+"4693","YDR132C",57,118,10,8.58925,0.73431,0.18357,1.43243,4.42452,2545.54108,330.93977,1.01524,0.49682,72.93845,1.30745,2530.45682,200.94597,13.80404
+"4694","YDR132C",69,118,10,10.57513,0.75122,0.18711,1.58638,5.73228,2622.53079,341.62207,1.03688,0.58673,74.00079,2.05248,2755.15168,215.81713,14.24908
+"4695","YDR132C",81,118,10,13.29296,0.77413,0.19024,1.58728,6.27507,2691.4695,359.8613,1.04806,0.79666,82.33837,1.82518,2694.41459,258.72982,14.56584
+"4696","YDR132C",93,118,10,21.67546,0.78861,0.19238,3.45977,7.23479,2831.56368,380.31227,1.08152,0.61104,76.77422,1.8326,2965.04925,252.2465,17.45388
+"4697","YDR133C",10,118,10,14.22613,0.87773,0.21025,4.5339,9.42564,2697.10721,431.82734,1.23113,0.53703,82.36182,4.84219,3075.77762,301.76316,15.19298
+"4698","YDR133C",22,118,10,10.59307,0.84792,0.19773,1.73787,8.18055,2613.44886,375.90804,1.16506,0.61464,68.86047,2.41306,2871.1975,245.25406,14.00183
+"4699","YDR133C",34,118,10,13.0093,0.86373,0.20108,1.72879,8.49433,2724.29609,411.9553,1.18011,0.67227,80.51711,1.73672,3146.66302,300.26622,13.91558
+"4700","YDR133C",46,118,10,14.29324,0.84382,0.19567,1.60195,6.24812,2662.66969,377.41384,1.14071,0.44295,68.97136,2.05869,2833.97629,280.0754,14.12062
+"4701","YDR133C",58,118,10,11.34919,0.81932,0.19109,2.07656,5.94777,2370.81165,345.33386,1.10369,0.6259,66.18183,3.58132,2604.02879,195.15978,14.44797
+"4702","YDR133C",70,118,10,14.65849,0.83179,0.18825,1.67754,9.68912,2489.31456,349.44084,1.12241,0.82029,63.70362,3.07176,2687.07977,231.1281,14.6207
+"4703","YDR133C",82,118,10,13.59417,0.88297,0.1987,1.73726,6.29478,2695.42414,414.64959,1.16511,0.57939,84.72046,2.51684,3279.5807,281.36439,15.49926
+"4704","YDR133C",94,118,10,18.24018,0.87829,0.19509,2.56941,5.67472,2684.7851,393.74032,1.26619,0.47287,67.46976,5.79383,3014.56809,256.77782,17.38512
+"4705","YDR134C",2,119,10,22.11437,0.81106,0.1939,1.95308,5.89852,3046.52856,500.02872,1.24027,0.54808,109.80716,2.51679,3521.67309,287.80284,15.61369
+"4706","YDR134C",14,119,10,13.69996,0.76869,0.18476,1.95491,5.62734,2738.59312,396.77957,1.11892,0.4938,71.2074,2.60866,2975.12105,211.83188,14.39701
+"4707","YDR134C",26,119,10,12.10693,0.78974,0.19705,1.9952,6.54863,2799.50852,396.17164,1.14677,0.46387,87.17983,1.73344,2983.22338,245.78376,15.59277
+"4708","YDR134C",38,119,10,13.5895,0.76597,0.19055,1.6246,5.58727,2801.53255,399.39352,1.10381,0.37549,82.81662,1.64572,2973.91647,263.25044,13.7567
+"4709","YDR134C",50,119,10,14.299,0.79763,0.19489,1.55842,6.14427,2724.5489,372.67128,1.0794,0.85296,77.42022,1.46148,2930.18539,249.95779,13.72039
+"4710","YDR134C",62,119,10,11.86929,0.77377,0.1884,1.47006,6.32216,2599.05612,347.40356,1.01501,0.77635,71.51688,1.20216,2708.06291,252.1696,13.76644
+"4711","YDR134C",74,119,10,11.51773,0.80175,0.19759,1.53767,35.56727,2636.1039,376.68437,1.12952,0.67967,96.24009,1.33337,2867.42706,247.1379,15.17225
+"4712","YDR134C",86,119,10,26.01945,0.78755,0.18908,1.81127,6.17948,2575.22421,354.30346,1.05539,0.49913,84.89629,1.42172,2719.13315,200.71201,14.14652
+"4713","YDR135C",3,119,10,22.0525,0.85885,0.19769,1.74319,5.86742,3018.93896,520.99246,1.20266,0.46698,121.74114,2.12452,3620.75392,379.11134,15.37189
+"4714","YDR135C",15,119,10,14.51728,0.78705,0.18693,1.66714,5.23178,2579.92345,399.32839,1.07572,0.53027,93.06525,1.82207,2869.77347,264.98256,14.28159
+"4715","YDR135C",27,119,10,13.43016,0.78691,0.19032,1.74152,5.84896,2768.58811,417.4613,1.07698,0.4763,76.90715,1.6253,3009.83881,279.1532,13.8087
+"4716","YDR135C",39,119,10,13.94622,0.79352,0.19332,1.78914,5.77161,2655.2345,418.17807,1.10299,0.39149,107.85305,1.84009,3048.46569,296.93109,13.8532
+"4717","YDR135C",51,119,10,12.75497,0.8183,0.19724,3.67882,7.1233,2657.45299,416.51236,1.05989,1.0023,102.5267,1.89975,3157.94209,289.42721,15.20939
+"4718","YDR135C",63,119,10,12.56266,0.79591,0.19619,1.49414,5.66973,2571.14448,367.14888,1.02456,0.58472,83.43429,1.12873,2819.76726,230.43828,14.07253
+"4719","YDR135C",75,119,10,11.01128,0.8185,0.1968,1.58801,6.96689,2568.49431,386.35753,1.00918,0.46358,95.61736,1.30062,2848.61957,236.24621,14.26982
+"4720","YDR135C",87,119,10,11.66621,0.8272,0.19672,1.63968,5.91067,2638.96399,376.46009,1.03866,0.51013,88.1044,1.80511,2835.81151,236.58133,15.06697
+"4721","YDR136C",4,119,10,36.51479,1.01884,0.14247,1.73696,6.31761,3123.46082,404.58959,1.47331,0.64457,172.24483,1.54346,3120.71101,383.32026,15.20108
+"4722","YDR136C",16,119,10,27.9826,0.9617,0.14108,1.62805,8.09325,2637.1003,326.24944,1.36531,0.60581,136.80954,2.00586,2558.53306,261.29337,14.82398
+"4723","YDR136C",28,119,10,34.70313,0.94574,0.14089,2.64447,6.22396,2717.70444,315.44083,1.36467,0.60224,127.8236,1.83249,2525.19533,233.84053,13.85636
+"4724","YDR136C",40,119,10,29.38889,0.97758,0.14984,1.762,6.52635,2707.024,347.20236,1.36412,0.61929,155.21782,1.38023,2916.94762,322.55362,14.67247
+"4725","YDR136C",52,119,10,24.47102,0.92406,0.1402,3.02855,4.578,2569.6574,288.90564,1.2864,0.59092,112.12403,1.0858,2393.77714,217.35706,14.78591
+"4726","YDR136C",64,119,10,26.95475,0.97563,0.14291,1.74876,5.61788,2571.27336,284.96461,1.24469,0.66981,110.11715,0.95798,2398.39987,216.64658,14.02749
+"4727","YDR136C",76,119,10,26.44963,0.96284,0.14763,1.54553,5.58304,2624.20429,306.96487,1.23583,0.91723,119.91329,1.07505,2559.90942,221.05564,14.2983
+"4728","YDR136C",88,119,10,50.94583,1.00421,0.14372,2.14868,5.81369,2782.98095,315.04489,1.41851,0.61843,126.16606,1.44815,2588.9105,195.28652,15.49001
+"4729","YDR137W",5,119,10,25.66561,0.83905,0.19316,1.79809,6.34958,2833.5811,446.83636,1.03829,0.53756,126.14709,2.08657,3109.28315,329.00835,16.14341
+"4730","YDR137W",17,119,10,11.62252,0.77312,0.18416,1.68077,6.09345,2612.05415,371.64575,0.94045,0.6842,98.8918,1.59505,2700.15839,287.63528,13.61381
+"4731","YDR137W",29,119,10,11.31141,0.78538,0.19228,1.77067,5.17531,2603.75015,382.81837,0.95292,0.466,107.60997,1.62041,2755.66518,256.75899,13.64971
+"4732","YDR137W",41,119,10,11.49348,0.77012,0.19069,1.51785,5.52022,2527.02906,352.90173,0.92193,0.4227,104.46394,1.63466,2691.79797,246.4972,13.80132
+"4733","YDR137W",53,119,10,18.58097,0.78752,0.188,4.45115,6.40413,2447.09733,347.35283,0.92481,0.46492,92.04446,1.96713,2581.97881,248.50951,14.17443
+"4734","YDR137W",65,119,10,11.50082,0.84542,0.19631,1.71351,5.09632,2651.55985,385.04829,0.91119,0.45179,111.01267,1.36655,2971.22674,290.10025,14.53608
+"4735","YDR137W",77,119,10,9.39817,0.81552,0.19234,1.45421,5.59777,2488.69358,357.4913,0.87936,0.4821,99.89842,1.35777,2763.63249,225.85917,13.68857
+"4736","YDR137W",89,119,10,23.34163,0.82566,0.19175,2.00196,6.40325,2487.6688,361.65968,0.9709,0.74036,106.43606,1.64409,2741.80764,236.21746,16.36931
+"4737","YDR139C",8,119,10,12.4234,0.86535,0.19547,1.61242,5.32548,2947.26071,442.15191,1.21885,0.49165,73.77202,1.72128,3267.94183,314.09077,14.73305
+"4738","YDR139C",20,119,10,7.99851,0.78676,0.18677,1.453,5.18989,2647.3606,366.58355,1.13629,0.40042,58.40241,1.32848,2800.83452,227.24236,13.56707
+"4739","YDR139C",32,119,10,11.45355,0.8227,0.19652,1.62545,5.14114,2770.23311,379.83184,1.13556,0.45377,57.99583,1.62,2947.83601,253.09337,14.37011
+"4740","YDR139C",44,119,10,14.90381,0.84445,0.20159,1.60426,4.94381,2892.67935,412.9993,1.1544,0.46123,70.63094,1.68765,3098.40138,274.00936,15.01569
+"4741","YDR139C",56,119,10,12.32277,0.82885,0.20041,1.61102,4.32462,2605.94546,387.73621,1.04598,0.37093,71.50979,1.41743,3024.7494,256.75455,14.89468
+"4742","YDR139C",68,119,10,14.52652,0.81973,0.19667,1.74891,4.00258,2553.93388,364.43357,1.04625,0.45347,76.26514,2.30316,2913.99411,271.9348,15.54012
+"4743","YDR139C",80,119,10,12.14188,0.83872,0.19176,1.45048,5.0313,2670.63224,365.34738,1.0747,0.55145,60.98214,1.28054,2944.11732,240.88854,15.08452
+"4744","YDR139C",92,119,10,61.16851,0.82771,0.1956,2.5704,5.70746,2672.2536,367.43396,1.17657,0.50676,76.88443,1.67238,2941.3236,226.76716,15.84432
+"4745","YDR140W",9,119,10,19.51858,0.85776,0.1939,1.77998,5.71095,2907.01775,441.36998,1.26913,0.39707,69.04901,1.85634,3241.23671,292.08638,15.54317
+"4746","YDR140W",21,119,10,16.0813,0.86052,0.18955,1.57206,4.96731,2806.2696,427.24662,1.19328,0.50382,79.43604,1.53137,3355.39814,315.85266,14.96341
+"4747","YDR140W",33,119,10,15.07105,0.80482,0.18885,1.62669,5.85618,2740.7943,408.01947,1.16342,0.46192,68.60039,1.64992,3110.94057,268.76101,14.01663
+"4748","YDR140W",45,119,10,14.58548,0.82387,0.19523,1.95142,5.07736,2691.68145,379.2368,1.15141,0.54724,69.38863,1.82789,3011.80099,281.90777,14.39777
+"4749","YDR140W",57,119,10,18.17031,0.84846,0.20122,1.55383,9.57508,2650.47153,375.53,1.19073,0.46632,66.66145,1.59769,2976.35156,247.92094,15.06182
+"4750","YDR140W",69,119,10,12.46229,0.83,0.18941,1.46659,4.12877,2593.3454,356.71571,1.06809,0.45684,61.87887,1.27349,2834.87236,208.40954,14.09191
+"4751","YDR140W",81,119,10,35.09974,0.87586,0.1988,1.58661,4.62826,2779.93644,397.91427,1.15665,0.44009,74.46327,1.36222,3175.77995,260.04452,18.48485
+"4752","YDR140W",93,119,10,29.03513,0.88273,0.19925,2.1965,5.13098,2821.0611,398.27676,1.20716,0.53747,71.10874,2.02944,3109.74675,240.13424,16.17458
+"4753","YDR142C",10,119,10,12.29678,0.74418,0.17773,1.68164,4.77997,3086.76463,376.06447,1.22834,0.37166,46.09895,1.86614,2924.18006,252.36563,13.80813
+"4754","YDR142C",22,119,10,15.96883,0.775,0.1842,1.53573,4.64328,3170.39974,405.77225,1.26537,0.56393,57.70368,1.39678,3197.41572,324.29111,14.31839
+"4755","YDR142C",34,119,10,14.56029,0.73164,0.18077,1.53129,6.05142,3017.84797,374.89349,1.18194,0.51451,52.30073,1.34187,2935.93769,268.4881,13.94318
+"4756","YDR142C",46,119,10,13.15092,0.71919,0.1815,1.73719,5.14294,2853.92095,352.79973,1.12372,0.5276,50.7794,1.52495,2832.28117,260.86561,13.60252
+"4757","YDR142C",58,119,10,7.38424,0.71404,0.1757,1.61623,4.1126,2694.02208,313.14698,1.03664,0.43201,39.98346,1.22615,2545.72703,196.31211,12.8815
+"4758","YDR142C",70,119,10,10.70388,0.74724,0.18311,1.60433,4.48922,2844.09695,332.64627,1.13054,0.58434,42.90992,1.7792,2735.56803,238.9713,13.9377
+"4759","YDR142C",82,119,10,11.06017,0.72906,0.17996,1.46191,3.96005,2675.38555,312.85974,1.04623,0.61605,51.97431,1.22978,2542.20462,211.96756,13.7363
+"4760","YDR142C",94,119,10,23.79331,0.82178,0.18688,1.56631,4.62954,3118.41278,398.71913,1.19505,0.45563,62.72027,1.58675,3219.42884,307.01553,16.00727
+"4761","YDR143C",2,120,10,35.996,0.70121,0.18468,1.59017,18.82035,2763.78672,466.51713,1.2176,0.4496,123.30179,1.46862,3273.2582,357.03056,15.01346
+"4762","YDR143C",14,120,10,13.84791,0.67625,0.17953,1.42156,4.17242,2399.78844,387.6604,1.08065,0.46988,98.76628,1.06741,2771.15848,257.81645,13.6461
+"4763","YDR143C",26,120,10,11.43552,0.6854,0.18077,2.13913,5.30095,2622.96361,387.33204,1.14645,0.46489,77.32851,1.12372,2888.4524,258.92466,13.4462
+"4764","YDR143C",38,120,10,11.15444,0.6813,0.18472,1.57556,5.34079,2682.46887,377.85056,1.13959,0.57366,80.06524,1.20964,2875.23901,277.99077,13.3794
+"4765","YDR143C",50,120,10,8.19214,0.72712,0.19154,2.84024,6.10776,2592.9355,379.85176,1.15233,0.5971,74.61441,1.41074,2838.54158,250.86412,13.63557
+"4766","YDR143C",62,120,10,7.17324,0.72019,0.18359,1.91145,4.47954,2540.76107,350.64703,1.09199,0.50831,71.58664,1.67344,2760.83261,221.00417,13.3345
+"4767","YDR143C",74,120,10,11.97978,0.72916,0.18997,1.61252,4.59231,2467.94442,366.65827,1.08219,0.43248,99.17715,1.29649,2732.88648,237.40875,13.7748
+"4768","YDR143C",86,120,10,13.30819,0.72579,0.18735,1.455,4.05193,2272.27945,353.71067,1.00898,0.51902,103.15456,1.31736,2715.53721,224.50797,14.48717
+"4769","YDR144C",3,120,10,26.12813,0.861,0.21294,1.62823,4.66452,3182.30595,571.8274,1.21536,0.41022,186.88955,1.42273,3958.70281,406.79638,16.30375
+"4770","YDR144C",15,120,10,7.87834,0.81276,0.1994,1.53381,3.92609,2659.3927,468.94467,1.05555,0.43273,171.19666,1.29188,3416.45583,318.18864,14.14565
+"4771","YDR144C",27,120,10,10.28852,0.78803,0.2044,1.57194,4.20932,2721.14262,465.44378,1.09587,0.38978,161.85919,1.37086,3380.77987,298.11541,14.24474
+"4772","YDR144C",39,120,10,8.95595,0.82017,0.21096,2.16875,5.21613,2792.96195,465.67113,1.07069,0.44018,160.6746,1.43047,3514.79214,317.94177,14.72586
+"4773","YDR144C",51,120,10,7.59073,0.82575,0.20809,1.55295,4.03876,2678.6887,442.97288,1.02389,0.4724,151.29326,1.35915,3240.1058,306.37186,14.54075
+"4774","YDR144C",63,120,10,4.82502,0.827,0.2043,1.56958,4.27859,2669.51989,410.63586,1.0462,0.42447,135.30421,1.34347,3114.18743,224.93969,14.53704
+"4775","YDR144C",75,120,10,7.2546,0.85543,0.21454,1.60117,3.90052,2609.44254,439.33112,1.02303,0.42646,155.61948,1.55066,3137.90155,249.72851,14.96069
+"4776","YDR144C",87,120,10,7.33673,0.83445,0.20514,1.53069,4.75558,2402.83034,409.63752,0.97854,0.41519,152.09496,1.39757,3088.66118,244.30125,15.01808
+"4777","YDR146C",4,120,10,36.3219,0.8678,0.19056,1.50532,3.75903,2679.71279,452.32722,1.23125,0.45637,128.22629,1.72797,3263.13709,330.72364,18.26299
+"4778","YDR146C",16,120,10,11.7977,0.85739,0.1897,1.43363,3.64536,2387.50205,390.70017,1.07938,0.45197,121.49979,1.07279,2898.33693,285.80156,14.01126
+"4779","YDR146C",28,120,10,8.51584,0.83659,0.18858,1.43034,3.39523,2442.68897,382.93541,1.0997,0.44348,114.17374,1.04421,2868.32572,236.3563,13.27236
+"4780","YDR146C",40,120,10,13.75677,0.85975,0.19933,1.56506,4.39122,2530.38883,418.59723,1.12181,0.39333,135.18189,1.17025,3211.06279,354.79194,14.11189
+"4781","YDR146C",52,120,10,10.31663,0.91671,0.20279,1.53346,3.87113,2529.31603,431.44726,1.15347,0.52118,131.167,1.14354,3289.80159,308.63455,14.60555
+"4782","YDR146C",64,120,10,9.23763,0.90432,0.19539,1.4561,3.35147,2419.2607,393.68246,1.04388,0.48187,114.66515,1.0787,3097.58079,250.00484,14.07016
+"4783","YDR146C",76,120,10,7.73019,0.8879,0.1977,1.46489,3.40293,2360.60216,387.48069,1.04218,0.46676,119.3714,1.26264,3011.47706,236.06769,14.26561
+"4784","YDR146C",88,120,10,9.38003,0.8972,0.20074,1.59735,3.15049,2268.57687,368.69732,0.99004,0.36628,105.83083,1.32842,2808.47576,200.54848,14.67052
+"5069","YDR338C",5,120,10,12.38503,0.86169,0.20275,1.38227,3.11346,2309.26792,470.92485,0.94866,0.39157,123.61826,1.27349,3176.21199,310.12445,14.9959
+"5070","YDR338C",17,120,10,9.54474,0.84585,0.20303,1.36794,3.7451,2125.86419,443.39497,0.89733,0.58232,120.38381,1.2683,3026.54725,310.01638,15.58995
+"5071","YDR338C",29,120,10,11.54751,0.8521,0.2086,1.47082,4.12787,2304.53303,449.54993,0.99575,0.44796,129.80597,1.3148,3209.78293,350.65255,14.77095
+"5072","YDR338C",41,120,10,23.72065,0.82297,0.20495,1.84576,4.39961,2114.47067,410.48685,2.05241,0.49697,115.89576,3.79686,3030.32699,302.09216,14.15978
+"5073","YDR338C",53,120,10,7.14111,0.8361,0.20121,1.39648,4.2191,2060.82593,409.87794,0.98322,0.61952,110.22711,1.32372,3050.25482,300.93229,13.88817
+"5074","YDR338C",65,120,10,7.20539,0.86753,0.20844,1.38506,3.28016,2180.0905,409.68219,0.89041,0.45721,115.98463,1.31022,3190.1518,300.62135,16.0637
+"5075","YDR338C",77,120,10,6.95355,0.87736,0.21323,1.3754,3.00209,2123.61308,424.74732,0.87429,0.48476,109.22309,1.34686,3028.55501,250.4103,14.83845
+"5076","YDR338C",89,120,10,9.37405,0.89324,0.20793,1.40508,3.97554,2181.1637,437.99914,0.89284,0.47438,119.2889,1.34166,3275.90759,310.46198,15.17823
+"5077","YDR340W",7,120,10,18.48327,0.78116,0.19126,1.5453,3.66275,2562.3011,438.99152,1.23446,0.48601,143.48031,1.1394,3254.4858,326.19012,14.61052
+"5078","YDR340W",19,120,10,15.6424,0.79829,0.19566,1.43976,3.85736,2375.52248,413.72775,1.06311,0.42082,132.93295,1.13338,3067.11047,312.71626,15.47855
+"5079","YDR340W",31,120,10,10.38838,0.74288,0.19212,1.41829,3.58642,2312.52123,381.93941,1.06708,0.47375,123.97637,1.08294,2884.3609,256.68114,13.69113
+"5080","YDR340W",43,120,10,28.11805,0.81516,0.19463,1.47196,3.28846,2396.54046,472.76967,1.08644,0.39262,156.90064,1.25545,3471.09413,355.88387,15.36642
+"5081","YDR340W",55,120,10,11.33177,0.78147,0.19146,1.37409,2.56644,2128.28491,366.66118,0.93149,0.42521,118.30627,1.12185,2833.62513,237.70236,13.73097
+"5082","YDR340W",67,120,10,11.77216,0.80277,0.19432,1.49011,2.96161,2337.19764,412.94506,1.02161,0.42051,137.62432,1.4442,3235.73263,298.26654,14.5889
+"5083","YDR340W",79,120,10,12.32605,0.79669,0.19318,1.43257,2.43248,2353.26151,413.06283,1.01017,0.42768,140.57302,1.2015,3294.56612,301.81919,14.70914
+"5084","YDR340W",91,120,10,7.15305,0.84672,0.19716,1.49867,2.44146,2394.0321,395.81237,1.03165,0.40063,117.55608,1.24973,3185.29861,237.46406,15.07794
+"5085","YDR344C",8,120,10,12.63815,1.09764,0.2128,1.5381,3.62811,2689.89815,453.64699,1.2473,0.45228,65.90027,1.38147,3254.57136,328.87228,13.94638
+"5086","YDR344C",20,120,10,11.78934,1.01365,0.20512,1.45351,3.49572,2428.27085,393.87869,1.13911,0.432,51.1624,1.25536,2914.68013,252.97665,13.49655
+"5087","YDR344C",32,120,10,11.97069,1.02479,0.20749,1.50229,3.01049,2445.33361,385.69033,1.13818,0.42716,52.09502,1.26709,2946.51143,216.24292,13.9984
+"5088","YDR344C",44,120,10,24.47688,1.01598,0.20871,1.5699,3.79787,2495.83929,407.00812,1.19923,0.42992,68.64805,1.62221,2962.92078,315.3111,14.63415
+"5089","YDR344C",56,120,10,11.45636,0.99586,0.20203,1.82212,2.47614,2254.528,360.79658,1.04301,1.07686,54.96136,1.22636,2736.2856,223.54277,13.83899
+"5090","YDR344C",68,120,10,13.10622,1.00851,0.20934,1.53273,6.1084,2372.79247,416.04514,1.08361,0.41547,77.01375,1.31151,3126.22404,305.86172,14.4422
+"5091","YDR344C",80,120,10,10.36382,0.9777,0.19833,1.42747,5.9719,2198.59306,376.205,1.03215,2.45357,62.84097,1.2325,2803.27013,223.66851,13.59259
+"5092","YDR344C",92,120,10,15.67318,1.01048,0.20606,1.55331,3.29179,2401.56979,428.93193,1.07201,0.41677,71.34027,1.30583,3181.19547,279.18317,14.7876
+"5093","YDR345C",9,120,10,9.94762,0.84242,0.19686,1.41831,5.39922,3028.29198,482.66506,1.00991,0.64168,110.69185,1.08709,3341.92961,350.19917,14.00247
+"5094","YDR345C",21,120,10,7.74055,0.80591,0.18752,1.41329,3.72507,2858.11902,410.21783,0.99078,0.44085,84.36956,0.99011,2928.48386,268.33908,13.518
+"5095","YDR345C",33,120,10,11.7236,0.86229,0.20047,1.43274,3.44918,3027.24419,465.2183,0.99493,0.40769,109.15795,1.10498,3340.64415,324.73707,14.18608
+"5096","YDR345C",45,120,10,11.61642,0.8123,0.18994,1.35336,3.19372,2841.82449,441.22713,0.9426,0.40356,93.7533,1.01358,3127.08181,270.34953,13.43324
+"5097","YDR345C",57,120,10,11.15327,0.81677,0.19413,1.37862,2.08493,2646.65197,363.74293,0.87185,0.4429,75.93632,0.97965,2617.08197,209.19108,13.67013
+"5098","YDR345C",69,120,10,10.18268,0.81977,0.19157,1.38848,3.51765,2734.86546,386.33156,0.92411,0.40505,81.99535,0.99416,2758.46903,241.38875,13.85503
+"5099","YDR345C",81,120,10,8.73903,0.85107,0.19557,1.426,2.49353,2836.87887,432.27691,0.8967,0.3967,98.49209,1.20348,3220.35893,287.3471,14.5062
+"5100","YDR345C",93,120,10,8.81323,0.84601,0.18551,1.52459,2.68021,2790.12153,403.74981,0.89418,0.38678,85.5171,1.34701,2965.74355,244.34952,13.87634
+"5101","YDR346C",10,120,10,8.41755,0.86518,0.19661,1.44591,5.66265,2438.29418,471.61152,1.29175,1.56049,143.89016,1.15233,3365.55655,267.86494,14.26777
+"5102","YDR346C",22,120,10,11.14129,0.90087,0.1965,1.49556,5.44412,2452.16083,471.68772,1.32966,1.44744,157.63946,1.14662,3620.54651,327.37012,14.57644
+"5103","YDR346C",34,120,10,12.38785,0.87048,0.19744,1.47205,6.35371,2370.39529,435.54954,1.27879,1.09628,146.34262,1.20345,3269.71215,288.06198,14.11694
+"5104","YDR346C",46,120,10,9.03891,0.84534,0.20004,1.44534,5.33987,2301.35848,400.82246,1.21507,0.60642,129.98749,1.15895,3070.45297,286.88117,14.13358
+"5105","YDR346C",58,120,10,9.04497,0.85944,0.19573,1.45276,3.92271,2214.33456,367.48317,1.20242,0.57513,116.82276,1.11969,2810.6604,230.10332,13.78292
+"5106","YDR346C",70,120,10,12.8052,0.86885,0.19731,1.46922,4.01817,2211.57922,398.83052,1.18334,0.71149,129.89553,1.15239,3107.56708,266.14757,14.21816
+"5107","YDR346C",82,120,10,8.18199,0.83727,0.19569,1.50483,9.59912,2117.24292,395.54314,1.12504,0.68504,120.56306,1.50286,2976.58531,229.65874,13.97206
+"5108","YDR346C",94,120,10,17.68889,0.90247,0.19972,1.92951,6.99089,2314.1759,440.67409,1.23286,0.49084,133.14684,2.13751,3272.14328,250.86636,15.50657
+"9465","YLR396C",12,88,1,50.5217,0.93695,0.20462,1.9327,11.12374,1867.56443,535.29951,0.86233,0.90333,96.5163,2.6786,3792.64933,669.46056,17.0935
+"9466","YLR396C",24,88,1,61.33871,0.94758,0.20767,1.80255,13.02403,1850.01563,536.71714,0.86089,1.01916,90.58318,1.70931,3822.53743,607.35872,19.17092
+"9467","YLR396C",36,88,1,23.62472,0.90206,0.19332,1.58371,7.40504,1636.48534,419.54168,0.67945,0.76618,64.24348,1.43293,3085.81992,480.53164,14.23125
+"9468","YLR396C",48,88,1,27.34151,0.90832,0.19358,2.0203,10.25176,1701.32164,423.78219,0.70995,0.76107,66.55924,1.57664,3221.93754,478.34533,15.35665
+"9469","YLR396C",12,89,1,48.09387,0.92292,0.2103,2.01992,10.54996,1878.93444,539.72373,0.83256,0.69854,94.6919,1.59052,3862.66262,658.23915,19.92201
+"9470","YLR396C",24,89,1,55.21674,0.91723,0.20091,2.22351,9.17197,1770.34797,524.75916,0.80231,0.74988,89.79448,1.81838,3779.33136,577.21575,30.42027
+"9471","YLR396C",36,89,1,32.62332,0.91413,0.19386,2.37221,7.43632,1670.8016,402.39229,0.69759,0.75819,94.68904,2.70087,2862.81589,719.81328,14.86579
+"9472","YLR396C",48,89,1,46.39309,0.94316,0.20465,2.0456,7.83696,1841.05386,478.72531,0.7871,0.80676,137.16185,2.72253,3575.4414,894.38926,17.31429
+"9473","YLR396C",12,90,1,72.08485,0.99463,0.21011,2.85624,8.38957,1926.65434,555.29385,0.87433,0.61906,88.82087,2.57252,3861.95293,671.73187,20.64716
+"9474","YLR396C",24,90,1,45.96146,0.90632,0.19238,4.40218,5.60149,1768.37647,485.56069,0.7589,0.63974,72.69551,2.60248,3671.71065,492.53969,18.25302
+"9475","YLR396C",36,90,1,41.04321,0.88408,0.18502,1.90014,6.11434,1608.0017,389.99025,0.64933,0.76409,54.31676,1.32218,2897.70398,412.63426,15.88194
+"9476","YLR396C",48,90,1,36.89257,0.91624,0.19672,2.15388,8.22026,1748.6702,463.60728,0.73778,0.69476,69.99581,1.3643,3482.49948,507.40157,15.95563
+"9477","YLR396C",12,94,2,22.11733,0.78506,0.18696,1.72615,11.2021,1679.26554,378.81432,0.61783,0.72838,75.77686,1.43017,2519.598,414.2888,12.97233
+"9478","YLR396C",24,94,2,19.55794,0.80284,0.18647,1.76065,14.84424,1711.85822,379.96652,0.61666,0.79925,76.48118,1.45214,2635.22852,359.08845,14.06221
+"9479","YLR396C",36,94,2,6.34659,0.75626,0.16459,1.628,8.97822,1389.57483,262.19377,0.49563,0.65753,52.72934,1.17797,1965.52193,189.77196,11.99579
+"9480","YLR396C",48,94,2,0.44872,0.73926,0.16327,1.58866,9.1507,1254.83202,222.07392,0.3806,0.61928,40.22071,1.05318,1581.8848,129.46545,10.50636
+"9481","YLR396C",12,95,2,21.16406,0.77385,0.18526,1.66912,11.8555,1675.40064,399.20729,0.63367,0.71524,79.19949,2.79675,2622.30554,411.69778,13.37669
+"9482","YLR396C",24,95,2,22.04339,0.81468,0.18612,1.72638,10.66501,1767.03832,436.08822,0.65053,0.69711,90.6704,1.30049,2926.27824,468.26159,13.87521
+"9483","YLR396C",36,95,2,10.255,0.79208,0.17372,1.52218,9.28307,1467.84187,277.19099,0.509,0.83035,46.36942,1.15254,1975.23455,161.55444,12.17589
+"9484","YLR396C",48,95,2,5.38339,0.74179,0.16381,1.41282,8.62044,1285.13808,208.45941,0.39889,0.7256,38.63759,1.04814,1556.35229,103.8959,10.74843
+"9485","YLR396C",12,96,2,47.08061,0.7741,0.18663,2.39198,22.37433,1599.94054,340.75491,0.68399,0.62942,68.59254,32.57835,2280.20849,347.65418,19.89059
+"9486","YLR396C",24,96,2,38.9824,0.76484,0.17547,1.73833,10.85297,1546.76244,376.00855,0.61101,0.70416,75.41535,1.51756,2620.66564,343.32144,13.87956
+"9487","YLR396C",36,96,2,10.22426,0.75667,0.16504,1.48424,9.5886,1262.90683,236.19191,0.45247,0.64669,42.48238,1.54398,1772.97108,114.80275,12.5678
+"9488","YLR396C",48,96,2,12.75523,0.74134,0.16351,1.58304,10.85393,1294.53572,243.6141,0.41349,0.60098,43.43225,1.09449,1713.64786,169.87681,11.15152
+"9489","YLR396C",12,97,3,59.64558,0.86794,0.20022,2.07334,12.61273,1806.27616,543.4794,0.77941,0.68485,119.08795,2.40861,3854.21161,506.32337,20.3705
+"9490","YLR396C",24,97,3,55.31347,0.93666,0.21415,2.17619,12.04073,2055.7876,687.3555,0.86132,0.78819,131.93089,2.91046,4437.33961,591.47292,20.27717
+"9491","YLR396C",36,97,3,34.83029,0.87402,0.19607,2.04495,11.03419,1764.7442,497.91775,0.73464,0.68833,90.74168,2.71354,3553.4442,376.61427,18.34434
+"9492","YLR396C",48,97,3,38.05903,0.94745,0.20817,2.18872,11.1378,1861.91765,510.65345,0.77378,0.67706,106.54184,2.39536,3887.97129,457.60235,18.75107
+"9493","YLR396C",12,98,3,84.28072,0.88908,0.20337,1.94116,14.20813,1839.36978,544.19435,0.82359,1.05636,106.84574,1.69487,3798.32707,537.50314,20.46512
+"9494","YLR396C",24,98,3,41.42107,0.95335,0.21372,2.019,13.51204,2108.23581,688.69037,0.86486,0.86337,138.54121,1.64941,4507.23713,658.34962,18.73987
+"9495","YLR396C",36,98,3,34.22782,0.90231,0.19903,1.91723,11.0193,1755.62917,495.02747,0.7062,0.6665,93.3752,1.4902,3386.95306,379.93541,16.68615
+"9496","YLR396C",48,98,3,32.11863,0.90669,0.201,1.89897,11.99009,1799.60099,484.17318,0.7231,0.7725,100.53394,1.54863,3527.39203,395.38996,17.74939
+"9497","YLR396C",12,99,3,40.09154,0.87782,0.19872,1.89698,11.0012,1795.41906,529.53499,0.77342,0.6654,104.33032,1.57525,3713.70501,477.05023,17.17296
+"9498","YLR396C",24,99,3,40.01765,0.90683,0.20606,1.87446,13.37629,1927.1051,575.31391,0.82378,0.8616,108.99748,2.19404,3883.86937,561.29995,18.25522
+"9499","YLR396C",36,99,3,27.96728,0.88763,0.19937,1.85701,12.63085,1833.86046,534.74937,0.75163,0.8218,103.88259,1.43453,3700.99806,454.73952,16.63858
+"9500","YLR396C",48,99,3,27.95341,0.93399,0.20241,1.87314,11.15927,1744.9706,458.0824,0.7072,0.91705,101.86975,1.49011,3467.10705,497.19508,16.60263
+"9501","YLR396C",12,100,4,81.48002,0.90461,0.18269,1.4831,6.86355,1508.23248,495.69757,0.78078,0.41834,90.66817,1.24229,3034.9486,717.79847,17.11951
+"9502","YLR396C",24,100,4,49.44383,0.85727,0.16417,1.22986,5.3642,1307.62592,392.5882,0.695,0.37291,73.01832,0.92087,2605.76155,570.30782,14.30333
+"9503","YLR396C",36,100,4,55.06086,0.91663,0.17467,1.63984,7.59964,1263.20537,332.06983,0.68372,0.39774,63.27292,1.22381,2205.7496,528.29965,15.28135
+"9504","YLR396C",48,100,4,60.65032,0.9709,0.18768,1.41443,5.94926,1512.82098,498.01703,0.7708,0.5098,95.37536,1.37345,3240.71282,707.53765,16.93151
+"9505","YLR396C",12,101,4,67.31725,0.89154,0.17651,1.3247,5.97147,1462.51835,463.2302,0.75189,0.31311,83.55616,1.236,2818.69523,681.25367,14.5099
+"9506","YLR396C",24,101,4,43.679,0.88283,0.17394,1.23345,6.20515,1409.78714,442.03374,0.7292,0.35488,82.44286,1.12319,2899.12592,636.61031,13.64388
+"9507","YLR396C",36,101,4,37.45506,0.89316,0.16718,1.22232,5.88738,1289.25287,346.11845,0.65403,0.38114,64.70256,0.9531,2346.30447,526.62101,13.49196
+"9508","YLR396C",48,101,4,43.1221,0.94959,0.181,1.35331,5.95425,1404.33897,380.47923,0.68272,0.37621,72.95942,1.06981,2626.47256,605.45016,14.29879
+"9509","YLR396C",12,102,4,65.88562,0.88037,0.17489,1.35441,5.86893,1347.22417,421.85736,0.96245,0.39671,79.47546,1.30259,2603.53353,638.85659,15.92062
+"9510","YLR396C",24,102,4,45.25537,0.83775,0.16573,1.16641,6.20684,1315.48869,388.16378,0.80646,0.37735,64.64446,1.07637,2525.86684,529.34638,15.45621
+"9511","YLR396C",36,102,4,40.93343,0.87618,0.1625,1.27086,5.86844,1234.31169,350.28355,1.12179,0.49191,63.00646,1.5744,2363.97905,530.62669,14.66298
+"9512","YLR396C",48,102,4,34.72022,0.88227,0.1573,1.06431,5.20013,1097.84664,274.71776,0.6734,0.43183,53.34986,1.01212,2065.70504,475.10719,12.96474
+"9513","YLR396C",12,103,5,30.98206,1.02785,0.20016,1.2839,3.28464,1748.65496,548.97412,0.79371,0.57752,80.39517,1.03856,3397.06698,496.19432,15.90595
+"9514","YLR396C",24,103,5,13.57353,0.9819,0.18862,1.2394,3.33048,1483.85873,474.33109,0.66737,0.54224,66.98617,0.89944,2944.8363,401.29413,14.31383
+"9515","YLR396C",36,103,5,18.5275,1.02806,0.1926,1.28591,2.85215,1614.81337,474.55576,0.71606,0.45437,70.75703,0.98001,3194.82128,450.2866,15.56525
+"9516","YLR396C",48,103,5,17.22089,1.04614,0.1926,1.27505,4.08962,1594.80954,430.565,0.73393,0.5671,64.19388,1.01189,2814.29723,415.47128,15.25576
+"9517","YLR396C",12,104,5,14.82151,1.01459,0.19746,1.25464,1.10038,1718.87952,522.79407,0.73479,0.46502,74.54505,0.92907,3251.96201,445.4672,14.8659
+"9518","YLR396C",24,104,5,12.98675,1.03854,0.20192,1.29829,2.59085,1688.75993,489.19731,0.73646,0.40031,70.97919,0.97106,3212.22338,408.65418,15.7732
+"9519","YLR396C",36,104,5,15.45417,1.03462,0.20034,1.26308,2.62897,1798.93616,519.94153,0.78715,0.418,79.54034,1.00599,3395.33871,492.96887,15.52158
+"9520","YLR396C",48,104,5,18.26711,1.0535,0.20245,1.32253,3.33586,1705.94571,510.06018,0.76829,0.41727,73.19019,1.06949,3279.98588,481.9625,15.70392
+"9521","YLR396C",12,105,5,21.27171,0.98657,0.19676,1.49208,2.51377,1715.35141,513.28766,0.73461,0.40802,78.31884,1.02327,3273.23779,505.08913,16.01047
+"9522","YLR396C",24,105,5,18.95153,0.99461,0.19151,1.22356,2.2878,1577.52209,455.4815,0.66774,0.38284,66.50226,0.90048,2913.406,407.90595,14.28682
+"9523","YLR396C",36,105,5,14.20856,1.02784,0.19594,1.27356,3.30088,1656.43641,486.71025,0.72619,0.48743,71.70848,1.10461,3104.65766,440.7757,15.25534
+"9524","YLR396C",48,105,5,13.51955,1.06903,0.19906,1.28493,3.22309,1648.97414,468.82148,0.73496,0.47512,65.05263,0.96076,3039.95772,395.87712,15.74366
+"9525","YLR396C",12,106,6,26.12424,0.79044,0.15303,1.05972,3.27031,1313.6815,437.99438,0.49858,0.4692,45.49873,1.00876,2791.71862,374.26025,13.53822
+"9526","YLR396C",24,106,6,18.82492,0.80471,0.14916,0.96446,86.70845,1233.26065,383.47841,0.65805,0.33965,37.28199,0.73022,2372.93188,345.68384,13.91472
+"9527","YLR396C",36,106,6,19.50199,0.80881,0.15415,0.86416,6.48784,1246.55606,400.94479,0.4706,0.53919,41.04647,0.68778,2452.90392,325.32482,11.58274
+"9528","YLR396C",48,106,6,12.34237,0.81193,0.14635,0.71257,2.58083,1115.4376,335.23158,0.42732,0.51662,28.16941,0.57994,2027.69377,253.97679,10.65702
+"9529","YLR396C",12,107,6,30.84472,0.78008,0.15199,1.2431,3.80315,1299.78493,424.45222,0.48924,0.36781,51.65647,0.64799,2629.29318,430.79826,12.03435
+"9530","YLR396C",24,107,6,16.07532,0.81012,0.15258,0.77893,3.90976,1248.03277,397.50804,0.48331,0.4691,42.32267,0.69001,2479.23369,389.04655,11.85665
+"9531","YLR396C",36,107,6,22.34708,0.86202,0.17173,0.8973,5.39419,1457.96033,484.91006,0.54999,0.97913,55.79919,1.05523,3008.09496,463.53924,13.81454
+"9532","YLR396C",48,107,6,16.39651,0.86012,0.15803,0.79496,4.08611,1246.44523,380.84388,0.47274,0.42324,37.19491,0.81499,2311.57507,310.92498,14.48727
+"9533","YLR396C",12,108,6,22.98517,0.79018,0.15618,0.84499,3.05512,1285.67671,429.87296,0.52596,0.35215,52.08139,0.83351,2598.33902,440.68346,13.20147
+"9534","YLR396C",24,108,6,14.88319,0.79406,0.14773,0.67838,3.39421,1194.18165,369.85732,0.47973,0.28873,43.46431,0.83172,2395.4812,341.40181,11.62691
+"9535","YLR396C",36,108,6,17.20516,0.77931,0.1432,0.70582,2.45705,1122.88341,369.35598,0.46,0.30732,36.63618,0.67089,2220.23166,358.80577,12.59097
+"9536","YLR396C",48,108,6,15.66882,0.7855,0.1408,0.62068,1.74687,987.29645,318.90734,0.36275,0.36027,20.20787,0.59622,1846.23896,241.01126,11.62563
+"9537","YLR396C",12,109,7,40.47236,0.89707,0.18841,1.32701,2.87386,1466.19269,476.02475,0.68097,0.48811,77.0258,1.04621,2845.97349,534.44011,19.39939
+"9538","YLR396C",24,109,7,43.39469,0.9104,0.18959,1.26842,4.76435,1508.42326,518.89063,0.69539,0.4865,83.69391,1.03967,3210.27697,586.24976,22.3208
+"9539","YLR396C",36,109,7,33.59842,0.93848,0.19031,1.25947,3.61848,1607.43272,518.38791,0.6947,0.5506,83.0066,2.54598,3212.14086,569.8682,16.80495
+"9540","YLR396C",48,109,7,33.29463,0.9545,0.19785,1.26676,3.73846,1640.47651,542.16301,0.71708,0.46391,85.63601,1.03983,3261.75746,565.37625,17.34148
+"9541","YLR396C",12,110,7,34.19411,0.98103,0.20304,1.30053,4.52538,1633.01491,583.58257,0.72383,0.73956,93.16995,1.11502,3337.32617,629.54996,17.04077
+"9542","YLR396C",24,110,7,32.04764,0.97346,0.19842,1.2661,3.8171,1659.21389,555.63259,0.71025,0.35318,90.09729,1.06183,3476.60003,651.60879,16.3377
+"9543","YLR396C",36,110,7,31.03645,0.95472,0.1956,1.18715,4.54921,1518.3567,479.82097,0.68304,0.49437,81.9688,1.03083,3004.56876,563.3383,15.99746
+"9544","YLR396C",48,110,7,28.71627,1.00828,0.20149,1.35449,3.57665,1539.84694,482.46081,0.70347,0.46448,78.69681,1.11274,2913.61767,495.37499,17.03438
+"9545","YLR396C",12,111,7,32.81522,0.93315,0.18407,1.20695,3.88113,1469.79623,471.33349,0.67952,0.46663,77.67183,0.99024,2800.44557,529.8848,15.44317
+"9546","YLR396C",24,111,7,32.19905,0.94952,0.18971,1.18909,5.35204,1567.82202,497.15209,0.69319,0.57102,79.29273,0.97475,3028.06794,568.27922,15.79554
+"9547","YLR396C",36,111,7,39.00749,0.91284,0.18585,1.14472,4.14226,1442.10196,446.62361,0.66143,0.56351,75.59485,1.11759,2735.03371,522.90149,17.70971
+"9548","YLR396C",48,111,7,31.18283,0.94372,0.19047,1.1504,3.26498,1519.83606,479.51101,0.66788,0.38569,79.247,0.98525,2868.29732,556.89119,16.73596
+"9549","YLR396C",12,112,8,39.31999,0.72152,0.18995,1.2041,7.84574,1241.23942,396.23625,0.66343,0.36282,72.09553,1.39907,2770.73921,527.89393,15.12302
+"9550","YLR396C",24,112,8,33.52679,0.68051,0.1846,1.13783,7.38591,1190.85615,330.32751,0.62183,0.3657,57.96666,1.33144,2346.10454,411.49317,14.4381
+"9551","YLR396C",36,112,8,33.76629,0.68411,0.18181,1.34246,8.19493,1212.61098,333.67687,0.5995,0.46161,59.15467,1.40627,2408.35473,431.30793,14.79304
+"9552","YLR396C",48,112,8,35.60586,0.70386,0.18347,1.13414,7.06797,1260.1511,355.74702,0.61415,0.3752,66.48454,1.34329,2493.55031,464.3582,15.30102
+"9553","YLR396C",12,113,8,43.14113,0.69554,0.18392,1.12699,6.67723,1183.17821,348.98008,0.67313,0.45347,63.80102,2.20606,2431.02953,464.36523,16.85745
+"9554","YLR396C",24,113,8,36.47217,0.74628,0.18504,1.15383,7.00412,1298.07012,414.60166,0.70385,0.39381,75.73285,1.41756,2941.30421,528.28879,15.39639
+"9555","YLR396C",36,113,8,33.80054,0.70383,0.18481,1.10486,12.68883,1203.57021,348.66248,0.66737,0.30989,64.83757,1.35879,2492.61485,443.64185,14.94868
+"9556","YLR396C",48,113,8,31.0419,0.7098,0.18519,1.14156,6.66129,1225.68657,358.61631,0.6503,0.39949,65.77008,1.33312,2532.34517,421.79497,14.55842
+"9557","YLR396C",12,114,8,31.46947,0.67125,0.17732,1.02409,6.53438,1170.75951,357.22808,0.61899,0.39698,65.46285,1.17505,2506.44602,456.4462,14.22515
+"9558","YLR396C",24,114,8,36.17561,0.70427,0.18104,1.09995,6.99425,1250.3394,397.80379,0.63537,0.45809,70.40169,1.6413,2827.96047,499.57875,15.64373
+"9559","YLR396C",36,114,8,29.15741,0.65471,0.17943,0.99059,9.35029,1146.93174,336.93442,0.60583,0.39889,60.59113,1.39938,2379.06729,407.36587,14.36372
+"9560","YLR396C",48,114,8,32.37829,0.68028,0.17978,1.06255,6.62367,1181.88467,341.89161,0.61272,0.52883,61.07162,1.18605,2399.07709,434.02326,14.58025
+"9561","YLR396C",12,115,9,60.50531,0.91537,0.21948,1.6992,7.24774,1790.33546,510.41034,0.80863,0.51384,99.06872,1.67178,2978.84896,557.0671,18.15838
+"9562","YLR396C",24,115,9,37.73519,0.94376,0.37253,2.01997,7.38205,1760.88092,472.60511,0.76261,0.64063,95.68736,2.67143,2744.55472,522.3802,15.633
+"9563","YLR396C",36,115,9,30.94663,0.95432,0.22871,1.60058,5.94919,1770.57308,472.19723,0.75715,0.44285,134.0626,1.61878,2672.63116,805.03393,15.07299
+"9564","YLR396C",48,115,9,26.10986,0.94054,0.22734,1.70139,6.76917,1661.91649,422.65723,0.68889,0.5267,85.96391,1.54477,2452.2172,484.73878,15.79238
+"9565","YLR396C",12,116,9,65.38605,0.92624,0.22945,4.82994,7.0232,1953.1841,535.29597,0.99838,0.38656,115.60323,2.4385,3220.19436,601.77699,19.33491
+"9566","YLR396C",24,116,9,31.09264,0.94323,0.22516,2.08516,5.80498,1935.13774,543.41268,0.90615,0.37879,102.0661,1.81555,3281.81338,572.03223,16.0659
+"9567","YLR396C",36,116,9,23.21833,0.95111,0.22996,1.8208,6.35361,1773.00162,451.12102,0.74122,0.54927,81.421,1.57453,2631.25896,448.45315,14.82016
+"9568","YLR396C",48,116,9,21.1951,0.94377,0.21709,1.71685,5.94984,1723.81894,428.49683,0.67029,0.47856,83.08335,1.50568,2547.29435,446.17964,14.04503
+"9569","YLR396C",12,117,9,71.6742,0.91006,0.22125,1.95327,6.69611,1879.12667,510.35291,1.07839,0.40148,107.16905,2.07523,3028.02794,569.60716,21.12803
+"9570","YLR396C",24,117,9,37.93336,0.89413,0.21971,1.57576,6.58615,1790.33024,490.33672,0.7793,0.50636,92.75082,2.97331,2824.13973,498.14139,16.37792
+"9571","YLR396C",36,117,9,39.15438,0.91042,0.21942,2.05473,13.48342,1716.66179,432.014,1.02725,1.69243,82.7779,1.52576,2502.598,439.23871,16.43655
+"9572","YLR396C",48,117,9,24.10052,0.93109,0.21474,1.63283,4.71263,1755.67306,448.10557,0.72167,0.4732,84.81314,1.38402,2634.21873,437.61817,14.65769
+"9573","YLR396C",12,118,10,20.5323,0.83996,0.21199,1.69735,7.07589,1610.48424,447.58019,0.77845,0.47348,51.38296,3.18039,2985.78101,462.408,15.79552
+"9574","YLR396C",24,118,10,11.47467,0.83648,0.21276,1.77251,6.97334,1568.26962,410.60164,0.70997,0.72354,34.45097,2.54417,2864.73459,325.81762,14.35862
+"9575","YLR396C",36,118,10,13.91189,0.84575,0.21961,3.34177,7.85656,1669.35407,422.09487,0.73398,0.51933,53.61381,2.95786,2902.0271,490.08346,15.23573
+"9576","YLR396C",48,118,10,10.70602,0.81654,0.21062,1.82472,8.46564,1569.15598,393.34368,0.72401,0.42176,35.12671,2.81157,2780.04317,326.26543,14.09295
+"9577","YLR396C",12,119,10,71.41053,0.8546,0.21284,2.57813,8.05657,1614.10685,436.21814,0.75141,0.66519,41.1924,3.46959,2940.14616,384.8932,23.21
+"9578","YLR396C",24,119,10,13.44201,0.88242,0.22546,1.66019,5.91039,1678.90639,466.39657,0.73202,0.3718,46.9921,2.33273,3329.72363,405.43569,15.25811
+"9579","YLR396C",36,119,10,11.24843,0.81927,0.21007,1.48472,7.33929,1593.62791,419.221,0.67548,0.36884,38.24112,2.58253,2971.81031,323.33124,13.88152
+"9580","YLR396C",48,119,10,8.65762,0.86714,0.22013,1.44206,5.54786,1610.92814,411.12766,0.68531,0.39691,34.30497,1.67336,2952.67226,351.32222,14.74383
+"9581","YLR396C",12,120,10,6.80139,0.83209,0.20685,1.51396,5.50182,1598.38733,447.02287,0.67032,0.50628,39.0511,1.58212,2900.38887,365.20646,13.80335
+"9582","YLR396C",24,120,10,8.17454,0.80009,0.21184,3.48907,5.7279,1509.10399,405.06484,0.67083,0.43733,33.39239,2.49679,2812.94055,347.82402,14.09171
+"9583","YLR396C",36,120,10,9.57401,0.82945,0.2123,6.32744,7.59645,1585.40881,411.98515,0.72506,0.50267,36.84669,4.03262,2851.76353,341.1382,14.15079
+"9584","YLR396C",48,120,10,8.42892,0.83809,0.2134,1.41164,10.93038,1567.80189,405.80702,0.76455,0.50032,36.62881,1.51156,2841.17808,376.11606,14.06821
+"11627","YPL092W",10,100,4,59.54384,1.07718,0.17561,1.41187,9.85736,2272.77544,428.11591,1.21222,0.62118,144.10466,1.17246,2883.71592,600.65025,14.42769
+"11628","YPL092W",22,100,4,47.61818,1.08576,0.17156,1.30431,6.00691,2515.69124,413.90971,1.24454,0.66443,101.03167,0.9812,2926.68466,563.38745,14.05234
+"11629","YPL092W",34,100,4,44.23071,1.14564,0.17167,1.2888,6.23236,2321.31131,382.36268,1.19426,0.62006,93.17996,0.97619,2692.26206,470.01564,14.02926
+"11630","YPL092W",46,100,4,40.64527,1.13005,0.16718,1.25604,5.88766,2133.08636,340.28633,1.13684,0.61829,97.39429,1.82202,2515.05914,471.09034,13.66824
+"11631","YPL092W",58,100,4,38.56373,1.10636,0.15491,1.18061,5.1807,1790.13885,267.4203,0.99672,0.6263,80.68314,0.96537,2030.47659,370.30201,13.28165
+"11632","YPL092W",70,100,4,43.75852,1.25356,0.18057,1.39798,5.41575,2337.75331,330.31685,1.23232,0.64015,85.2905,1.09043,2602.07333,419.01699,15.56781
+"11633","YPL092W",82,100,4,33.04429,1.19687,0.15588,1.3207,4.58478,1608.22873,210.34629,0.90115,0.77212,71.59738,1.35332,1633.29498,317.04637,13.15033
+"11634","YPL092W",94,100,4,36.73374,1.19851,0.15557,1.20558,5.27571,1693.77443,203.97441,0.95865,0.65965,50.69996,0.96943,1527.81533,228.30026,13.53028
+"11635","YPL095C",9,100,4,49.30754,0.78318,0.16165,1.27197,6.6576,2801.75654,475.22663,1.14735,0.58393,153.27856,0.99049,3174.18388,629.8984,14.14766
+"11636","YPL095C",21,100,4,45.59218,0.83198,0.16107,1.32638,6.64615,2836.30849,440.32073,1.16561,0.54499,144.80709,0.8607,2971.42277,575.94038,14.63234
+"11637","YPL095C",33,100,4,35.9864,0.81451,0.14992,1.22206,4.96362,2145.87475,322.62093,0.94386,0.53897,117.62698,0.79856,2237.06386,403.13336,13.25079
+"11638","YPL095C",45,100,4,32.61011,0.84815,0.14871,1.26815,6.24848,2125.08015,275.39043,0.93985,0.87831,100.56359,0.74903,2095.06736,369.2808,13.52681
+"11639","YPL095C",57,100,4,42.30494,0.87547,0.15889,1.27801,5.7107,2420.06539,384.40201,1.02767,0.6316,132.42654,0.83994,2769.68262,477.15274,15.2374
+"11640","YPL095C",69,100,4,33.31996,0.85763,0.14275,1.12572,5.28989,1881.10379,233.20182,0.84493,0.7338,80.25738,0.68838,1777.82707,290.14963,13.50237
+"11641","YPL095C",81,100,4,26.90748,0.86143,0.1397,1.11172,4.02911,1738.51093,236.70451,0.79484,0.61129,89.84123,0.72215,1817.83222,244.54898,12.45831
+"11642","YPL095C",93,100,4,31.08523,0.88264,0.13555,1.13909,6.71472,1633.63705,186.76962,0.77189,0.76708,78.22955,0.75615,1410.67637,259.25341,12.56331
+"11643","YPL096W",8,100,4,49.66505,0.83317,0.16873,1.35169,7.13018,2969.27482,521.43605,1.33248,0.72817,153.8127,0.96163,3430.03725,636.8828,14.37087
+"11644","YPL096W",20,100,4,47.87807,0.9068,0.17245,1.42231,5.76272,2995.8815,486.53673,1.32843,0.63239,125.64217,0.97456,3190.28333,583.88061,15.16651
+"11645","YPL096W",32,100,4,37.01987,0.82006,0.14219,1.23139,4.36111,2263.75089,337.97832,1.06459,0.59562,87.0073,0.77374,2269.03172,410.79935,13.17853
+"11646","YPL096W",44,100,4,38.48277,0.87606,0.14995,1.3248,5.55745,2139.1476,305.77925,1.01479,0.76868,96.63067,0.90583,2208.60978,389.20886,13.74557
+"11647","YPL096W",56,100,4,50.16008,0.86204,0.15237,1.21903,4.97539,2115.0351,315.40529,0.98913,0.75705,97.43407,0.83732,2371.68917,382.83855,14.7393
+"11648","YPL096W",68,100,4,31.77798,0.80017,0.13097,1.113,4.0744,1660.97283,217.83672,0.8037,0.66425,77.04748,0.77248,1654.3364,281.26405,12.3111
+"11649","YPL096W",80,100,4,32.25291,0.90724,0.14869,1.19494,4.24826,1836.26443,228.3753,0.89124,0.65315,75.55144,0.80214,1695.23169,251.93721,13.27362
+"11650","YPL096W",92,100,4,59.8318,0.88468,0.13838,1.75443,4.96817,1555.12306,187.71441,0.83993,0.80005,70.59366,1.24797,1400.59404,205.51437,14.6022
+"11651","YPL097W",7,100,4,50.04726,0.64179,0.15715,1.17195,5.75881,1380.44612,751.88936,0.88884,0.47282,131.21722,0.94526,3957.95275,484.21336,14.87692
+"11652","YPL097W",19,100,4,44.79252,0.62618,0.14761,1.09127,5.35204,1191.22122,588.83957,0.7446,0.3706,109.68525,0.86675,3373.50833,496.4723,13.9808
+"11653","YPL097W",31,100,4,49.86247,0.67277,0.16062,1.25486,5.99982,1356.25924,716.22966,0.85511,0.40014,137.88515,1.02823,4043.20196,582.25529,15.61163
+"11654","YPL097W",43,100,4,47.01188,0.65957,0.1478,1.24119,6.82331,1208.89002,561.29334,0.75711,0.41784,106.56945,0.94453,3407.61292,468.58696,15.2173
+"11655","YPL097W",55,100,4,65.02117,0.65862,0.15133,1.28577,7.22671,1215.66543,605.21635,0.77768,0.45128,113.81177,1.07027,3642.42753,484.55945,16.10745
+"11656","YPL097W",67,100,4,52.86279,0.63031,0.13387,1.31517,11.28345,927.15124,416.34415,0.63658,0.61512,82.17216,1.05009,2571.14984,324.40479,14.5948
+"11657","YPL097W",79,100,4,51.91785,0.71868,0.14515,1.43478,7.39267,1012.87739,420.48406,0.66557,0.97705,81.02252,1.06851,2706.6237,321.4759,16.06693
+"11658","YPL097W",91,100,4,53.97588,0.64116,0.12669,1.37558,4.28334,819.69021,311.9704,0.54997,0.51461,58.4955,1.1217,2003.75572,218.95009,14.5951
+"11659","YPL098C",5,100,4,51.57328,0.87512,0.16899,1.39735,5.88221,2680.58779,466.04701,0.92041,0.34835,151.55633,0.9545,3130.99866,532.01562,15.17166
+"11660","YPL098C",17,100,4,48.33181,0.91255,0.1739,1.32771,6.72068,2769.19908,447.69868,0.90376,0.30553,145.00911,0.8937,2999.57773,602.50551,15.13319
+"11661","YPL098C",29,100,4,45.48838,0.94694,0.17435,1.34153,6.1333,2660.54838,438.72467,0.89379,0.46536,144.15422,0.96855,3137.45076,565.35659,15.19222
+"11662","YPL098C",41,100,4,38.45556,0.86181,0.15418,1.21572,4.5879,2125.35483,311.17112,0.73237,0.2875,107.44234,1.0244,2392.10816,385.4689,13.55718
+"11663","YPL098C",53,100,4,31.35094,0.80517,0.13216,1.08663,3.91609,1595.6064,228.76093,0.57984,0.39181,75.15887,0.8055,1700.72861,254.81601,12.26543
+"11664","YPL098C",65,100,4,44.83811,0.9654,0.16933,1.34007,8.08653,2228.30648,349.82873,0.77734,0.46101,115.92987,0.87375,2556.44935,463.14973,15.50189
+"11665","YPL098C",77,100,4,29.64965,0.90956,0.14616,1.1293,5.88452,1783.61789,231.68446,0.62078,1.19687,72.00413,0.75371,1729.93147,283.89706,13.23813
+"11666","YPL098C",89,100,4,36.3856,0.94853,0.14338,1.24257,5.42939,1623.69737,201.0639,0.59544,0.68148,69.70817,1.02466,1585.58115,233.96562,14.64462
+"11667","YPL099C",4,100,4,52.301,0.97051,0.17026,1.30171,5.21981,2902.12187,515.14626,1.34422,0.63822,97.281,2.71584,3354.45455,529.6368,14.49566
+"11668","YPL099C",16,100,4,44.54736,1.03546,0.17046,1.30107,16.58685,2647.57873,379.21972,1.28346,0.6553,68.87314,0.92613,2742.35371,509.26741,13.85373
+"11669","YPL099C",28,100,4,44.61073,1.07049,0.17427,1.29101,5.26182,2723.88324,409.76484,1.26946,0.6113,78.95077,0.96046,2842.87673,501.0704,13.99491
+"11670","YPL099C",40,100,4,36.61706,1.01246,0.1553,1.183,5.0934,2238.85614,316.20991,1.09655,0.56135,62.95885,0.91929,2327.39343,403.83076,12.82079
+"11671","YPL099C",52,100,4,39.91365,1.07006,0.15935,1.24675,4.93386,2230.90865,312.15079,1.11596,0.59173,68.58243,0.92453,2433.62136,411.04363,13.74475
+"11672","YPL099C",64,100,4,31.47433,1.02315,0.1434,1.08968,3.89446,1915.68171,248.43854,0.97378,0.55767,48.77123,0.74975,1888.94251,311.65971,12.52671
+"11673","YPL099C",76,100,4,33.70145,1.08651,0.15435,1.20097,4.40924,1991.02989,232.73108,0.98498,0.66344,49.17661,0.83833,1740.91543,292.3773,13.19639
+"11674","YPL099C",88,100,4,46.25609,1.08634,0.14472,1.23021,3.89502,1685.66627,190.01868,0.88982,0.65807,46.21695,1.0593,1532.79415,218.66161,13.5411
+"11675","YPL100W",3,100,4,54.32505,0.86525,0.17461,1.42376,6.88734,3461.97112,611.10577,1.29737,0.55679,202.1024,0.97744,3811.45897,647.52417,16.49109
+"11676","YPL100W",15,100,4,37.46137,0.78208,0.15473,1.20648,6.50805,2624.75947,400.5838,1.06455,0.70576,122.21134,2.86837,2558.40147,475.50655,13.99273
+"11677","YPL100W",27,100,4,33.52478,0.76891,0.1465,1.17795,5.23007,2458.72708,373.83001,0.9628,0.6186,134.05861,1.15206,2513.22629,452.804,13.07103
+"11678","YPL100W",39,100,4,32.8917,0.77069,0.14231,1.21992,6.18357,2427.19073,349.17989,0.963,0.60582,116.09551,0.83935,2291.63972,442.48132,13.23662
+"11679","YPL100W",51,100,4,35.52236,0.84363,0.15827,1.23214,6.13185,2650.89126,401.19965,1.03302,0.62011,130.86272,0.81946,2696.19762,484.54029,14.45466
+"11680","YPL100W",63,100,4,27.33539,0.81089,0.13647,1.12846,5.33117,2018.84408,250.63935,0.82193,0.60721,84.91889,0.73704,1808.76074,330.33325,12.77326
+"11681","YPL100W",75,100,4,23.74332,0.82553,0.13464,1.29689,3.85412,1811.61795,234.96723,0.782,0.59739,77.47552,0.70623,1713.51293,287.6712,12.96349
+"11682","YPL100W",87,100,4,26.71934,0.84678,0.12987,1.13711,4.33438,1701.36209,195.94445,0.76457,0.79208,67.52065,0.76141,1425.66965,207.4855,12.40236
+"11683","YPL101W",10,99,3,81.30112,0.9164,0.18694,2.0262,10.9855,2756.2205,399.61329,1.44176,1.23921,134.47037,1.3433,3152.17665,377.74076,18.84132
+"11684","YPL101W",22,99,3,42.27142,0.93685,0.18699,1.96935,10.21202,2681.03061,426.47967,1.38118,1.29985,146.62828,1.43616,3424.33882,381.67031,16.60582
+"11685","YPL101W",34,99,3,42.24637,0.88799,0.17871,1.89552,10.72122,2534.78225,383.78118,1.28744,1.33941,119.31444,1.34164,3018.12825,320.22601,15.91849
+"11686","YPL101W",46,99,3,56.25852,0.95687,0.19233,2.00987,11.65397,2931.2405,445.6018,1.439,1.28371,202.09587,1.4878,3526.51008,857.77976,17.85809
+"11687","YPL101W",58,99,3,36.64787,0.97292,0.19235,1.98968,13.44396,2733.40063,401.47302,1.36901,1.31748,138.13133,1.42438,3338.68659,417.08586,17.13567
+"11688","YPL101W",70,99,3,35.44307,0.96491,0.19306,1.97453,11.74867,2801.48833,384.21927,1.3636,1.45229,123.47469,1.37194,3152.43235,409.76315,17.34255
+"11689","YPL101W",82,99,3,30.29956,0.95919,0.18978,1.97324,14.82599,2487.50499,318.23303,1.27994,1.42317,97.7479,1.30813,2821.96585,202.27644,16.90589
+"11690","YPL101W",94,99,3,60.90426,0.94702,0.18515,2.21018,11.19135,2645.88212,328.10667,1.31934,1.36471,110.04104,1.5966,2942.58964,250.0409,19.73249
+"11691","YPL102C",2,100,4,49.65609,0.71387,0.13678,1.06814,4.19196,2383.82635,391.20481,1.18733,0.50958,64.2335,0.82057,2530.33791,488.83639,11.97201
+"11692","YPL102C",14,100,4,47.51306,0.87652,0.1632,1.24747,7.74336,2737.46283,375.94314,1.39425,0.78422,51.205,0.76306,2581.22986,555.75692,13.94824
+"11693","YPL102C",26,100,4,39.59281,0.86121,0.15557,1.2198,5.28695,2298.53809,280.25087,1.21807,0.61968,38.1999,3.44824,2109.12401,420.30403,13.54679
+"11694","YPL102C",38,100,4,39.6859,0.87238,0.15226,1.22988,21.06498,2162.69266,251.24011,1.21088,0.92248,38.21286,0.82092,1920.31271,415.90244,13.09689
+"11695","YPL102C",50,100,4,34.1992,0.8868,0.14491,1.1991,4.97924,1979.08819,225.54864,1.10882,0.66298,32.25235,0.75519,1792.37648,343.48959,12.52391
+"11696","YPL102C",62,100,4,34.67849,0.93568,0.15181,1.21984,4.41367,1891.61757,211.19776,1.07759,0.67383,34.38763,0.81137,1773.60817,346.78492,13.06579
+"11697","YPL102C",74,100,4,32.11601,0.96176,0.14983,1.21836,3.75098,1873.5819,189.35413,1.01323,0.7604,33.7333,0.77193,1622.7191,329.28488,12.98293
+"11698","YPL102C",86,100,4,28.37072,0.92524,0.13246,1.11933,3.41168,1646.01794,150.38535,0.90508,0.75601,22.63263,0.70064,1223.09352,192.74873,12.08904
+"11699","YPL103C",9,99,3,79.05182,0.87384,0.1808,1.95834,10.06607,3272.48806,497.07136,1.25386,1.2227,194.20872,1.37172,3913.30233,405.96193,19.64441
+"11700","YPL103C",21,99,3,34.04762,0.92405,0.18625,2.04791,10.23593,3292.95331,500.11052,1.30708,1.16281,194.69181,1.4023,4073.45177,418.74247,16.84347
+"11701","YPL103C",33,99,3,30.81549,0.91433,0.18797,2.00908,10.40122,3212.37267,525.59564,1.22701,1.14938,206.22728,1.37724,4052.66439,383.27078,16.81302
+"11702","YPL103C",45,99,3,26.22445,0.90871,0.19096,2.00752,10.69284,3116.40363,518.80056,1.17153,1.06136,201.75977,1.44083,3867.42235,385.59014,16.53249
+"11703","YPL103C",57,99,3,23.05443,0.95067,0.19036,1.99805,10.39136,3115.90883,481.03155,1.17784,1.1411,207.45235,1.40351,3911.38026,360.39879,16.64417
+"11704","YPL103C",69,99,3,21.09654,0.96838,0.18784,1.9633,9.74445,3135.66446,483.05157,1.1754,1.0753,180.9358,1.38166,3765.07232,323.34881,17.09259
+"11705","YPL103C",81,99,3,20.57346,0.95146,0.18905,1.93951,9.11936,3038.81156,449.23471,1.09345,1.06344,165.77332,1.32399,3807.29714,281.4121,16.35776
+"11706","YPL103C",93,99,3,22.3816,1.01648,0.19125,1.98915,9.97496,3248.80082,465.44968,1.18955,1.26695,165.68957,1.34728,3847.59081,290.63222,17.59128
+"11707","YPL104W",8,99,3,113.40064,0.89631,0.23203,1.94496,11.52404,1375.37831,558.02534,0.81978,0.68143,193.53906,1.47767,3922.2934,442.93216,21.64988
+"11708","YPL104W",20,99,3,87.66481,0.92133,0.20699,2.18777,11.40105,1474.43275,621.51115,0.77188,0.66219,188.88762,1.43746,4172.16706,496.4848,21.15356
+"11709","YPL104W",32,99,3,36.7611,0.89042,0.20195,1.85889,10.9427,1296.60369,509.16892,0.72529,0.77145,163.07955,1.34207,3687.47724,380.11479,17.25521
+"11710","YPL104W",44,99,3,32.10283,0.86783,0.19307,1.81366,9.99838,1261.61141,487.76807,0.69036,0.78832,156.98886,1.31337,3615.31925,371.73283,17.09401
+"11711","YPL104W",56,99,3,32.35023,0.93433,0.20716,1.92711,10.78078,1320.5467,512.73859,0.72788,0.80876,158.98687,1.40111,3806.04936,366.30954,18.68668
+"11712","YPL104W",68,99,3,28.18376,0.90732,0.19688,1.80476,10.09817,1308.96559,485.16764,0.70285,0.83974,148.43548,1.28922,3475.13659,346.14699,17.59966
+"11713","YPL104W",80,99,3,23.67017,0.91861,0.20154,1.86821,10.56483,1187.38116,410.74248,0.62731,0.87834,135.39088,1.31208,3284.8555,288.98363,16.88513
+"11714","YPL104W",92,99,3,28.14742,0.93775,0.19504,1.81175,10.4376,1239.46509,420.91404,0.63582,0.80284,135.65916,1.32397,3371.46365,233.58579,17.22797
+"11715","YPL105C",7,99,3,98.86471,0.76246,0.17296,1.9981,12.01411,3180.71879,499.76012,1.27457,0.73964,250.28277,1.20879,3869.34877,370.35675,20.97435
+"11716","YPL105C",19,99,3,35.60003,0.80871,0.18072,1.9691,10.78746,3179.0223,505.25243,1.23156,0.75289,252.45177,1.19667,4031.69247,391.79566,16.50217
+"11717","YPL105C",31,99,3,31.99221,0.8289,0.18384,1.99621,11.05198,3082.13268,526.68271,1.14518,0.71331,248.52684,1.29368,4190.18686,403.02615,16.49944
+"11718","YPL105C",43,99,3,36.65882,0.85591,0.1877,2.02967,10.87139,3113.13711,504.22398,1.17816,0.76929,245.39536,1.24129,4097.50798,349.04426,18.49824
+"11719","YPL105C",55,99,3,31.13793,0.84301,0.18775,1.98953,10.27789,2789.50142,463.28431,1.09458,0.61074,220.84481,1.30385,3771.28125,303.95844,17.66907
+"11720","YPL105C",67,99,3,30.65753,0.87637,0.19067,2.05762,10.2728,2984.55161,492.72679,1.11308,0.62617,225.98633,1.2931,4093.03368,315.00196,18.72239
+"11721","YPL105C",79,99,3,30.08388,0.87549,0.19184,1.97793,9.7611,2957.70967,474.02677,1.05617,0.61534,213.87759,1.30368,3892.68966,283.72566,18.24423
+"11722","YPL105C",91,99,3,22.44828,0.84515,0.17956,1.88305,9.43747,2632.55794,369.8629,0.96673,0.59909,170.73447,1.23584,3164.85211,182.96685,16.51002
+"11723","YPL106C",5,99,3,45.13289,0.46008,0.10721,1.96093,10.42685,2911.31383,391.16079,0.96816,0.73432,174.966,1.07961,3246.34055,457.20891,18.45382
+"11724","YPL106C",17,99,3,29.46064,0.45691,0.10703,1.8541,10.62049,2852.57344,435.29044,0.92144,0.81,195.35715,0.99848,3420.99394,433.12147,17.09749
+"11725","YPL106C",29,99,3,27.5314,0.44519,0.10331,1.78798,10.18265,2800.58329,406.73958,0.91488,0.77892,163.43227,0.9425,3270.0616,477.76322,16.68312
+"11726","YPL106C",41,99,3,25.39311,0.46612,0.10785,1.85095,12.68219,2762.77637,393.97407,0.94057,0.91685,147.01276,0.98583,3237.7296,354.38265,17.2449
+"11727","YPL106C",53,99,3,23.61182,0.48035,0.11332,1.81052,10.48993,2696.43543,342.45868,0.88819,0.97239,142.44461,0.99059,3054.44318,333.35679,17.83212
+"11728","YPL106C",65,99,3,26.6394,0.48523,0.1084,1.82528,10.40967,2852.65754,359.24311,0.94661,0.9602,140.02857,0.96322,3139.50852,353.12866,18.44905
+"11729","YPL106C",77,99,3,25.07666,0.49476,0.10856,1.80066,21.80738,2763.23859,347.17053,0.95239,1.86327,138.27115,0.95749,3147.68918,333.1177,18.4944
+"11730","YPL106C",89,99,3,24.62946,0.47352,0.10502,1.82807,10.06124,2410.94278,285.65844,0.82195,0.86311,109.71306,0.96062,2746.07683,210.8311,17.81844
+"11731","YPL107W",4,99,3,40.52618,1.187,0.19026,2.01891,12.8788,3025.00449,395.57751,1.33025,1.42776,104.71169,1.29797,3229.45121,366.12104,16.45662
+"11732","YPL107W",16,99,3,36.10536,1.18338,0.20002,1.97979,10.89973,3354.19548,494.98262,1.34912,0.59204,138.42377,1.29996,3931.48791,448.49021,16.56029
+"11733","YPL107W",28,99,3,33.83815,1.23093,0.20398,2.04895,14.41621,3325.83955,504.81493,1.38435,0.68624,130.79939,1.37516,3824.29127,427.82005,17.02513
+"11734","YPL107W",40,99,3,29.97258,1.20133,0.2012,1.99556,12.03466,3248.21754,474.68464,1.30185,0.75787,134.96216,1.35461,3858.506,382.00065,16.39081
+"11735","YPL107W",52,99,3,26.07667,1.23617,0.20792,2.01113,11.16708,3066.59855,406.15797,1.29892,0.73558,120.06308,1.3216,3443.11878,304.8453,16.55026
+"11736","YPL107W",64,99,3,30.51656,1.23948,0.20441,2.0374,11.00937,3279.84497,479.34486,1.33431,0.60344,126.39294,1.71734,3811.05095,384.29085,17.61055
+"11737","YPL107W",76,99,3,30.88549,1.20098,0.19923,1.93779,10.28799,3021.11076,419.91359,1.22538,0.58786,120.67225,1.33873,3487.44227,318.82727,17.21122
+"11738","YPL107W",88,99,3,32.05928,1.1851,0.19342,1.91531,9.95738,2869.82285,371.95196,1.15925,0.59828,99.9931,1.32416,3225.49362,197.82003,17.14068
+"11739","YPL108W",3,99,3,33.53361,0.85975,0.17827,1.94548,10.80454,3238.06909,430.40296,1.21024,1.38878,133.60741,1.14897,3462.06573,353.12412,17.77479
+"11740","YPL108W",15,99,3,32.84561,0.86567,0.18005,1.91659,11.26441,3410.67119,509.85509,1.22833,1.00389,159.88189,1.2041,3890.17437,413.38446,18.0829
+"11741","YPL108W",27,99,3,29.82256,0.8988,0.18444,1.9262,11.84655,3437.94606,503.70557,1.25734,1.18815,174.86768,1.21471,3934.17328,478.54476,17.01151
+"11742","YPL108W",39,99,3,29.20692,0.91153,0.1828,1.9288,11.01164,3363.41309,491.57576,1.20832,0.86359,166.0205,1.24639,3941.4887,391.54048,17.60311
+"11743","YPL108W",51,99,3,23.16231,0.90686,0.1831,1.95058,10.99708,3078.6306,443.06291,1.12667,1.01884,152.06527,1.18818,3544.5033,344.08224,16.18804
+"11744","YPL108W",63,99,3,25.76356,0.93302,0.18683,1.89638,10.98762,3264.46911,470.95072,1.15573,0.91231,158.56204,1.2423,3823.83871,333.62401,17.35822
+"11745","YPL108W",75,99,3,25.05868,0.92477,0.18488,1.85235,13.51314,3135.49728,430.27005,1.12153,0.95569,145.7423,1.24029,3561.34025,296.47385,16.68939
+"11746","YPL108W",87,99,3,18.35324,0.941,0.17866,1.79702,10.16219,2858.50829,339.76129,1.01274,0.95493,117.29357,1.16667,2931.64264,196.90553,16.3403
+"11747","YPL109C",2,99,3,50.58397,0.84573,0.184,1.88802,11.58162,2677.41008,503.21481,1.08454,1.05829,214.4745,1.34831,3744.0206,394.63309,20.20542
+"11748","YPL109C",14,99,3,36.66155,0.88978,0.19317,1.96159,11.89043,2849.18895,594.81279,1.1337,0.9575,264.02145,1.32593,4367.34867,519.23247,17.09659
+"11749","YPL109C",26,99,3,34.04994,0.92896,0.19217,2.01263,12.1259,2726.00052,508.02737,1.08868,0.92824,230.41365,2.74391,3907.79266,435.68737,17.95608
+"11750","YPL109C",38,99,3,26.88582,0.91068,0.1919,1.96531,11.28022,2647.96508,466.458,1.0475,0.97482,200.30758,1.29619,3703.30315,354.79597,17.55096
+"11751","YPL109C",50,99,3,31.53282,0.97784,0.19869,2.03957,11.32271,2702.60101,525.52225,1.07584,0.90582,223.7813,1.36763,4037.56712,371.97888,18.76229
+"11752","YPL109C",62,99,3,25.57741,0.95194,0.19975,2.00051,11.20463,2597.43681,472.1523,1.03208,0.89053,201.9979,1.34815,3745.61173,329.69772,17.6383
+"11753","YPL109C",74,99,3,24.83108,0.91843,0.18667,1.94311,13.69639,2298.25718,438.4737,0.94608,0.9832,192.85565,1.34126,3467.03521,275.01944,16.65836
+"11754","YPL109C",86,99,3,24.16048,0.92835,0.1807,1.85256,10.11112,2243.62079,367.47653,0.86696,0.93042,156.77068,1.26699,3065.75298,221.18942,16.40816
+"11755","YPL110C",10,98,3,40.96024,0.98825,0.18465,1.94364,9.84141,2825.81149,478.04053,1.31059,1.27363,241.2445,1.39545,3859.91204,431.02351,16.18562
+"11756","YPL110C",22,98,3,38.84175,0.99079,0.18511,1.94535,9.0092,2885.40795,503.44244,1.28506,1.22708,232.0068,1.37783,3951.58105,385.08346,16.06145
+"11757","YPL110C",34,98,3,31.20605,0.96902,0.18099,1.90093,18.99529,2687.9075,472.46678,1.20777,1.12235,217.60918,1.3233,3740.94549,387.6076,15.73956
+"11758","YPL110C",46,98,3,33.89432,0.99548,0.18821,1.99661,42.65424,2840.08115,471.43792,1.34969,1.24505,224.54811,1.37727,3839.80103,422.37104,16.36034
+"11759","YPL110C",58,98,3,29.98136,1.02328,0.18431,1.99007,10.68901,2736.70463,412.27995,1.19636,1.27964,177.2811,1.36582,3431.92464,356.66235,16.92426
+"11760","YPL110C",70,98,3,26.49105,1.0037,0.18035,1.91126,14.43642,2746.7078,423.98796,1.20692,1.26155,192.94694,3.98495,3520.24365,330.68293,15.9733
+"11761","YPL110C",82,98,3,36.67128,1.02058,0.18039,1.99052,10.28532,2715.98892,402.95005,1.2231,1.1797,232.25141,1.38439,3400.95337,662.97615,16.2453
+"11762","YPL110C",94,98,3,50.42327,0.99943,0.17886,2.08279,11.00588,2524.75084,414.40639,1.18166,1.25699,228.51183,1.54972,3520.58892,408.66669,17.48456
+"11763","YPL111W",9,98,3,38.40137,0.81453,0.1779,1.98061,10.44996,3091.64741,540.04077,1.18327,0.96451,207.41693,1.32224,3906.86819,484.38561,16.94421
+"11764","YPL111W",21,98,3,28.62767,0.82071,0.16926,2.93122,9.26634,2916.80852,471.5315,1.13127,0.78829,181.94025,1.27682,3656.09843,407.83439,15.64326
+"11765","YPL111W",33,98,3,27.56803,0.82848,0.16994,1.83718,9.18934,2863.01887,457.00031,1.06284,0.85246,155.75974,1.20811,3459.19561,383.54037,15.62394
+"11766","YPL111W",45,98,3,24.50354,0.85861,0.17074,1.95478,9.62941,2863.44584,449.8895,1.10816,0.87482,146.3445,1.24562,3530.31432,321.37985,15.83989
+"11767","YPL111W",57,98,3,27.43663,0.87652,0.17373,1.92135,9.77078,2959.04758,424.49388,1.10331,0.83016,141.14136,1.23169,3511.77399,331.8498,16.18953
+"11768","YPL111W",69,98,3,22.84499,0.85734,0.17072,1.90834,9.64599,2717.26519,413.47421,1.06665,1.13741,147.55763,1.24988,3266.97509,334.22064,15.91775
+"11769","YPL111W",81,98,3,24.49719,0.8967,0.17664,1.94492,9.56432,2933.39877,412.29295,1.11305,0.94041,131.99202,1.26019,3355.16135,286.27408,16.51357
+"11770","YPL111W",93,98,3,145.92415,0.92147,0.18429,2.04643,11.72916,2988.97419,411.75608,1.14603,0.93746,138.51167,2.12491,3363.23184,270.91893,32.93467
+"11771","YPL112C",7,98,3,37.27583,0.83639,0.18174,2.0016,10.59469,3056.29038,433.67942,1.17681,0.89437,174.23584,1.2348,3435.59785,408.57418,16.9665
+"11772","YPL112C",19,98,3,30.60139,0.81604,0.16957,1.90595,11.2275,2923.20114,430.44556,1.09271,0.9411,161.74022,1.16397,3463.26674,371.2689,16.45349
+"11773","YPL112C",31,98,3,25.6993,0.82758,0.17262,1.95188,10.59613,2886.33756,428.69671,1.07368,0.81211,159.32865,1.20094,3459.38631,354.23553,16.47427
+"11774","YPL112C",43,98,3,28.31629,0.84189,0.17668,1.92503,10.91577,2911.10605,425.94004,1.08032,0.93825,151.07649,1.20059,3443.5311,356.87248,16.59169
+"11775","YPL112C",55,98,3,25.40052,0.89804,0.18004,1.97441,10.83499,2891.70796,414.78248,1.06923,0.92729,138.23705,1.21475,3459.49275,300.79754,16.71969
+"11776","YPL112C",67,98,3,24.8499,0.90064,0.17699,1.97034,10.70446,2888.93189,386.88648,1.05997,1.15198,135.02129,1.23202,3167.20291,302.43272,17.10768
+"11777","YPL112C",79,98,3,24.10361,0.9,0.1748,1.8744,10.17018,2837.97028,371.55813,1.03074,1.21854,130.88323,1.18604,3365.98154,303.94958,17.53055
+"11778","YPL112C",91,98,3,49.82545,0.87342,0.16424,1.86481,9.73625,2644.42289,319.44856,0.94236,1.00845,112.85524,1.38795,2891.7379,193.01942,21.00046
+"11779","YPL113C",5,98,3,44.01966,0.89573,0.19048,1.9611,10.42303,3323.01979,613.64239,1.2262,1.00091,224.20375,1.45692,4273.71425,597.22069,17.62958
+"11780","YPL113C",17,98,3,36.14902,0.97555,0.19863,2.1043,11.19212,3460.98321,657.74806,1.28559,0.94404,255.50588,1.55165,4705.5299,593.46847,17.81065
+"11781","YPL113C",29,98,3,30.60721,0.97529,0.19135,2.04191,11.40814,3199.84476,549.78827,1.17863,1.00454,212.96626,1.45687,4203.67566,616.49629,17.10151
+"11782","YPL113C",41,98,3,28.68232,0.95148,0.19008,1.97196,12.13678,2975.72756,524.9105,1.12725,0.99941,209.76083,1.43884,4041.23704,396.93315,16.81428
+"11783","YPL113C",53,98,3,28.17857,0.95334,0.18623,2.01738,11.06961,2868.31023,455.43556,1.08814,1.07232,191.42149,1.40667,3773.45828,345.79366,17.62855
+"11784","YPL113C",65,98,3,29.85485,0.95981,0.19295,1.99287,10.35344,2930.55107,469.98684,1.08646,0.97354,183.03546,1.42293,3796.51709,345.39455,18.63925
+"11785","YPL113C",77,98,3,27.14851,0.9901,0.18801,1.96915,10.05555,2849.56303,446.38983,1.08579,0.96433,166.29199,1.42221,3580.54109,351.13448,17.6745
+"11786","YPL113C",89,98,3,27.67637,0.97841,0.182,1.9451,10.22313,2663.72302,398.09487,0.99011,0.94548,144.16303,1.49725,3235.98439,221.58663,18.68997
+"11787","YPL114W",4,98,3,47.7939,0.82331,0.17377,1.94857,10.76132,3257.87149,495.36152,1.23988,0.98509,177.43413,1.27983,3639.72494,454.16327,18.67349
+"11788","YPL114W",16,98,3,30.59838,0.80742,0.17109,1.94477,10.60085,3056.35767,457.86201,1.13108,0.88677,166.28646,1.28491,3512.96678,420.83212,16.02308
+"11789","YPL114W",28,98,3,30.07856,0.86595,0.18029,1.98598,12.1261,3187.45077,469.52076,1.15901,1.00935,175.41769,1.25925,3652.44687,483.02513,16.49065
+"11790","YPL114W",40,98,3,30.72011,0.86548,0.18152,2.02944,14.43888,3140.56308,469.7991,1.16611,0.78121,167.59667,1.21395,3643.28168,380.10953,16.6954
+"11791","YPL114W",52,98,3,24.6443,0.86864,0.17184,1.91312,11.08923,2937.28079,413.58707,1.083,0.945,145.56808,1.16076,3365.99909,304.72624,16.30811
+"11792","YPL114W",64,98,3,28.01458,0.87824,0.17974,2.39252,11.3122,3078.8732,417.05652,1.11756,0.8768,135.97638,1.18943,3421.68892,342.09702,17.66543
+"11793","YPL114W",76,98,3,23.46541,0.86589,0.17049,1.99815,9.92907,2977.26938,403.18702,1.06839,1.16855,150.82315,1.16638,3405.49681,279.00106,16.37426
+"11794","YPL114W",88,98,3,30.24232,0.87359,0.17011,1.95352,9.84205,2858.30698,349.57711,1.02462,0.78992,123.02562,1.20686,3034.15915,218.68069,18.9112
+"11795","YPL115C",3,98,3,55.22331,1.05575,0.19522,2.05221,10.9218,3165.10811,553.51891,1.43862,1.30433,181.14904,1.52862,4140.85572,498.80275,19.2578
+"11796","YPL115C",15,98,3,36.73949,1.05138,0.19305,2.08951,19.90117,3003.21363,507.21105,1.46516,1.12795,157.63374,1.48283,3856.54156,443.45074,16.30821
+"11797","YPL115C",27,98,3,35.17359,1.07599,0.20062,2.02039,18.76074,3064.22942,493.35739,1.35191,1.07076,163.90412,1.4536,3911.41632,520.05163,16.95869
+"11798","YPL115C",39,98,3,28.8628,1.07158,0.19701,2.02828,10.67902,3042.41504,505.22796,1.29474,0.89262,153.63054,1.41479,3917.35793,398.4378,16.68136
+"11799","YPL115C",51,98,3,29.99522,1.07783,0.19195,2.0269,10.82977,2972.30089,467.91667,1.27426,0.99248,147.07004,1.40816,3844.12677,380.07194,16.92887
+"11800","YPL115C",63,98,3,31.79597,1.06929,0.18454,2.00985,10.89382,2931.06314,474.89325,1.28136,0.98149,142.49774,1.39447,3700.47652,369.97324,17.13693
+"11801","YPL115C",75,98,3,25.89189,1.06459,0.18817,2.00067,10.55098,2918.49664,444.6016,1.2464,1.09015,136.25006,1.36761,3629.68396,332.22816,17.23936
+"11802","YPL115C",87,98,3,28.48605,1.06389,0.18252,1.95589,10.09724,2610.98071,350.1531,1.11662,1.10001,106.10043,1.29213,2982.22388,191.76082,18.1288
+"11803","YPL116W",2,98,3,37.42037,0.86177,0.18333,1.99271,14.27238,2989.39666,561.57007,1.15145,0.92989,220.63335,1.36705,4055.52661,474.59979,16.693
+"11804","YPL116W",14,98,3,38.61203,0.92253,0.18923,2.05597,10.48631,3118.60754,636.6266,1.1445,1.00733,250.35878,1.46233,4439.35148,593.92918,17.63942
+"11805","YPL116W",26,98,3,32.08851,0.90633,0.19142,2.06167,12.02022,2982.08203,587.96816,1.10494,1.02639,222.54454,1.52143,4210.78282,549.13588,17.2522
+"11806","YPL116W",38,98,3,28.0738,0.89811,0.18492,2.03364,10.12579,2868.85567,487.49348,1.01753,1.11433,182.58924,1.35458,3706.90071,380.08805,16.26627
+"11807","YPL116W",50,98,3,26.17644,0.88742,0.18339,2.09728,11.37168,2724.88369,487.18272,0.97955,1.41426,196.62922,1.36532,3817.42818,355.11295,16.41696
+"11808","YPL116W",62,98,3,22.61043,0.95283,0.18746,2.06473,10.65344,2645.12547,450.88953,1.01646,0.82015,165.7374,1.42382,3469.93286,382.45302,16.75996
+"11809","YPL116W",74,98,3,23.3012,0.93784,0.1901,2.04935,11.57823,2766.47424,452.49185,0.99283,1.24249,160.4309,1.31702,3675.36559,332.87422,16.78844
+"11810","YPL116W",86,98,3,14.93944,0.8917,0.17204,1.92422,9.77326,2377.14678,344.85967,0.87117,0.81031,121.51119,1.21865,2919.94868,156.47132,16.51052
+"11811","YPL118W",10,97,3,52.88466,0.87572,0.19592,2.0854,12.21557,1317.29264,503.61396,0.81264,0.80819,149.8374,2.76075,3485.81608,411.14373,19.17681
+"11812","YPL118W",22,97,3,79.38604,0.88198,0.20275,2.34268,12.97962,1327.33457,563.16456,0.80656,0.88277,182.90543,2.46494,3839.90269,515.69171,22.06138
+"11813","YPL118W",34,97,3,52.19354,0.86747,0.19748,2.18476,15.17299,1241.42612,451.43464,0.74968,1.00923,148.43472,2.36791,3456.83531,383.15621,19.77852
+"11814","YPL118W",46,97,3,42.7055,0.9044,0.19597,2.1933,13.93344,1261.82375,476.49126,0.75771,1.15351,152.48649,2.63196,3548.73425,457.53683,19.12464
+"11815","YPL118W",58,97,3,34.98582,0.88978,0.19187,2.17807,12.3877,1197.89672,437.57815,0.71866,0.9841,136.45333,1.72846,3369.67403,306.54837,18.275
+"11816","YPL118W",70,97,3,35.7019,0.90009,0.19781,2.1839,13.29884,1227.40184,447.34626,0.71801,0.96444,138.15222,1.87328,3342.18739,328.10159,18.08134
+"11817","YPL118W",82,97,3,31.4761,0.90523,0.18778,2.1949,11.34212,1154.88953,397.24217,0.69447,0.99789,127.74242,1.65498,3067.96251,257.09311,17.48417
+"11818","YPL118W",94,97,3,48.0312,0.9435,0.19224,2.17861,11.31753,1215.91442,397.6269,0.70496,1.08081,118.56458,1.65592,3048.27605,301.21013,18.95114
+"11819","YPL119C",9,97,3,57.73856,0.83648,0.18749,2.18696,13.49787,3029.01065,512.26428,1.16591,1.54411,222.38747,1.95016,3765.89115,446.93404,18.79115
+"11820","YPL119C",21,97,3,42.20492,0.88806,0.18538,2.26265,12.1046,3203.4705,567.12858,1.15477,1.26175,214.24858,2.09999,4075.41238,463.37483,18.31811
+"11821","YPL119C",33,97,3,49.70273,0.85607,0.18445,2.4443,12.60872,2845.58665,466.05106,1.03418,0.80749,189.65884,1.79803,3583.38349,403.18344,18.26892
+"11822","YPL119C",45,97,3,41.15385,0.90965,0.18834,2.30185,10.81783,2948.61499,440.20359,1.04577,0.73751,180.7053,2.35731,3685.40862,367.31647,18.98522
+"11823","YPL119C",57,97,3,32.98042,0.88636,0.18137,2.89841,11.64488,2919.63772,462.64803,1.05397,1.07373,181.66309,1.98863,3699.86681,354.54312,18.44444
+"11824","YPL119C",69,97,3,63.44612,0.91617,0.1856,2.2683,13.32951,2979.40796,442.81718,1.20976,1.04379,157.26907,1.89136,3529.70217,320.66072,18.50051
+"11825","YPL119C",81,97,3,28.88136,0.90675,0.18113,2.13522,10.22126,2783.11286,387.25429,0.9881,0.83723,165.96612,1.78613,3167.70459,296.06167,17.11433
+"11826","YPL119C",93,97,3,39.54795,0.96528,0.1897,2.23588,10.5466,2948.75704,386.68473,1.05752,0.78009,153.51555,1.73322,3264.08242,277.92965,18.46191
+"11827","YPL120W",8,97,3,55.24118,1.1985,0.18365,2.01937,12.40379,2517.05436,448.96544,1.03307,1.34089,296.72762,1.71294,3464.96335,436.40111,18.41373
+"11828","YPL120W",20,97,3,47.13545,1.30643,0.19495,2.13678,12.27462,2572.25525,453.07794,1.05673,1.43279,290.5445,1.66896,3472.54459,407.19854,18.58492
+"11829","YPL120W",32,97,3,44.56881,1.29326,0.19272,2.09911,11.96824,2499.0528,395.82664,0.96882,1.28503,253.11974,1.8001,3168.85576,376.91368,18.43453
+"11830","YPL120W",44,97,3,45.62023,1.3419,0.19126,2.13403,12.85056,2522.23993,428.45167,1.01204,1.29478,273.91586,1.77798,3458.72997,460.09187,18.655
+"11831","YPL120W",56,97,3,39.67289,1.32676,0.19049,2.08841,13.40528,2374.4087,382.88774,0.92988,1.24494,232.08794,1.58906,3056.52546,309.32313,18.62056
+"11832","YPL120W",68,97,3,45.19421,1.32324,0.18836,2.13789,13.04968,2288.64208,392.02322,0.89155,1.57449,273.63206,1.93309,3298.20276,360.80755,19.1177
+"11833","YPL120W",80,97,3,36.65983,1.31236,0.18107,2.02269,10.99568,2146.88354,316.0879,0.84437,1.24421,224.23006,1.41914,2808.74464,202.87481,17.89448
+"11834","YPL120W",92,97,3,50.21056,1.36235,0.18914,2.45325,10.96737,2116.85557,331.79394,0.84426,1.23976,203.87778,2.12561,2866.25601,217.1583,23.4744
+"11835","YPL121C",7,97,3,49.58962,1.05152,0.19347,2.20868,13.38166,3160.88922,519.77189,1.37338,1.78962,169.03151,1.96922,3832.78947,378.98273,19.5654
+"11836","YPL121C",19,97,3,45.23738,1.06655,0.19471,2.1674,12.83221,3299.60789,586.67802,1.38025,1.24675,177.34572,1.87267,4251.6283,447.70492,18.39843
+"11837","YPL121C",31,97,3,43.8658,1.1012,0.19867,2.26945,15.21711,3085.69199,503.66597,1.35117,1.22874,169.95356,2.21916,3876.42789,444.63408,19.30562
+"11838","YPL121C",43,97,3,40.39701,1.07617,0.19536,2.17149,12.63143,3037.13687,445.486,1.26609,1.32718,158.99699,1.74308,3565.65463,440.48054,19.13117
+"11839","YPL121C",55,97,3,39.50563,1.14985,0.197,2.33835,13.24182,3091.77828,466.53335,1.32342,1.30826,168.80094,1.90403,3869.46019,370.11898,19.85135
+"11840","YPL121C",67,97,3,40.95414,1.12589,0.1998,2.32161,11.82533,3107.6416,478.83287,1.31677,1.38428,158.67983,1.84829,3754.77596,377.96061,19.80976
+"11841","YPL121C",79,97,3,37.8384,1.10492,0.18945,2.22005,11.18764,2976.08657,420.4833,1.20107,1.16829,144.7255,1.92142,3623.60027,318.29413,18.89371
+"11842","YPL121C",91,97,3,33.45565,1.10457,0.18774,2.12439,10.14751,2674.85826,377.65261,1.10167,1.10312,127.69497,1.67749,3199.97936,244.01834,19.07095
+"11843","YPL123C",5,97,3,40.23526,0.8615,0.17115,2.113,10.85713,2952.08031,438.15802,1.28071,1.11629,275.50485,1.49744,3755.15486,388.28858,17.68531
+"11844","YPL123C",17,97,3,47.85149,0.9597,0.19268,2.20842,11.76834,3278.53464,572.11319,1.47994,1.10273,334.89372,1.71189,4536.88722,486.74086,19.31253
+"11845","YPL123C",29,97,3,42.85317,0.93366,0.18076,2.18565,13.76332,3046.83148,438.83468,1.31949,1.30954,291.32484,2.02791,3856.85664,448.07181,18.99296
+"11846","YPL123C",41,97,3,48.72768,0.93575,0.17745,2.22028,11.01936,3050.47245,492.48334,1.29451,1.40078,315.46036,1.56625,4113.18088,493.55318,19.14302
+"11847","YPL123C",53,97,3,35.52405,0.87114,0.16146,2.04506,11.05339,2638.22089,400.76735,1.1316,1.45773,258.93379,1.36726,3510.08868,317.73927,16.93393
+"11848","YPL123C",65,97,3,39.06865,0.98317,0.18638,2.37175,11.55509,3105.14554,456.05402,1.33924,0.96495,275.28747,1.56548,3897.75481,389.31996,18.42589
+"11849","YPL123C",77,97,3,47.43152,0.97657,0.18026,2.17136,10.82441,2965.01021,438.73797,1.25673,1.34747,263.37241,1.6161,3887.56985,324.80437,18.68165
+"11850","YPL123C",89,97,3,43.26904,0.96504,0.17358,2.14302,10.24548,2674.29201,352.10317,1.14715,0.99444,226.99219,1.5085,3220.62191,266.85563,19.80984
+"11851","YPL125W",4,97,3,38.27036,0.87592,0.16816,1.97014,13.67091,3025.4729,433.66249,1.16244,1.08126,148.8519,1.40734,3289.47696,427.86395,16.2973
+"11852","YPL125W",16,97,3,41.17377,0.82219,0.17395,2.03436,12.67271,3087.67491,469.69868,1.1721,0.9746,147.3354,1.53632,3621.48847,414.95775,17.70315
+"11853","YPL125W",28,97,3,44.31372,0.86183,0.18014,2.38487,14.24143,3147.10077,499.50953,1.1995,1.01513,184.65817,1.65655,3828.796,537.37364,18.37398
+"11854","YPL125W",40,97,3,35.84329,0.84158,0.17653,2.16872,11.53016,3093.81913,452.50025,1.12329,0.92581,142.05662,1.48993,3517.79481,398.28232,18.17645
+"11855","YPL125W",52,97,3,31.31417,0.83197,0.16905,2.55533,11.49375,2847.56895,373.40697,1.04031,0.8033,130.03875,1.52201,3137.01004,335.44404,16.49954
+"11856","YPL125W",64,97,3,35.88464,0.88954,0.18552,2.19537,13.22105,3219.48756,458.89159,1.15943,1.64376,149.73501,1.54615,3601.77397,396.92718,18.64108
+"11857","YPL125W",76,97,3,33.44149,0.8726,0.17214,2.09438,12.4977,2851.51893,382.27848,1.04754,1.10982,121.82808,1.40232,3155.21444,320.62969,17.68292
+"11858","YPL125W",88,97,3,30.4391,0.88588,0.17155,2.0048,11.22491,2688.98947,319.50013,0.99991,0.89015,107.47406,1.39189,2824.40108,239.10839,17.48948
+"11859","YPL127C",3,97,3,70.27276,1.27382,0.19249,2.11783,13.51126,2829.91842,487.32755,1.47666,1.78732,93.76321,2.22776,3698.75302,400.37317,16.88731
+"11860","YPL127C",15,97,3,48.12822,1.36362,0.19863,2.16437,11.06047,2987.08574,539.08451,1.48104,1.64922,100.90789,2.10528,4018.1341,420.90409,17.11343
+"11861","YPL127C",27,97,3,55.6753,1.38099,0.20604,2.24208,14.45978,3112.02717,567.16584,1.56709,1.8972,112.47312,2.14312,4310.60812,525.58845,18.87599
+"11862","YPL127C",39,97,3,69.12268,1.37896,0.19896,2.30288,13.22992,2980.36599,508.33413,1.49309,1.69445,95.80786,2.52822,4022.76716,448.94489,21.29871
+"11863","YPL127C",51,97,3,63.29455,1.44083,0.20691,2.33553,13.5129,3060.75371,533.78183,1.50152,1.88411,104.12187,2.27262,4183.37541,457.26299,19.49972
+"11864","YPL127C",63,97,3,52.15709,1.42254,0.20663,2.28826,12.08964,2993.80767,523.17266,1.54152,1.86875,97.93756,2.19673,4126.49668,427.59964,18.37473
+"11865","YPL127C",75,97,3,44.17487,1.3451,0.18824,2.14767,12.327,2506.61465,432.83128,1.25743,1.84493,107.53339,2.02927,3683.11241,378.27775,17.15289
+"11866","YPL127C",87,97,3,148.33147,1.37464,0.1816,2.18458,14.60551,2470.96725,384.26662,1.56482,2.10308,77.98417,2.63325,3359.48742,253.48526,18.94531
+"11867","YPL129W",2,97,3,50.34374,0.51161,0.13646,2.30284,14.18749,2142.68266,367.38636,0.7647,0.40896,156.59621,1.37588,2783.30352,421.74207,19.21054
+"11868","YPL129W",14,97,3,65.70769,0.51151,0.13802,2.31286,13.16124,2192.17194,380.38699,0.72391,0.48113,155.75094,1.76113,2846.53937,386.21636,21.06784
+"11869","YPL129W",26,97,3,63.48763,0.56911,0.1471,2.5916,17.21097,2486.89437,450.39267,0.83623,0.56427,193.48281,2.09231,3406.71647,654.95141,24.40168
+"11870","YPL129W",38,97,3,50.26719,0.53719,0.13938,2.39989,14.99059,2265.97969,384.41659,0.73457,0.70092,166.4269,1.4008,3028.55229,380.50373,21.67723
+"11871","YPL129W",50,97,3,61.07623,0.56676,0.14442,2.54074,15.36586,2289.03843,372.61779,0.77771,0.66471,171.17185,1.98366,3087.25368,403.77195,23.63844
+"11872","YPL129W",62,97,3,47.39103,0.57511,0.14342,2.517,24.40813,2309.9432,369.03516,0.7586,1.64573,157.76096,1.704,3028.83123,382.4807,23.09047
+"11873","YPL129W",74,97,3,34.3791,0.55276,0.1334,2.49772,13.93436,2227.19122,345.12151,0.73237,0.50247,145.28631,1.40142,2832.10736,318.86708,20.66649
+"11874","YPL129W",86,97,3,47.77988,0.56252,0.13379,2.30548,12.5486,1999.12212,260.49167,0.60605,0.61679,113.54321,1.30159,2354.81008,201.29689,22.19804
+"11879","YPL130W",10,96,2,32.32832,0.70044,0.1588,1.89278,10.80061,2779.68713,342.86595,0.99117,1.52184,151.38234,1.35008,2488.95284,345.94038,12.52497
+"11880","YPL130W",22,96,2,17.80348,0.76654,0.16011,1.69518,9.14901,2833.99487,319.8032,0.99252,0.97466,122.19285,1.06395,2605.95651,330.93038,12.46656
+"11881","YPL130W",34,96,2,7.68265,0.7227,0.14896,1.56176,7.73172,2353.16126,231.95146,0.80752,0.7185,82.71463,0.92178,1987.95511,137.11002,11.545
+"11882","YPL130W",46,96,2,0.46671,0.68694,0.14139,1.47235,7.2737,2239.67846,200.83099,0.72153,0.71716,81.79695,0.86938,1680.34311,117.3202,9.81563
+"11883","YPL130W",58,96,2,28.29994,0.71841,0.14642,1.5258,8.46208,2083.09916,159.3103,0.67237,0.77332,58.68463,0.87411,1390.3743,12.94345,10.34983
+"11884","YPL130W",70,96,2,16.93924,0.77635,0.16166,1.71734,8.55832,2582.39962,287.76121,0.89983,0.78629,115.60124,1.06234,2445.43806,235.46034,13.36262
+"11885","YPL130W",82,96,2,19.64791,0.83495,0.16692,1.74379,9.61908,3074.47832,354.93868,1.03445,0.92429,105.25907,1.107,2864.90059,293.07295,14.01215
+"11886","YPL130W",94,96,2,23.91019,0.84047,0.16971,1.88041,12.50379,2988.12808,384.73198,1.0606,0.91019,134.72075,1.18389,3082.3745,333.47742,14.81476
+"11887","YPL133C",9,96,2,33.16291,0.73665,0.17473,1.87374,11.80143,2317.23518,358.75803,0.8781,0.73187,162.97865,1.48765,2529.75661,330.39906,13.81048
+"11888","YPL133C",21,96,2,15.4366,0.79652,0.17562,1.89791,10.42704,2286.50675,332.56328,0.76145,0.74786,144.56162,1.23879,2516.94656,281.96672,13.22524
+"11889","YPL133C",45,96,2,8.68442,0.78534,0.17035,1.6844,9.31269,2255.40494,301.4099,0.70732,0.81834,126.1309,1.10146,2208.48361,211.86173,12.12002
+"11890","YPL133C",57,96,2,0.53117,0.7364,0.15353,1.49988,7.45374,1981.4728,213.17751,0.59499,0.81683,96.16202,0.99152,1723.36196,80.42356,11.01693
+"11891","YPL133C",69,96,2,10.79467,0.79504,0.16125,1.70132,9.05528,2114.88925,309.80552,0.68919,0.71046,135.41861,1.18249,2385.12924,200.58974,13.25072
+"11892","YPL133C",81,96,2,13.10718,0.82226,0.16823,1.75859,8.89441,2170.76725,283.34741,0.70539,0.69714,129.46226,1.18336,2345.71625,211.05848,13.33811
+"11893","YPL133C",93,96,2,27.30357,0.87687,0.17891,1.89989,10.34793,2382.65593,369.31167,0.80899,0.80207,170.80318,1.39981,2892.43348,308.63706,15.31411
+"11894","YPL135W",8,96,2,37.54156,0.7602,0.17157,1.90116,10.16902,2780.14768,410.19221,0.93375,1.21553,168.27383,1.43528,2793.34563,429.06528,13.83145
+"11895","YPL135W",20,96,2,19.5952,0.78729,0.16699,1.78271,9.78716,2418.94536,348.60657,0.83045,1.24045,140.12481,1.17919,2604.8039,285.33114,12.51587
+"11896","YPL135W",32,96,2,13.11273,0.75178,0.14563,1.49918,7.23185,1791.56072,182.63876,0.55812,1.22866,71.26556,0.946,1478.11859,5.07339,11.68726
+"11897","YPL135W",44,96,2,11.3527,0.79169,0.16887,1.68254,9.73857,2265.15932,289.31319,0.74803,1.28746,113.9113,1.1222,2225.19044,186.47019,11.63709
+"11898","YPL135W",56,96,2,11.56289,0.80118,0.16119,1.6728,8.40804,2226.00222,275.79243,0.72217,1.26267,107.19147,1.07705,2129.8894,177.11171,11.54821
+"11899","YPL135W",68,96,2,24.67247,0.91055,0.18744,1.90949,10.56085,2662.31028,426.47254,0.86712,1.40126,172.66157,1.33725,3186.5431,318.9591,14.43164
+"11900","YPL135W",80,96,2,12.73438,0.8613,0.17383,1.74181,9.12548,2386.71821,295.61708,0.79225,1.29052,114.88706,1.16524,2413.0554,183.71965,13.35366
+"11901","YPL135W",92,96,2,26.07495,0.89002,0.1772,1.81771,9.6402,2590.67658,408.48061,0.87186,1.31653,164.1457,1.37169,3106.65917,311.60774,14.88075
+"11902","YPL136W",7,96,2,46.056,0.7635,0.17897,1.93787,10.88961,3316.05803,457.19544,0.90197,0.64044,181.62292,1.60853,3033.95046,485.5356,14.953
+"11903","YPL136W",19,96,2,23.39992,0.77465,0.17634,1.78498,10.7238,2950.09127,394.64705,0.81021,0.68987,156.25513,1.28714,2761.83208,315.64791,13.92421
+"11904","YPL136W",31,96,2,4.95221,0.75738,0.15369,1.47384,7.62208,2123.60021,209.16956,0.54386,0.59918,83.80789,0.94469,1599.11998,72.5946,11.08879
+"11905","YPL136W",43,96,2,9.4693,0.77764,0.16805,2.59575,8.43347,2453.5137,281.06414,0.65079,0.5646,118.11496,1.08762,2077.83391,166.65959,12.08205
+"11906","YPL136W",55,96,2,11.94765,0.79725,0.17339,1.9312,9.47061,2824.12466,337.58969,0.72279,0.62549,137.12727,1.42541,2403.62081,280.18758,12.51129
+"11907","YPL136W",79,96,2,12.95901,0.83622,0.16312,1.61865,9.30534,2580.62373,292.99231,0.71187,0.68225,119.2508,1.10518,2311.66321,173.88123,13.42008
+"11908","YPL136W",91,96,2,18.1192,0.87986,0.19247,1.76459,13.05167,2940.28029,360.43493,0.77335,0.62885,149.65915,1.38034,2816.37644,265.90603,15.5924
+"11909","YPL138C",5,96,2,35.07983,0.63561,0.14399,1.79357,9.07765,2701.33732,365.93731,0.89159,0.90083,163.29367,1.17992,2794.36733,314.16409,13.67715
+"11910","YPL138C",17,96,2,29.10316,0.69758,0.15513,1.70746,9.26692,2878.26699,339.92326,0.89328,0.75213,145.58399,1.20968,2611.64713,322.94415,13.05142
+"11911","YPL138C",29,96,2,9.23097,0.6649,0.14365,1.50298,7.72227,2338.13197,223.08782,0.70938,0.85374,92.73875,0.90165,1828.3191,136.06927,11.16869
+"11912","YPL138C",41,96,2,7.38972,0.70107,0.14808,1.62265,17.79507,2653.87494,299.76178,0.82333,0.87362,116.85756,1.00046,2298.87414,225.98466,11.76081
+"11913","YPL138C",65,96,2,2.84595,0.70042,0.14414,1.52582,8.3525,2290.68042,232.19632,0.69972,0.96195,104.32802,0.88217,1863.67069,149.14058,11.25397
+"11914","YPL138C",77,96,2,12.81513,0.75769,0.15352,1.73148,9.37542,2662.1816,280.44199,0.82061,0.91156,109.41409,1.00251,2319.57872,212.05818,13.36903
+"11915","YPL138C",89,96,2,29.2092,0.75416,0.16013,1.89884,11.35722,2575.8647,295.46683,0.85059,1.12608,143.39439,1.2349,2600.65912,261.51225,15.70313
+"11916","YPL139C",4,96,2,39.48866,0.85811,0.16645,1.69789,9.90326,2634.54126,377.2794,1.0584,0.53398,141.18523,1.35883,2819.77733,272.55229,14.00725
+"11917","YPL139C",16,96,2,31.71855,0.84402,0.16515,1.62853,8.7784,2700.47262,338.75951,1.00972,0.56755,115.57996,1.33231,2461.73812,268.42414,12.34251
+"11918","YPL139C",28,96,2,14.16601,0.88555,0.16188,1.53833,7.75215,2371.20462,260.32709,0.86918,0.51852,78.09101,1.06637,1969.71575,149.63291,11.83111
+"11919","YPL139C",40,96,2,17.43878,0.92453,0.18064,1.65709,8.92165,2848.60389,367.53095,0.97454,0.48727,108.78092,1.22461,2592.64878,298.68785,12.62123
+"11920","YPL139C",52,96,2,6.61236,0.86005,0.1608,1.51381,8.1213,2426.64394,274.49988,0.81538,0.51854,78.28119,1.09638,1927.18409,139.92997,10.59829
+"11921","YPL139C",64,96,2,10.92876,0.91023,0.16386,1.6095,9.32598,2413.12469,282.01578,0.88787,0.52892,87.66866,1.51482,2106.73166,163.85691,11.74879
+"11922","YPL139C",76,96,2,18.18334,0.936,0.17187,1.66222,9.61786,2709.72832,332.44352,0.99942,0.59366,97.57252,1.71867,2522.24969,211.73237,12.74018
+"11923","YPL139C",88,96,2,19.18034,1.10453,0.19081,1.91269,10.26618,2827.78181,336.09508,1.05412,0.75568,106.48103,1.40931,2668.9005,181.94966,14.88748
+"11924","YPL140C",3,96,2,40.34575,0.81379,0.173,1.87463,10.49819,2864.14605,484.57694,1.12698,1.0576,226.82325,1.39544,3526.84862,399.11295,15.54303
+"11925","YPL140C",15,96,2,33.71758,0.74546,0.16656,1.6821,9.57269,2538.27447,358.83815,0.96071,0.79566,171.99199,1.25848,2618.73454,327.47936,14.22149
+"11926","YPL140C",27,96,2,9.2123,0.77701,0.1557,1.61215,9.11664,2272.17099,253.92688,0.87267,0.87782,101.39416,1.04926,2087.48351,117.65549,11.66254
+"11927","YPL140C",39,96,2,17.93491,0.77606,0.16522,1.70183,9.60908,2678.77905,338.0746,0.96625,0.90056,149.33028,1.12972,2526.01149,349.37939,11.99225
+"11928","YPL140C",51,96,2,105.24571,0.79874,0.16783,2.20734,10.65361,2437.18417,275.49375,0.88794,1.00165,124.198,1.35569,2224.27331,296.2203,12.54884
+"11929","YPL140C",63,96,2,11.01772,0.81484,0.16087,1.78927,10.10697,2409.06896,265.81162,0.84789,1.05503,112.59516,1.1727,2092.31951,173.12413,11.95266
+"11930","YPL140C",75,96,2,16.78118,0.84901,0.16888,1.73567,10.26622,2644.35077,337.54193,0.96055,1.1204,145.21905,1.21703,2674.1903,246.95764,13.55567
+"11931","YPL140C",87,96,2,15.09892,0.8665,0.16675,1.75314,9.76608,2305.85973,304.92908,0.87441,0.91903,160.99277,1.37171,2555.58923,224.10884,13.71713
+"11932","YPL141C",2,96,2,42.80353,0.81295,0.17155,1.94117,11.67084,3070.64698,488.01913,1.18777,0.86121,171.99133,1.44287,3708.09298,370.68394,17.33703
+"11933","YPL141C",14,96,2,26.35858,0.75438,0.16484,1.74807,9.51054,3144.04949,419.06906,1.05421,0.73031,130.31439,1.12847,2916.42911,384.54778,13.96668
+"11934","YPL141C",26,96,2,11.17293,0.73379,0.14814,1.62679,8.39008,2437.41624,269.63182,0.88885,0.71094,87.22364,0.95461,2217.28038,193.13807,11.90672
+"11935","YPL141C",38,96,2,8.0966,0.717,0.149,1.54159,8.61226,2470.53973,257.75195,0.78195,0.77349,96.05089,0.94589,1964.11757,247.2079,10.35933
+"11936","YPL141C",50,96,2,12.41165,0.7651,0.16086,1.67361,11.75373,2565.12278,293.54762,0.86785,0.82794,94.91694,1.00831,2316.00279,219.84655,12.03464
+"11937","YPL141C",62,96,2,21.28309,0.75329,0.16051,1.74039,8.72825,2479.39408,275.90589,0.82847,0.8202,110.28718,1.0713,2180.18279,228.39294,12.35938
+"11938","YPL141C",74,96,2,22.91791,0.81172,0.16077,1.75247,10.58852,2594.22226,306.93745,0.91549,0.92163,106.841,1.11142,2420.81898,244.67612,13.05986
+"11939","YPL141C",86,96,2,16.10471,0.82442,0.16363,1.69847,9.93146,2622.14388,314.5514,0.92764,0.84295,108.64396,1.29354,2608.24909,240.97522,13.60365
+"11940","YPL144W",10,95,2,19.18701,0.6859,0.15321,1.66324,10.50685,3290.77135,277.22963,1.0342,0.79179,156.36658,0.99781,2218.11174,330.79394,12.25112
+"11941","YPL144W",22,95,2,20.51949,0.75518,0.15658,2.22762,11.26932,3286.76364,284.57585,1.07372,0.95345,154.24245,1.08465,2347.16765,297.25931,13.94451
+"11942","YPL144W",34,95,2,17.1039,0.73443,0.15218,1.6875,10.14237,2959.04633,211.8453,0.92899,0.76743,126.99668,0.83507,1879.2983,181.93123,12.98381
+"11943","YPL144W",46,95,2,34.19337,0.69049,0.14228,1.52545,8.16052,2509.56062,186.6415,0.80708,0.74794,115.78237,0.82656,1656.34233,107.46026,12.67708
+"11944","YPL144W",70,95,2,21.48314,0.74977,0.15394,1.71334,9.41454,2753.58745,250.36634,0.93777,0.74903,163.5196,0.8869,2181.49003,344.21686,13.5652
+"11945","YPL144W",82,95,2,23.58663,0.80196,0.1634,1.85431,10.85257,3407.43426,329.44016,1.11745,0.85347,179.56456,0.96221,2677.72968,344.96427,14.71571
+"11946","YPL144W",94,95,2,33.38966,0.78188,0.15549,1.84184,10.64716,3260.77847,326.62176,1.01984,0.84715,179.96832,0.99605,2790.97073,314.92756,15.88236
+"11947","YPL145C",9,95,2,59.52252,0.71525,0.16614,3.33936,10.29322,3195.51668,364.81544,1.03394,0.76407,147.07427,2.09098,2525.1378,380.25527,14.29174
+"11948","YPL145C",21,95,2,25.9092,0.75004,0.16432,1.7026,9.91673,2981.30356,392.12976,0.97701,0.83384,147.35419,1.13484,2847.91659,353.99924,12.80096
+"11949","YPL145C",45,95,2,14.40087,0.74909,0.16016,1.63787,9.0469,2853.1335,333.29049,0.91551,0.74909,125.23502,1.0453,2434.39579,275.34708,12.33036
+"11950","YPL145C",57,95,2,10.48697,0.74622,0.14946,1.52565,8.74293,2535.67789,219.82447,0.79619,0.97363,78.48166,0.92434,1846.4042,143.69347,11.74571
+"11951","YPL145C",69,95,2,20.74917,0.8363,0.16944,1.74341,9.50062,3135.7313,321.33335,1.01109,1.08568,97.41712,1.11355,2603.06382,238.38188,14.17182
+"11952","YPL145C",81,95,2,12.80048,0.79425,0.15382,1.64218,9.10437,2787.70508,279.72171,0.90296,0.80852,90.22843,0.99129,2320.93604,189.01768,12.94995
+"11953","YPL145C",93,95,2,18.89543,0.79508,0.15501,1.76086,10.95777,3108.09402,341.4045,1.01043,0.86599,87.97731,1.07805,2648.51104,237.67005,14.20111
+"11954","YPL147W",8,95,2,33.18397,0.74902,0.16355,1.71919,9.58489,3273.6502,432.74698,1.09597,0.82944,163.68251,1.18806,2953.93753,459.07626,12.59396
+"11955","YPL147W",20,95,2,17.45547,0.76837,0.15889,1.59382,9.34021,2790.92629,339.7135,0.99875,0.8853,145.67104,1.23121,2687.22354,310.96904,12.57657
+"11956","YPL147W",32,95,2,3.21329,0.73385,0.13663,1.38224,7.0425,2041.13179,171.08902,0.68953,0.90717,76.6638,0.84112,1429.19013,32.41938,10.1221
+"11957","YPL147W",44,95,2,23.95997,0.7718,0.16174,1.6645,8.50879,2716.88277,320.20133,0.9216,0.87521,120.82638,1.08052,2428.69398,261.65109,12.93428
+"11958","YPL147W",56,95,2,16.90211,0.78503,0.15663,1.59022,10.88003,2454.35052,253.34509,0.84921,1.07009,117.23274,1.0104,2119.29324,211.10847,12.40981
+"11959","YPL147W",68,95,2,15.44238,0.86699,0.16839,1.68694,9.6727,2803.84798,301.82826,0.96727,1.07989,135.60288,1.1254,2530.01964,234.02682,13.39059
+"11960","YPL147W",80,95,2,14.31632,0.8229,0.15404,1.61743,8.88436,2580.85648,272.13848,0.92492,1.06883,102.15327,1.03775,2397.76431,173.7011,12.89077
+"11961","YPL147W",92,95,2,28.00604,0.83584,0.16577,1.79519,10.33453,3108.37032,404.96938,1.06817,1.01877,186.99625,1.3479,3237.88575,374.39306,14.80749
+"11962","YPL149W",7,95,2,34.44052,0.74918,0.16889,1.71849,10.11139,3312.75148,447.90048,1.0298,1.05877,240.52365,1.19779,2817.15819,527.58158,14.48162
+"11963","YPL149W",19,95,2,16.33989,0.72978,0.15642,1.51817,9.71184,2710.52354,302.79722,0.93281,0.93909,153.98006,1.16793,2207.48944,266.16853,13.14447
+"11964","YPL149W",31,95,2,2.8636,0.71838,0.14077,1.34721,7.01853,2228.01931,181.36124,0.67826,0.91263,101.196,0.78148,1450.42427,101.27361,11.42335
+"11965","YPL149W",43,95,2,19.1697,0.74804,0.1566,1.45826,8.84874,2732.8827,294.90648,0.83606,0.93834,181.39151,0.97011,2112.23086,595.62431,12.55251
+"11966","YPL149W",55,95,2,2.5421,0.70647,0.14257,1.31296,7.97072,2215.95113,197.97253,0.6846,0.92509,108.5877,0.82679,1523.2759,154.08023,10.85877
+"11967","YPL149W",79,95,2,9.50435,0.79284,0.15159,1.45641,8.63341,2511.22301,235.22411,0.79975,0.90067,124.07502,0.92624,1976.21431,179.71869,12.99504
+"11968","YPL149W",91,95,2,18.84361,0.78791,0.15545,2.12335,10.35159,2704.63719,282.92971,1.54688,1.00899,152.89775,1.01656,2341.67722,221.70173,14.1396
+"11969","YPL150W",5,95,2,36.54246,0.73877,0.1617,1.77779,10.2867,3639.01993,413.96516,1.01527,1.00431,61.14772,1.21199,3213.90931,352.51293,15.25039
+"11970","YPL150W",17,95,2,28.9976,0.68637,0.15051,2.53529,9.89643,3390.59094,350.16597,0.87591,0.94043,79.41086,1.36009,2621.75549,501.73829,12.62327
+"11971","YPL150W",29,95,2,10.87541,0.67811,0.13702,1.47801,9.97324,2737.53014,221.10278,0.70694,1.03116,26.34626,2.10742,1866.36967,125.66983,11.76349
+"11972","YPL150W",41,95,2,13.40881,0.66818,0.14181,1.47133,8.19103,2869.77669,254.25726,0.70848,1.02096,40.15355,0.85335,2072.53553,203.53698,11.60154
+"11973","YPL150W",53,95,2,3.93361,0.662,0.13825,1.46113,8.44422,2679.13671,223.66659,0.6274,1.01217,29.48995,0.80358,1777.17689,108.99694,10.0812
+"11974","YPL150W",65,95,2,10.62569,0.71804,0.14746,1.57092,8.72224,2893.39729,250.20051,0.7347,1.03734,35.40876,2.72981,2085.38647,186.67572,11.85643
+"11975","YPL150W",77,95,2,18.28125,0.76003,0.14802,1.69841,10.03915,3069.1696,285.50101,0.79989,1.60383,35.90043,1.43426,2417.90843,202.94487,13.66703
+"11976","YPL150W",89,95,2,21.39802,0.73142,0.14205,1.62216,9.02845,2980.79902,281.40786,0.80873,1.07427,38.29863,3.14012,2355.5976,178.61937,14.32585
+"11977","YPL152W",4,95,2,39.30162,0.71628,0.14999,1.86091,9.42747,3277.29198,387.96925,0.93822,1.00098,107.60388,1.09221,3093.53069,319.31759,15.93029
+"11978","YPL152W",16,95,2,39.72603,0.69175,0.14893,1.77987,10.07748,3233.45052,350.96024,0.91364,0.9473,105.30868,1.20421,2733.3545,358.10447,15.9646
+"11979","YPL152W",28,95,2,12.86582,0.69488,0.14285,1.69789,8.67642,2540.35105,239.0784,0.77073,0.95845,78.98057,2.78683,2077.15096,153.22995,12.86582
+"11980","YPL152W",40,95,2,14.25886,0.68697,0.14109,1.69385,9.61069,2900.4236,293.85969,0.77918,0.99775,81.81066,0.85329,2360.00919,243.48588,12.2454
+"11981","YPL152W",52,95,2,2.00031,0.62756,0.12852,1.48862,8.19181,2459.14444,208.35864,0.61875,1.13949,55.75716,0.82078,1740.0589,113.06779,10.24176
+"11982","YPL152W",64,95,2,9.18974,0.68507,0.13492,1.55809,8.28773,2515.6139,214.55573,0.66518,1.08396,61.1133,0.82646,1864.93105,104.07842,11.69533
+"11983","YPL152W",76,95,2,23.97175,0.69372,0.13807,1.76316,12.29114,2875.53658,291.24368,0.81181,1.66252,68.03066,0.94867,2529.34506,216.97353,14.9077
+"11984","YPL152W",88,95,2,20.77941,0.72085,0.14079,1.92565,12.82638,2593.02721,213.75046,0.91308,1.20345,64.31466,1.3889,2019.73198,132.25725,14.10563
+"11985","YPL154C",3,95,2,29.44938,0.78289,0.16809,1.84902,10.49589,2199.10747,370.46655,1.22298,0.99863,126.66541,1.08202,2666.32681,403.42339,17.28579
+"11986","YPL154C",15,95,2,16.11385,0.73271,0.1684,1.74282,10.32623,2161.10048,298.67629,1.09943,1.57508,107.40147,1.03117,2017.31759,383.92938,13.6158
+"11987","YPL154C",27,95,2,3.7159,0.73985,0.15501,1.59109,8.18363,1726.45276,193.22038,0.92201,0.94986,63.51985,0.92201,1508.32566,146.96506,12.65447
+"11988","YPL154C",51,95,2,3.75353,0.7326,0.15837,1.59464,8.53495,1743.04066,205.82803,0.90799,1.01279,67.44955,1.35905,1525.89418,185.45483,12.79404
+"11989","YPL154C",63,95,2,16.98085,0.73762,0.16555,1.71977,9.51628,1918.26908,236.69772,0.95246,1.03587,80.61734,1.24938,1666.39201,261.63522,14.31196
+"11990","YPL154C",75,95,2,7.39455,0.76134,0.15934,1.65589,10.47859,1820.35791,231.82399,0.98609,1.14684,78.66387,0.91911,1750.40139,201.01336,14.15503
+"11991","YPL154C",87,95,2,8.46998,0.75905,0.15678,1.61038,9.34941,1691.83303,208.61375,0.92197,1.02649,70.98202,1.22616,1619.02726,137.61011,14.20794
+"11992","YPL155C",2,95,2,43.22465,0.87731,0.18012,1.91584,9.91914,3474.93519,527.94152,1.26126,0.92976,184.26804,1.38298,3963.76994,414.05274,16.7693
+"11993","YPL155C",14,95,2,18.81096,0.74819,0.158,1.63369,8.49014,2934.404,331.97767,0.95381,0.84304,111.10142,1.11566,2568.93008,329.3245,11.77343
+"11994","YPL155C",26,95,2,9.85811,0.81844,0.15709,1.64964,8.71627,2568.07332,271.55904,0.92127,0.88794,91.06341,1.11418,2248.92585,166.73682,12.22689
+"11995","YPL155C",50,95,2,14.43642,0.84169,0.16715,1.73385,9.32244,2952.59997,331.33249,1.01166,0.89959,101.24048,1.15194,2527.30088,302.83077,12.69959
+"11996","YPL155C",62,95,2,8.42118,0.79258,0.15364,1.60803,7.75815,2575.88981,253.93091,0.88098,0.90994,78.41984,0.99835,1992.88516,135.95821,11.15711
+"11997","YPL155C",74,95,2,17.11108,0.86579,0.16765,1.76125,11.82875,2883.38926,321.53003,1.01409,1.19206,113.62658,1.10872,2706.84082,265.10515,13.62954
+"11998","YPL155C",86,95,2,18.04982,0.87526,0.16894,1.72529,10.14721,2731.37996,290.13856,0.94765,0.99347,95.89382,1.1668,2536.13909,221.80426,13.6735
+"11999","YPL156C",10,94,2,102.94262,0.66782,0.14314,1.75263,10.16396,2835.48287,330.65431,1.01835,0.78575,133.30418,1.30893,2415.89395,344.66232,12.0925
+"12000","YPL156C",22,94,2,24.35944,0.71108,0.14242,1.74191,9.03338,2788.41612,316.475,0.98379,0.8038,137.64822,1.00969,2489.80334,275.56914,12.29903
+"12001","YPL156C",34,94,2,11.89603,0.66466,0.12608,1.44798,8.51665,2207.96319,200.94435,0.73111,0.91759,99.33561,0.8009,1703.32919,101.15411,10.09268
+"12002","YPL156C",46,94,2,13.80439,0.69293,0.13479,1.5499,10.22949,2247.0823,228.73193,0.78926,1.02295,111.58033,0.91617,1871.79479,163.11465,10.63186
+"12003","YPL156C",58,94,2,7.05169,0.6808,0.13435,1.53026,8.30459,2191.57791,216.91331,0.72144,0.92024,113.50674,0.86733,1676.14829,74.72527,10.10819
+"12004","YPL156C",70,94,2,26.41912,0.7441,0.14329,1.72844,9.5741,2532.77733,271.06529,0.89434,0.80859,129.9696,1.02828,2325.84645,246.40366,13.66311
+"12005","YPL156C",82,94,2,21.95448,0.75505,0.14011,1.67299,9.14482,2470.82776,295.25702,0.90137,0.87307,159.15444,0.98281,2482.56074,211.88383,12.89248
+"12006","YPL156C",94,94,2,27.70887,0.78429,0.14432,1.80944,24.60356,2579.12745,307.87629,0.98733,0.90704,183.06696,1.29056,2687.94579,283.39216,14.02031
+"12007","YPL157W",9,94,2,78.32459,0.90451,0.17832,1.71294,31.45574,3335.09003,388.70729,0.77794,0.67192,60.12174,1.12252,2758.58927,406.20111,12.70952
+"12008","YPL157W",21,94,2,56.05809,0.93989,0.1789,1.71289,9.60138,3096.88144,327.1452,0.71225,0.63607,49.20096,1.24504,2633.92036,254.59368,13.03693
+"12009","YPL157W",33,94,2,31.24194,0.88987,0.15826,1.46112,9.14006,2430.64415,203.63987,0.49788,0.59008,23.46163,0.88745,1587.44154,61.25288,10.08142
+"12010","YPL157W",45,94,2,49.0743,0.93299,0.16841,1.53293,11.31394,2616.29883,235.09685,0.54491,0.58176,33.7686,0.94795,1933.6834,139.90861,11.02263
+"12011","YPL157W",57,94,2,38.39169,0.91881,0.16325,1.50288,9.14996,2486.50062,229.74015,0.51766,0.56867,33.77859,0.88602,1890.22847,129.92938,10.7512
+"12012","YPL157W",69,94,2,47.88359,0.95266,0.17166,1.6089,9.69617,2832.16641,315.43889,0.61407,0.55486,46.57111,0.99542,2484.13659,217.29743,12.54235
+"12013","YPL157W",81,94,2,51.91179,1.02055,0.1747,1.6719,11.81983,2752.81299,288.6874,0.60924,0.84157,51.77141,1.15461,2443.98135,224.11351,12.999
+"12014","YPL157W",93,94,2,52.89499,1.02893,0.17539,1.69705,11.04066,2882.35042,334.19831,0.65885,0.97613,57.53193,1.09797,2772.0115,245.7241,13.97852
+"12015","YPL159C",8,94,2,38.88066,0.75807,0.17661,1.88002,11.90678,2456.82636,450.86739,0.7985,0.63887,210.23857,1.3396,3051.15463,497.22769,13.11296
+"12016","YPL159C",20,94,2,22.98062,0.76336,0.16742,1.81942,10.48799,2055.47254,338.5356,0.71847,0.65071,162.83991,1.38145,2649.59852,308.90193,12.81947
+"12017","YPL159C",44,94,2,9.20893,0.74298,0.15854,1.63768,8.7509,1787.94741,273.05372,0.57889,0.57544,129.29471,1.19652,2201.78692,196.63404,11.26608
+"12018","YPL159C",56,94,2,312.14779,0.81683,0.17236,1.86094,11.84517,2031.59808,359.38885,0.74003,0.62119,171.43306,1.69028,2748.35892,621.34787,13.26473
+"12019","YPL159C",68,94,2,6.26429,0.76175,0.15272,1.58254,8.74219,1684.19347,237.29969,0.5068,0.73109,101.49075,1.11493,1891.56639,123.36656,11.05176
+"12020","YPL159C",80,94,2,20.61829,0.83091,0.16655,1.75447,11.64007,1730.93602,281.47932,0.64149,0.89856,124.48915,1.61329,2319.92487,206.0358,13.49307
+"12021","YPL159C",92,94,2,30.96008,0.85497,0.17404,1.85775,10.80562,2048.6834,403.86713,0.73758,0.67995,181.81446,1.33373,3115.10196,376.71165,15.53662
+"12022","YPL161C",7,94,2,45.69861,0.58914,0.11769,2.09418,16.00415,2963.24773,546.23474,1.18723,1.55152,211.82779,1.22579,3288.97772,725.83386,16.07302
+"12023","YPL161C",19,94,2,24.22036,0.53813,0.11265,1.80573,11.93817,2285.16069,311.73925,0.88127,1.26042,141.26714,1.14258,2338.59334,346.43387,13.51187
+"12024","YPL161C",31,94,2,0.18527,0.49023,0.09123,1.55602,8.90754,1698.34888,163.67797,0.61721,1.3953,77.78502,0.74083,1423.28673,73.59512,10.59469
+"12025","YPL161C",43,94,2,11.91647,0.53925,0.10068,1.97576,9.56928,1978.33996,212.2782,0.72066,1.31545,82.58989,0.9148,1615.51533,148.22504,12.38934
+"12026","YPL161C",55,94,2,5.23837,0.55166,0.1073,1.76237,10.31371,1889.07563,198.38838,0.80295,1.35744,88.6944,2.60678,1563.00629,142.1237,12.26304
+"12027","YPL161C",79,94,2,31.41975,0.62174,0.11311,1.91526,10.68475,2227.03406,251.92197,0.86246,1.65363,108.17918,1.05986,2196.48382,263.43706,17.20213
+"12028","YPL161C",91,94,2,23.46374,0.58715,0.10628,1.84692,12.3599,2026.04255,266.37331,0.82201,1.33187,140.61895,0.95505,2257.93003,262.58284,21.14487
+"12029","YPL162C",5,94,2,155.41007,0.75026,0.16511,3.15988,15.72602,2809.63028,370.59814,1.67978,0.98758,142.90581,1.49541,2917.44761,401.47601,15.24754
+"12030","YPL162C",17,94,2,29.15714,0.76018,0.16248,1.80243,10.63426,2836.48675,326.19939,0.94322,0.94322,133.38932,1.35643,2615.87871,363.49103,12.9223
+"12031","YPL162C",29,94,2,11.05105,0.73626,0.14747,1.56239,12.62566,2261.25855,196.71871,0.80025,0.94764,81.53473,0.99294,1798.94082,151.06214,11.64063
+"12032","YPL162C",41,94,2,88.41337,0.76445,0.15394,1.75406,10.86841,2471.38567,232.02901,0.85421,1.35986,98.66095,1.08385,2114.59059,294.03805,12.60377
+"12033","YPL162C",53,94,2,3.89165,0.69461,0.1337,1.71259,8.94017,1992.47261,148.46192,0.63644,1.12198,61.60764,0.84047,1336.15732,45.17137,10.01915
+"12034","YPL162C",65,94,2,9.55582,0.75613,0.14883,1.59668,11.00322,2255.96235,197.7093,0.72847,1.16473,78.88669,0.97377,1743.69142,165.50291,11.50336
+"12035","YPL162C",77,94,2,15.94521,0.76159,0.14729,1.57414,9.1989,2324.18298,233.3015,0.79896,0.93348,103.87827,0.9953,2143.46604,207.41686,12.42599
+"12036","YPL162C",89,94,2,15.31476,0.78131,0.14502,1.62017,9.6005,2336.48276,231.75255,0.79214,1.0352,94.17698,1.00338,2129.30695,179.34926,13.10759
+"12037","YPL163C",4,94,2,26.17543,0.75048,0.15709,1.76498,10.5294,3180.87515,370.76603,1.09831,1.00127,125.83613,1.1859,3022.08344,317.83546,14.26605
+"12038","YPL163C",16,94,2,20.92683,0.72692,0.1589,1.66904,12.21852,3272.17054,346.92001,1.02482,0.96766,110.82074,1.08534,2705.29019,378.52544,12.58837
+"12039","YPL163C",28,94,2,6.85222,0.7375,0.14753,1.62605,12.87791,2397.07621,216.08187,0.86178,1.53305,86.40275,0.98178,1953.81212,120.45383,11.52037
+"12040","YPL163C",40,94,2,10.00845,0.70545,0.14646,1.57981,10.81631,2746.71319,240.1878,0.84451,0.9971,81.7581,0.9799,1956.06073,210.64119,11.19031
+"12041","YPL163C",52,94,2,8.72672,0.69685,0.1482,1.55668,10.42068,2396.43605,217.32504,0.76951,1.43786,89.51512,0.95697,1807.16166,188.98527,11.1914
+"12042","YPL163C",64,94,2,11.86499,0.74038,0.15018,1.60796,11.86499,2564.6407,217.3722,0.82154,1.19872,83.60469,0.98493,1876.71534,145.37291,11.77337
+"12043","YPL163C",76,94,2,81.0213,0.72912,0.13877,1.52506,8.88793,2377.99811,235.89253,0.83615,1.04138,76.11578,0.93457,1877.52754,152.65878,12.28289
+"12044","YPL163C",88,94,2,1081.20786,0.78126,0.1546,1.72662,14.03915,2572.00594,228.86026,1.04604,0.93296,83.09027,1.11775,2203.09892,927.43914,14.21843
+"12045","YPL164C",3,94,2,124.02511,0.94452,0.18473,1.95809,12.94968,3701.21161,546.58336,1.36988,1.49885,170.66481,1.54119,4225.58249,493.29946,17.14465
+"12046","YPL164C",15,94,2,20.81155,0.84847,0.17547,1.77977,10.94869,3210.82588,349.06334,1.13385,1.60298,106.84192,1.38512,2777.19386,356.78937,12.77231
+"12047","YPL164C",27,94,2,12.09095,0.87307,0.16599,1.8429,10.1558,2752.71674,273.17151,0.99008,1.55562,95.85755,1.26085,2365.68627,204.76612,12.55599
+"12048","YPL164C",39,94,2,12.5857,0.80568,0.16251,1.58391,12.23857,2612.40151,235.56822,0.88156,2.09331,88.88301,1.22386,1902.79059,180.18789,10.92268
+"12049","YPL164C",51,94,2,21.22437,0.83349,0.16029,1.72942,9.0343,2502.12749,249.87969,0.88261,1.44632,99.33571,1.35057,2078.30622,194.17508,12.05684
+"12050","YPL164C",63,94,2,4.35273,0.80457,0.15367,1.58179,10.34678,2385.55317,236.78526,0.79644,1.68558,102.42189,1.11835,1988.09507,156.16724,11.07894
+"12051","YPL164C",75,94,2,19.62683,0.90818,0.1727,1.81636,12.2028,2935.01505,344.46063,1.0163,1.51075,143.14685,1.34858,2862.2163,317.57555,14.1417
+"12052","YPL164C",87,94,2,627.315,0.89728,0.17434,3.36764,14.34654,2654.92598,451.90532,2.22474,1.63058,112.37294,1.4737,2463.97008,271.02961,15.29777
+"12053","YPL165C",2,94,2,45.02871,0.80517,0.16555,1.87081,11.05283,3007.81043,469.56246,1.19251,1.01013,300.35406,1.21508,3733.6864,349.94542,16.64025
+"12054","YPL165C",14,94,2,18.85099,0.74865,0.15801,1.74237,10.31419,2793.98641,347.39686,0.99506,1.0092,238.53238,1.05835,2725.31493,352.31159,12.17236
+"12055","YPL165C",26,94,2,21.73686,0.74703,0.14822,1.69906,9.74267,2314.75332,266.49892,0.87073,0.9972,194.36701,1.03333,2284.17717,203.74833,12.36944
+"12056","YPL165C",38,94,2,5.63465,0.69521,0.1348,1.47498,9.64562,1824.6297,196.04722,0.6428,1.30698,155.05333,2.35032,1625.28689,104.49421,10.01537
+"12057","YPL165C",50,94,2,22.93366,0.76647,0.15579,1.75994,10.31296,2723.13596,383.84187,0.96623,0.98892,266.71448,1.1115,2839.65804,396.70469,12.37858
+"12058","YPL165C",62,94,2,10.81249,0.74832,0.14485,1.62415,9.95688,2257.14594,247.21843,0.79049,1.06005,196.26039,0.97676,2054.22239,240.02525,11.37281
+"12059","YPL165C",74,94,2,23.26865,0.78225,0.15384,1.72988,9.67526,2495.66722,361.48405,0.92704,1.1425,267.20176,1.14868,2899.83219,319.28346,13.24344
+"12060","YPL165C",86,94,2,29.56664,0.79972,0.15237,1.71594,11.3409,2381.39177,314.35951,0.90438,1.16042,235.17725,1.10579,2652.57293,280.72515,14.34891
+"12065","YPL194W",10,90,1,63.43089,1.12246,0.18628,2.03014,6.4864,2603.58177,516.76575,1.28832,1.59198,187.57037,1.52226,3921.8128,638.23528,17.24668
+"12066","YPL194W",22,90,1,61.03101,1.11197,0.18053,2.03772,5.84689,2507.84382,436.21124,1.1952,1.4966,164.39672,1.44028,3764.88234,491.24163,16.19156
+"12067","YPL194W",34,90,1,25.71326,1.03318,0.1701,1.92469,4.12427,2125.65877,287.88388,0.95892,1.51659,88.09271,1.14851,2405.95481,339.43346,12.41051
+"12068","YPL194W",46,90,1,31.32702,1.12697,0.17943,2.00613,5.15572,2400.53733,368.4421,1.11095,1.57136,168.92941,1.31213,3284.42872,365.70507,14.4921
+"12069","YPL194W",58,90,1,34.38488,1.13902,0.18438,2.07134,5.12018,2545.05685,423.10059,1.1598,1.58514,133.41694,1.36673,3538.89997,418.13715,15.6781
+"12070","YPL194W",70,90,1,24.86991,1.09387,0.17481,1.86059,4.805,2266.83504,345.22161,1.04494,1.47681,101.88137,1.26829,3051.04308,268.62244,14.53157
+"12071","YPL194W",82,90,1,27.39915,1.11053,0.17397,1.94583,4.64534,2128.40608,318.94585,0.97025,1.43465,92.28088,1.22175,2936.9475,271.91451,14.07432
+"12072","YPL194W",94,90,1,21.87212,1.06486,0.16962,2.03083,4.3914,1951.58289,263.06716,0.9086,1.5644,76.78771,1.2469,2412.49046,194.71197,13.55917
+"12081","YPL195W",9,90,1,41.92058,0.85844,0.17189,1.94333,6.02612,2424.59274,355.30885,1.22555,0.49006,216.99108,1.16743,3324.04131,574.43589,16.95456
+"12082","YPL195W",21,90,1,28.59995,0.89396,0.17236,2.06085,5.88698,2421.71203,312.12884,1.1906,0.60815,166.1863,1.32508,3108.42216,461.2674,16.03144
+"12083","YPL195W",33,90,1,6.94951,0.77764,0.14949,1.65717,3.13169,1797.7747,181.13512,0.81601,0.51666,80.14961,0.77617,1757.88129,236.58448,11.62063
+"12084","YPL195W",45,90,1,14.11396,0.85562,0.16539,1.88621,4.383,2124.86976,248.41942,1.0184,0.50792,136.23649,0.99269,2663.92529,276.90665,14.80248
+"12085","YPL195W",57,90,1,16.41865,0.86195,0.17239,1.85083,8.41265,2171.13827,275.90509,0.96795,0.54432,132.42459,1.02949,2792.56806,325.5931,14.84048
+"12086","YPL195W",69,90,1,11.83166,0.84995,0.1592,1.78339,3.94154,1878.98305,205.11343,0.85656,0.52473,99.53919,0.87648,2351.47956,190.21343,14.38014
+"12087","YPL195W",81,90,1,23.4593,0.92375,0.16884,1.9167,4.31204,2031.97198,237.88694,0.93829,0.46495,123.90011,1.06003,2488.56156,295.07342,15.65398
+"12088","YPL195W",93,90,1,14.45268,0.84232,0.15884,1.77469,3.76117,1787.79394,176.21851,0.82902,0.58504,80.21853,0.92641,1928.33745,165.69755,14.6255
+"12093","YPL196W",8,90,1,48.75359,0.80372,0.17111,1.91353,5.68193,3215.83405,498.54975,1.12278,1.19651,107.04096,1.24772,3950.74221,584.73142,16.42198
+"12094","YPL196W",20,90,1,42.20414,0.80522,0.16441,2.02834,5.64833,3073.29428,445.4178,1.08011,1.19578,114.70455,1.07849,3758.44284,529.23165,15.55519
+"12095","YPL196W",32,90,1,3.80221,0.68274,0.14036,1.64103,1.49091,2008.00629,185.58981,0.63471,1.23317,22.65857,0.73492,1567.44377,76.06009,9.51548
+"12096","YPL196W",44,90,1,23.9873,0.76213,0.15509,1.91036,4.14415,2624.15194,347.38819,0.9405,1.17604,104.88659,1.02706,3022.5955,325.32156,13.98792
+"12097","YPL196W",56,90,1,24.01373,0.77889,0.15716,2.08367,4.83193,2726.66475,397.78172,0.96738,1.20163,115.67601,1.11444,3398.17003,367.84711,14.51038
+"12098","YPL196W",68,90,1,22.00332,0.78786,0.16096,2.26967,4.79667,2586.67524,307.49927,0.91851,1.35557,82.75005,1.74759,2857.69552,317.94653,14.19488
+"12099","YPL196W",80,90,1,34.7546,0.79217,0.15996,1.77554,4.30693,2534.33292,323.68777,0.88439,1.23371,100.17858,1.00626,2896.08976,332.25302,14.26404
+"12100","YPL196W",92,90,1,34.05788,0.78072,0.15439,1.71995,4.73245,2419.27839,285.04174,0.83088,1.23592,70.63571,0.98776,2556.44701,224.4086,14.30192
+"12105","YPL197C",7,90,1,55.32406,0.85825,0.17052,1.95952,5.67423,3460.78381,502.6957,1.28877,1.36387,115.98149,1.17643,4092.09722,588.33953,16.70627
+"12106","YPL197C",19,90,1,40.24796,0.88282,0.16943,1.858,5.02901,3295.80372,446.66513,1.25309,1.37467,107.51067,1.11335,3785.63367,458.96679,16.28219
+"12107","YPL197C",43,90,1,25.94796,0.8461,0.16725,1.83423,3.65397,3005.50528,382.34362,1.14553,1.44606,96.08558,1.04242,3293.63886,356.59975,14.88823
+"12108","YPL197C",55,90,1,31.49543,0.87862,0.17253,1.89284,3.60313,3153.20473,460.67661,1.17605,1.55699,142.48809,1.11176,3773.22316,461.73072,15.75171
+"12109","YPL197C",67,90,1,23.71399,0.81158,0.15757,1.79684,5.36212,2606.26357,318.99585,1.00618,1.41008,84.0835,0.99997,2958.58827,269.67631,13.80699
+"12110","YPL197C",79,90,1,47.13293,0.83733,0.15616,1.83264,4.90762,2729.842,340.5334,1.02608,1.46499,92.82505,1.08777,3027.91586,298.93465,17.86234
+"12111","YPL197C",91,90,1,41.42672,0.8183,0.14757,1.77775,4.7387,2408.41833,245.77698,0.90508,1.47863,51.75177,0.91877,2300.46919,174.54186,15.12209
+"12116","YPL198W",5,90,1,45.07854,0.83836,0.17446,1.89605,5.58143,3489.47809,506.63509,1.2657,1.42263,106.43183,1.16099,3987.58059,598.49102,15.88249
+"12117","YPL198W",17,90,1,39.84994,0.88621,0.17795,1.96066,5.88267,3387.61957,482.92744,1.25233,1.49004,99.32373,1.11297,3956.80418,531.31116,16.10975
+"12118","YPL198W",29,90,1,44.41565,0.89389,0.16978,1.96085,5.78587,3257.31757,450.70548,1.21894,1.47673,112.05732,1.12456,3791.39795,504.43724,17.64786
+"12119","YPL198W",41,90,1,31.36478,0.83643,0.16389,1.88057,4.37319,2831.34186,359.22271,1.09032,1.39865,100.82873,1.20844,3068.58002,422.76982,14.93413
+"12120","YPL198W",53,90,1,27.84933,0.89246,0.16965,1.87981,4.28875,3172.73846,398.90054,1.13073,1.8765,80.182,1.02445,3437.09676,396.08587,15.29573
+"12121","YPL198W",65,90,1,25.3413,0.87333,0.16838,2.12958,4.90216,2894.44886,358.74366,1.09962,1.67051,85.09201,1.04462,3116.22453,369.00887,15.01998
+"12122","YPL198W",77,90,1,16.25901,0.85778,0.15983,1.76118,4.5847,2725.27406,312.61883,1.0072,1.62496,71.46438,0.99354,2864.3318,268.33645,13.94526
+"12123","YPL198W",89,90,1,19.23978,0.85432,0.15744,2.07703,5.39342,2615.00026,288.36823,0.9932,1.5417,53.94139,1.01283,2644.57767,211.98758,14.68694
+"12128","YPL199C",4,90,1,43.905,0.8392,0.17458,1.91884,7.60726,3695.89084,503.59435,1.27235,1.49491,105.48009,1.15177,3905.89517,601.04998,15.66251
+"12129","YPL199C",16,90,1,36.63399,0.83528,0.17007,1.99333,5.96376,3468.77728,449.40117,1.20485,1.38732,108.6104,1.15563,3760.57958,502.39287,15.92823
+"12130","YPL199C",28,90,1,33.62919,0.85109,0.17108,1.88435,16.82249,3437.66958,440.5226,1.19426,1.51281,93.01004,1.12154,3757.12383,499.56782,16.3967
+"12131","YPL199C",40,90,1,26.53633,0.81789,0.16818,1.79767,5.27431,3225.9561,392.57291,1.10588,1.41074,87.76557,1.04854,3356.00472,401.99279,14.61386
+"12132","YPL199C",52,90,1,17.34694,0.77928,0.15614,1.68817,6.28591,3017.11537,328.65021,1.0035,1.57547,57.6348,0.94386,2966.487,296.8719,13.81408
+"12133","YPL199C",64,90,1,19.18704,0.82578,0.16212,1.8112,4.86689,3055.60105,330.15588,1.02998,1.50715,60.74932,0.96094,2919.98685,313.78111,14.11556
+"12134","YPL199C",76,90,1,16.50785,0.81479,0.15694,1.69341,4.83704,2765.62967,297.33466,0.94011,1.37756,62.66137,0.96279,2736.18113,272.62124,13.76646
+"12135","YPL199C",88,90,1,18.73954,0.8186,0.16158,1.80632,6.15748,2702.0818,279.65043,0.94176,1.57953,57.72548,1.08709,2648.10208,265.54579,14.76524
+"12140","YPL200W",3,90,1,43.39099,0.82812,0.17083,1.84387,7.48137,3455.76502,502.21866,1.28205,1.26329,102.62055,1.15091,3807.9171,578.66773,15.33887
+"12141","YPL200W",15,90,1,37.03779,0.86601,0.17894,1.97992,6.3262,3490.55849,464.09138,1.24248,1.26481,105.47705,1.14843,3838.31142,527.86346,15.98765
+"12142","YPL200W",27,90,1,34.03259,0.86881,0.17255,1.82496,5.40431,3323.58429,466.87498,1.2089,1.37377,121.46904,1.14531,3847.33838,527.78108,15.88928
+"12143","YPL200W",39,90,1,26.85963,0.85954,0.17384,1.76323,8.86654,3192.14248,403.02309,1.15489,1.26778,99.67353,3.60047,3386.02832,412.89544,14.9121
+"12144","YPL200W",51,90,1,24.32151,0.84001,0.16808,1.76021,5.61678,2907.43865,370.16325,1.08482,1.27507,92.24842,1.06402,3190.96532,396.38708,14.48934
+"12145","YPL200W",63,90,1,21.13849,0.87403,0.16844,1.86472,5.24306,2992.62356,334.69647,1.0713,1.36186,74.4527,1.00877,3075.30178,322.78314,15.13689
+"12146","YPL200W",75,90,1,17.25671,0.8423,0.1655,1.75697,5.38865,2814.63889,327.87757,1.04317,1.40061,89.33976,1.06944,2996.24508,318.32422,14.20423
+"12147","YPL200W",87,90,1,24.1352,0.85396,0.16358,1.79359,5.69092,2681.47014,309.69785,0.97111,1.37927,74.00645,1.10126,2803.63523,270.1816,14.5554
+"12152","YPL201C",2,90,1,53.06115,0.83991,0.1806,2.04667,9.38747,3589.70223,514.72335,1.30077,1.23332,116.27044,1.32315,3967.37325,636.91984,17.37398
+"12153","YPL201C",14,90,1,35.47586,0.81777,0.16973,1.8633,9.27416,3278.71587,442.67985,1.2016,1.22591,110.87355,1.14807,3667.76493,484.52587,15.25225
+"12154","YPL201C",26,90,1,32.30154,0.87352,0.17504,1.87722,5.38047,3249.92351,448.02522,1.23533,1.35429,105.8654,1.16082,3766.7315,445.69982,16.08061
+"12155","YPL201C",38,90,1,27.97813,0.84163,0.16662,1.75149,4.51287,3188.52538,408.55035,1.13177,1.25005,91.75431,1.06512,3467.01812,433.30891,14.56325
+"12156","YPL201C",50,90,1,23.28271,0.82993,0.16358,1.73347,6.27775,2910.93112,343.8721,1.06215,1.48202,94.55632,1.05399,3091.35972,345.65926,14.38592
+"12157","YPL201C",62,90,1,22.16409,0.85318,0.16555,1.77989,5.20454,2937.68052,373.9944,1.08063,1.37233,101.04487,1.02024,3169.66293,379.55441,14.53427
+"12158","YPL201C",74,90,1,15.47332,0.84023,0.1603,1.7541,4.71229,2733.74041,303.57791,1.01126,1.32881,72.24958,1.02504,2820.51369,246.48934,13.83796
+"12159","YPL201C",86,90,1,16.97469,0.83923,0.15544,1.71705,22.41921,2560.60683,289.78165,1.00163,1.90668,63.99034,3.87556,2634.05266,229.85032,13.83003
+"12164","YPL202C",10,89,1,62.38922,0.8609,0.18081,1.98787,20.78957,3546.56718,524.28436,1.41348,1.51128,128.46651,1.28882,4087.65305,600.35141,16.6325
+"12165","YPL202C",22,89,1,39.00434,0.88817,0.17268,1.85865,6.62114,3202.11989,432.91792,1.17309,1.47963,127.77995,1.2436,3710.46745,477.75005,15.88958
+"12166","YPL202C",34,89,1,56.40173,0.79552,0.15933,1.68206,6.52887,2787.80613,304.67079,0.96566,1.49713,63.23786,1.00498,2583.76241,284.09625,12.40426
+"12167","YPL202C",46,89,1,28.06305,0.88564,0.17069,1.92385,6.56532,3046.99457,385.41504,1.10382,1.40296,107.06129,1.1567,3325.39386,388.72152,15.45709
+"12168","YPL202C",58,89,1,22.6103,0.86542,0.16638,2.27422,6.56507,2852.2715,385.03075,1.07693,1.61362,95.46488,1.14286,3263.47639,358.89855,14.38872
+"12169","YPL202C",70,89,1,17.30736,0.80058,0.15856,1.62701,4.73112,2581.31779,312.20077,0.92269,1.37637,84.51725,1.15842,2805.85688,229.04227,13.06405
+"12170","YPL202C",82,89,1,19.54477,0.8214,0.16581,1.74312,5.73252,2652.07933,343.38814,0.96864,1.43977,110.15241,1.23539,2914.97089,307.63979,13.86324
+"12171","YPL202C",94,89,1,22.25688,0.82989,0.16613,1.68371,5.44527,2562.52163,286.2599,0.95208,1.44832,78.39528,1.10204,2627.77076,238.73235,15.21859
+"12176","YPL203W",9,89,1,50.03825,0.86009,0.17921,1.97007,7.50755,3651.46657,534.42975,1.34951,1.36583,113.12654,1.29666,4136.03622,596.6424,16.82737
+"12177","YPL203W",21,89,1,61.56993,0.81568,0.16774,2.0604,7.007,3319.31252,455.0082,1.22533,1.28857,113.63071,1.20265,3746.81829,468.68756,15.39408
+"12178","YPL203W",33,89,1,9.69347,0.76503,0.14821,1.54173,3.55993,2493.56538,264.43309,0.90785,1.30801,38.30138,0.92741,2226.61849,186.61219,10.83409
+"12179","YPL203W",45,89,1,41.78927,0.82369,0.17066,1.81928,11.71961,3128.79127,403.28378,1.16526,1.33309,102.53778,1.22977,3480.91192,362.19252,16.17069
+"12180","YPL203W",57,89,1,41.29066,0.80691,0.17033,1.81946,5.39209,3017.0853,382.47174,1.08759,1.30905,97.76896,1.96327,3419.26666,368.69328,20.19425
+"12181","YPL203W",69,89,1,19.39639,0.78821,0.15846,1.68906,4.4907,2745.16427,322.39264,0.9644,1.37031,86.91275,1.09759,2841.93475,239.33839,14.10208
+"12182","YPL203W",81,89,1,17.33947,0.79164,0.15803,1.63644,4.76947,2745.72611,321.75012,0.98151,1.3184,74.65154,1.04184,2832.65668,266.65176,13.53027
+"12183","YPL203W",93,89,1,23.0308,0.79177,0.15704,1.66095,4.99098,2773.19618,324.66994,0.97281,1.33132,75.23054,1.17143,2869.33954,237.63136,14.5991
+"12188","YPL205C",8,89,1,51.10396,0.80112,0.16108,1.75067,7.35394,3630.45771,549.76318,1.14531,1.50297,194.77778,1.24329,4287.13356,541.14778,15.11409
+"12189","YPL205C",20,89,1,41.61294,0.84344,0.16299,1.73571,6.5691,3581.08318,499.64035,1.13866,1.58046,195.2574,1.20712,4266.00832,464.52091,14.81175
+"12190","YPL205C",32,89,1,11.2647,0.7199,0.13083,1.351,1.92908,2377.6498,222.0909,0.71865,1.61665,56.9665,0.74865,1767.31233,63.25118,9.05495
+"12191","YPL205C",44,89,1,38.2736,0.81748,0.1609,1.68818,5.27459,3275.81634,409.87501,1.05512,1.49287,165.94576,1.25996,3609.18176,353.80514,14.87924
+"12192","YPL205C",56,89,1,28.39577,0.82452,0.15861,1.65615,5.3329,3247.82729,409.84072,1.03637,1.46161,149.82388,1.13235,3684.20574,320.61138,14.62889
+"12193","YPL205C",68,89,1,29.77846,0.86116,0.16377,1.67283,5.55094,2978.25871,356.22741,0.98559,1.58146,137.31376,1.16081,3290.93257,318.58653,14.39563
+"12194","YPL205C",80,89,1,28.12891,0.80632,0.15423,1.59526,4.85125,3031.73252,391.06011,0.95107,1.54169,161.89751,1.09081,3499.76813,282.35247,13.40344
+"12195","YPL205C",92,89,1,33.36256,0.8069,0.14858,1.55971,4.99677,2738.18263,334.44202,0.89301,1.67071,140.88797,1.13205,3017.29829,236.8437,13.49516
+"12200","YPL206C",7,89,1,49.17855,0.81819,0.17292,1.98241,7.61872,3350.98359,512.67384,1.28198,1.26463,147.81712,1.87635,3978.2407,577.18326,15.92075
+"12201","YPL206C",19,89,1,39.77036,0.82165,0.16816,1.95724,7.53489,3213.67408,449.53678,1.23269,1.38845,147.38198,1.08831,3845.9605,511.19414,15.93994
+"12202","YPL206C",31,89,1,5.10575,0.73039,0.13912,1.40059,2.67043,1977.47489,181.40201,0.72488,1.31117,48.45224,0.6931,1583.03791,83.56026,10.74289
+"12203","YPL206C",43,89,1,30.73159,0.82157,0.16403,1.76622,8.56236,2907.8779,350.99162,1.1023,1.43159,132.01131,1.00847,3267.88718,359.85705,15.2348
+"12204","YPL206C",55,89,1,29.34729,0.83453,0.16531,1.7522,6.22856,2918.36705,388.6587,1.11911,1.41253,122.88271,1.02168,3490.1961,378.74129,16.07186
+"12205","YPL206C",67,89,1,28.47373,0.79425,0.15574,1.71502,5.53475,2731.5111,327.16638,1.05532,1.26645,115.72451,0.96235,3071.81435,313.48506,15.1887
+"12206","YPL206C",79,89,1,39.39527,0.78809,0.15739,1.62476,7.08125,2524.7874,301.4442,0.95439,1.3419,114.44039,0.93193,2779.36455,234.55979,14.49061
+"12207","YPL206C",91,89,1,30.51837,0.80873,0.15618,1.67884,5.17208,2478.07809,279.24276,0.94675,1.35032,104.97237,1.01888,2669.53384,234.77983,14.76849
+"12212","YPL207W",5,89,1,50.09991,0.82501,0.17441,2.06171,8.05311,3530.27941,501.35557,1.25984,1.22175,123.37817,1.30747,3907.92797,608.68529,16.93046
+"12213","YPL207W",17,89,1,38.47018,0.83833,0.17033,2.45307,8.09755,3405.60636,455.14175,1.24798,1.24086,112.57554,1.27749,3736.73207,525.02383,17.00018
+"12214","YPL207W",29,89,1,35.61846,0.87342,0.17462,1.8251,7.33638,3466.80751,480.64808,1.2507,1.23504,103.97863,1.09084,3965.40797,510.92888,16.56173
+"12215","YPL207W",41,89,1,26.17556,0.79988,0.16238,1.72082,5.1097,2933.62539,359.11605,1.07429,1.24271,102.04594,1.05561,3070.60849,386.04552,15.98365
+"12216","YPL207W",53,89,1,23.28212,0.82575,0.16574,1.70503,5.78708,2940.2848,380.64466,1.05692,1.30101,98.89939,1.00729,3217.00534,360.73686,15.5741
+"12217","YPL207W",65,89,1,18.71712,0.83066,0.16377,1.70998,6.09508,2823.89976,369.00305,1.0595,1.38269,108.73085,1.15748,3109.65934,330.85888,14.59432
+"12218","YPL207W",77,89,1,20.40872,0.83509,0.16348,1.65721,5.44685,2643.16619,317.80578,0.97345,1.34077,80.7977,0.98211,2816.19152,231.91722,13.70009
+"12219","YPL207W",89,89,1,25.47217,0.86316,0.16378,1.75473,5.5058,2722.58369,305.79783,1.02672,1.29903,81.4158,1.06368,2741.91839,235.17842,14.71604
+"12224","YPL208W",4,89,1,49.71392,0.82369,0.168,2.31152,25.97432,2963.88177,524.45772,1.27042,1.43575,258.36155,1.16091,3977.71693,598.67868,15.74375
+"12225","YPL208W",16,89,1,39.07633,0.8244,0.16508,2.81385,6.70888,2855.83442,452.07846,1.19306,1.42951,242.32811,1.1248,3735.20859,489.45013,16.31827
+"12226","YPL208W",28,89,1,35.46579,0.81742,0.15933,1.75807,6.0017,2610.37964,398.6248,1.08657,1.39633,219.65327,1.07349,3533.8412,464.54156,15.73166
+"12227","YPL208W",40,89,1,26.42348,0.78425,0.15393,1.73731,5.36168,2424.64822,386.60821,0.99913,1.33274,219.13596,1.06791,3204.74672,355.75825,14.22391
+"12228","YPL208W",52,89,1,26.33808,0.84182,0.15992,1.78573,6.00256,2476.43536,384.35078,1.03033,1.37486,207.24477,1.01736,3328.00741,341.17262,15.45093
+"12229","YPL208W",64,89,1,27.07116,0.83798,0.16389,1.8022,5.2992,2458.56782,385.35349,1.04417,1.46347,226.23378,1.07557,3330.72922,375.0003,15.01136
+"12230","YPL208W",76,89,1,26.24712,0.8064,0.16136,1.75478,5.50526,2203.51458,368.50201,0.90073,1.51666,209.43213,1.17511,3066.11235,304.92933,14.93575
+"12231","YPL208W",88,89,1,22.85767,0.82514,0.15654,2.24653,5.87598,2199.09022,308.89869,0.90664,1.5224,183.10706,4.59699,2791.31605,231.68147,15.48291
+"12236","YPL212C",3,89,1,57.95898,0.96147,0.18778,1.85679,9.26344,3657.06392,512.77306,1.43467,1.84753,88.29776,1.28089,3982.11426,678.0421,17.29013
+"12237","YPL212C",15,89,1,38.47265,0.93409,0.1803,2.09933,6.93927,3388.27015,412.97272,1.31265,1.77583,83.90865,1.24643,3555.17188,514.10915,15.026
+"12238","YPL212C",27,89,1,35.10961,0.96247,0.18042,1.78606,6.17283,3266.99168,405.82453,1.27412,1.74149,92.31631,1.14123,3481.96726,464.58445,15.81865
+"12239","YPL212C",39,89,1,34.40285,0.94486,0.17857,1.88157,7.33035,3095.00859,370.06902,1.21665,1.84185,97.2552,1.22647,3302.0043,427.14268,15.26549
+"12240","YPL212C",51,89,1,33.15111,0.97642,0.17869,1.81534,6.79624,3222.25061,396.79964,1.25002,1.85753,95.29567,1.2254,3508.30291,424.72796,15.1358
+"12241","YPL212C",63,89,1,29.35444,0.96027,0.17503,1.71905,6.02637,2917.24115,327.42326,1.13943,1.90752,75.43065,1.13903,3040.39219,309.7142,14.55672
+"12242","YPL212C",75,89,1,37.03388,0.93709,0.17757,1.90428,6.48539,2622.68504,321.6945,1.08558,1.87049,117.44587,1.44427,2892.13268,390.65895,15.06561
+"12243","YPL212C",87,89,1,29.26662,0.95128,0.17428,1.77014,6.78301,2745.14881,301.67252,1.12441,2.17491,78.0061,1.25476,2789.04492,268.53655,16.57142
+"12248","YPL213W",10,88,1,54.58622,0.85718,0.17784,1.85585,8.55919,3559.60825,510.87924,1.21825,1.48978,143.96454,1.65137,3999.45952,602.93576,15.5921
+"12249","YPL213W",22,88,1,45.45254,0.85915,0.17506,1.93687,7.08928,3349.38134,461.36306,1.14929,2.57876,135.71865,1.23854,3852.92633,518.29072,15.44398
+"12250","YPL213W",34,88,1,18.9825,0.74369,0.14871,1.51175,5.20044,2526.17357,253.08496,0.81159,1.30066,55.92427,0.93083,2181.14424,203.15715,11.43991
+"12251","YPL213W",46,88,1,27.90556,0.74085,0.14965,1.58698,6.04492,2714.36957,329.91953,0.9534,1.21905,85.12216,1.01418,2850.28885,279.05565,13.06031
+"12252","YPL213W",58,88,1,28.43028,0.77225,0.1546,1.59521,5.33077,2843.47254,360.12706,0.92746,1.32755,100.45873,0.99236,3076.08844,332.02321,13.31175
+"12253","YPL213W",70,88,1,38.43709,0.84153,0.16359,1.72704,4.75394,2709.47009,292.63579,0.92857,1.41932,70.30287,1.04583,2640.90486,199.32949,14.4081
+"12254","YPL213W",82,88,1,29.3827,0.80576,0.15038,2.23836,5.94891,2408.50399,232.21377,0.81005,1.38671,44.59719,2.05418,2185.41183,113.59736,13.70799
+"12255","YPL213W",94,88,1,31.33176,0.8574,0.1563,1.67597,6.36128,2595.46521,304.54093,0.87234,1.3185,83.9919,1.13629,2720.62797,265.90743,14.09601
+"12260","YPL214C",9,88,1,60.42366,0.83883,0.20289,4.4005,11.1998,3548.60259,511.10574,1.24444,1.53903,118.27286,1.5594,4002.27604,595.22901,17.71993
+"12261","YPL214C",21,88,1,40.8269,0.81796,0.16429,1.69015,5.8725,3384.07298,438.52895,1.12792,1.33713,98.79984,1.08462,3704.12492,476.33492,14.54537
+"12262","YPL214C",33,88,1,18.23054,0.74188,0.15216,1.50744,3.81022,2638.65531,265.81748,0.82808,1.28948,49.64434,0.87877,2212.43621,238.54521,11.1512
+"12263","YPL214C",45,88,1,38.77437,0.81595,0.17015,1.72209,7.20577,2944.51913,323.49972,0.99477,1.45358,77.0828,1.82523,2847.32513,356.77586,18.3836
+"12264","YPL214C",57,88,1,52.27391,0.79063,0.1538,1.66613,12.84253,2855.74028,315.26912,1.02288,1.4405,64.97327,1.26262,2908.9948,306.55183,21.14446
+"12265","YPL214C",69,88,1,88.19816,0.81615,0.17701,1.91136,7.59117,2939.63925,324.85781,0.97375,1.45643,71.22948,1.78574,2934.88845,351.27758,18.38634
+"12266","YPL214C",81,88,1,26.08004,0.82963,0.15521,1.65037,6.02722,2636.15218,284.34903,0.89416,1.42162,62.46808,1.01562,2624.78274,253.59793,13.58715
+"12267","YPL214C",93,88,1,45.59206,0.78824,0.15173,1.78478,5.96901,2563.05254,259.74697,0.85709,1.41675,52.1307,0.9845,2374.18492,175.20143,16.13603
+"12272","YPL215W",8,88,1,52.33177,0.8404,0.18094,1.91558,8.81857,3647.08778,530.72687,1.25378,1.44604,129.79517,1.29789,4062.78234,637.49396,16.39312
+"12273","YPL215W",20,88,1,39.18793,0.81005,0.17129,1.81819,9.07862,3381.33817,435.67534,1.16383,1.39868,111.68686,1.21149,3639.14967,488.27099,15.31725
+"12274","YPL215W",32,88,1,5.78987,0.73783,0.14388,1.42207,4.55911,2170.03056,183.60502,0.66534,1.41581,27.27856,0.83059,1541.75945,125.39202,10.61614
+"12275","YPL215W",44,88,1,47.68782,0.77164,0.159,1.7959,7.45849,2821.71018,351.67415,0.99546,1.37147,100.21474,1.24577,3037.14784,406.90261,16.58177
+"12276","YPL215W",56,88,1,31.34356,0.80189,0.1694,2.23267,6.20704,2991.42535,381.95051,1.01732,1.60166,101.46958,1.25127,3186.77529,361.30662,15.22853
+"12277","YPL215W",68,88,1,80.75967,0.78365,0.16285,1.72631,7.24569,2931.24472,344.48337,1.03241,1.48322,95.14735,1.15446,3001.39366,377.26251,18.06381
+"12278","YPL215W",80,88,1,37.37022,0.78252,0.16201,1.75718,7.7588,2726.13623,295.38032,0.94945,1.4676,66.51341,1.18612,2620.02521,245.95358,15.18807
+"12279","YPL215W",92,88,1,51.0548,0.78784,0.16417,1.75511,7.16268,2580.85573,263.50142,0.91512,1.38507,61.67398,1.60213,2471.72863,195.61305,15.96734
+"12284","YPL216W",7,88,1,59.40585,0.89535,0.18257,1.96359,9.10135,3436.60787,525.08442,1.34411,1.55149,143.86678,1.2585,4056.56568,629.60601,17.62861
+"12285","YPL216W",19,88,1,43.96217,0.94757,0.18371,1.83625,9.07711,3379.32457,447.24794,1.26976,1.57601,112.25925,1.23809,3761.56297,524.5686,15.79125
+"12286","YPL216W",31,88,1,20.8336,0.84541,0.15988,1.58967,6.03246,2611.13354,258.60404,0.94825,1.4912,53.20181,0.99614,2279.44107,243.13295,12.79354
+"12287","YPL216W",43,88,1,28.22757,0.88137,0.17,1.6664,6.28271,2864.99407,336.29085,1.06782,1.43664,71.26957,1.08141,2983.79876,334.28306,14.45539
+"12288","YPL216W",55,88,1,60.32913,0.90858,0.18586,1.92202,8.65612,3107.36052,402.20445,1.16496,2.30027,109.94927,1.61761,3456.46844,490.22213,20.17231
+"12289","YPL216W",67,88,1,44.39295,0.86411,0.16805,1.75304,6.4314,2836.64564,341.00656,1.06263,1.50819,88.98408,1.16868,3126.15036,372.80389,15.0729
+"12290","YPL216W",79,88,1,153.11592,0.89174,0.17521,1.89451,9.48756,2883.55637,339.0565,1.1188,1.49988,75.57424,1.35394,3082.06583,380.10195,24.47587
+"12291","YPL216W",91,88,1,45.9868,0.86811,0.16565,1.725,11.18267,2480.95865,268.26002,0.9821,1.63971,45.41113,1.12859,2456.90986,171.74014,15.17764
+"12296","YPL219W",5,88,1,45.26612,0.76922,0.15747,1.72025,7.39719,3163.34895,458.03394,1.1611,1.41785,144.93432,1.1319,3482.66295,533.70605,15.54305
+"12297","YPL219W",17,88,1,57.83094,0.85111,0.17346,1.85946,9.6182,3338.77195,485.49496,1.21212,1.52752,178.75784,1.51292,3873.31312,669.23287,17.47557
+"12298","YPL219W",29,88,1,52.54114,0.81824,0.16596,1.7753,7.48399,2976.50783,400.0772,1.09644,1.6014,142.4887,1.43159,3422.08748,434.99619,15.88366
+"12299","YPL219W",41,88,1,39.3498,0.73763,0.14781,1.66576,6.29764,2545.34255,332.81746,0.92371,1.26532,122.32805,1.11745,2717.47356,282.30139,13.6952
+"12300","YPL219W",53,88,1,63.49006,0.70456,0.14607,1.56429,6.71408,2368.97912,309.48642,0.91614,1.76333,122.49768,1.06518,2657.07279,251.34746,16.47606
+"12301","YPL219W",65,88,1,35.96141,0.81118,0.16507,1.70209,6.62306,2728.93213,346.60321,1.01698,1.50419,125.99199,1.13205,2968.83095,352.86179,15.1854
+"12302","YPL219W",77,88,1,110.88206,1.15983,0.16178,2.85667,10.81888,2776.7516,329.84908,1.06668,1.7248,121.92204,1.4662,2906.89798,347.0026,20.32529
+"12303","YPL219W",89,88,1,72.81155,0.79377,0.16876,1.75431,7.49844,2509.97328,278.6409,0.96101,1.57691,99.59786,1.17649,2508.11342,273.03613,18.4655
+"12308","YPL220W",4,88,1,77.12485,0.81619,0.17573,1.79743,8.19821,3404.08855,540.68451,1.29854,1.70323,294.50052,1.2708,3838.26397,1298.2937,15.43411
+"12309","YPL220W",16,88,1,64.00232,0.84352,0.17362,1.85773,9.31103,3448.82913,464.78262,1.23964,1.66702,120.28326,1.32757,3814.67415,534.57124,16.10773
+"12310","YPL220W",28,88,1,47.44257,0.82154,0.16947,1.80654,8.17432,3085.62381,409.72082,1.12053,1.76814,128.99574,2.41536,3542.74987,522.48603,15.88773
+"12311","YPL220W",40,88,1,53.32307,0.72119,0.15388,1.97821,4.78611,2435.26825,353.57519,0.88682,1.25866,172.74513,1.51912,2878.72524,353.22932,13.98289
+"12312","YPL220W",52,88,1,39.42728,0.81541,0.16553,1.66773,7.37557,2758.86098,360.98195,1.03289,1.55614,131.94058,1.19259,3140.84241,378.56119,15.35218
+"12313","YPL220W",64,88,1,39.60822,0.85062,0.17181,1.80102,8.52114,3013.20331,370.82082,1.09275,1.62287,111.6093,1.1633,3298.01564,404.62472,15.53286
+"12314","YPL220W",76,88,1,70.29114,0.88277,0.16452,4.94589,7.96964,2815.24596,328.49182,1.10057,1.65136,93.62371,1.42523,2909.6108,316.03174,16.45168
+"12315","YPL220W",88,88,1,21.48166,0.80928,0.1614,1.77092,6.30037,2558.87646,280.2301,0.94612,1.59433,81.99941,1.37811,2492.84913,240.08066,13.8445
+"12320","YPL221W",3,88,1,73.02787,0.7893,0.1697,2.29396,10.73652,3353.17461,505.23571,1.27864,1.35594,164.85158,1.52709,3739.84796,628.17853,16.61316
+"12321","YPL221W",15,88,1,48.89785,0.77673,0.16354,1.7402,8.65474,3212.2138,432.91079,1.16437,1.33448,118.39897,1.18454,3527.2005,525.29339,14.58493
+"12322","YPL221W",27,88,1,38.31876,0.81198,0.16848,1.73746,7.70339,3369.87425,418.05165,1.19144,1.36783,96.79103,1.3001,3518.11256,454.92379,15.29514
+"12323","YPL221W",39,88,1,29.3753,0.77689,0.15909,1.64391,5.99822,2903.65223,339.22248,1.05571,1.26355,85.45988,1.23938,2886.449,302.15698,13.92843
+"12324","YPL221W",51,88,1,32.44951,0.81966,0.16501,1.70586,7.85212,3061.1126,388.36174,1.1125,1.3441,121.40248,1.20821,3290.1197,422.0731,14.47179
+"12325","YPL221W",63,88,1,31.55207,0.85137,0.17005,1.73475,8.99563,3310.27628,424.27653,1.138,1.65241,115.98943,1.13532,3703.27248,461.7226,14.96848
+"12326","YPL221W",75,88,1,16.91026,0.82482,0.1621,1.62164,8.80479,2681.64987,277.7739,0.97215,1.4572,76.29731,1.00579,2595.33094,277.65013,13.39438
+"12327","YPL221W",87,88,1,34.94185,0.83121,0.14712,3.88689,6.62563,2426.93201,287.27134,0.90592,1.37424,91.13079,1.28247,2592.30007,213.83819,15.39864
+"12332","YPL222W",2,88,1,53.06557,0.7128,0.15388,1.61546,20.8463,2960.17454,447.37747,1.0964,1.18515,155.74433,1.2457,3260.71735,571.83416,13.48252
+"12333","YPL222W",14,88,1,49.34941,0.83147,0.1739,1.81114,9.74151,3219.07526,459.33152,1.20628,1.32907,150.76528,1.28885,3737.19421,549.3931,15.20241
+"12334","YPL222W",26,88,1,44.60894,0.81087,0.16726,1.80021,7.35924,3000.40749,444.06928,1.12288,1.40785,179.88726,1.48575,3624.09981,555.78895,15.20075
+"12335","YPL222W",38,88,1,56.53389,0.9317,0.15536,2.4829,7.36294,2561.24956,307.21723,0.94388,1.17557,89.82483,1.35382,2661.32124,288.60054,15.17316
+"12336","YPL222W",50,88,1,41.46424,0.84813,0.17374,1.81318,7.35919,3144.88954,454.62255,1.17523,1.36268,136.58604,1.34558,3686.56191,483.55206,15.81996
+"12337","YPL222W",62,88,1,23.27089,0.82869,0.16234,1.66613,7.32407,2799.1588,323.17137,1.0208,1.79824,94.27559,1.05892,2986.78818,348.65606,14.10839
+"12338","YPL222W",74,88,1,28.25473,0.79812,0.15819,1.73759,6.72397,2539.32403,296.68187,0.93275,1.36873,93.74912,1.1026,2662.43753,279.32252,15.15801
+"12339","YPL222W",86,88,1,57.6834,0.79112,0.15528,1.98513,9.13092,2425.35168,270.30867,0.9196,1.20749,72.46751,1.66634,2533.92957,242.02214,18.0432
+"12367","YPR021C",7,119,10,10.10608,0.77429,0.19117,2.00364,4.62115,2701.45694,430.85705,1.00076,0.42092,104.99037,1.60307,3100.87047,272.51057,14.03284
+"12368","YPR021C",19,119,10,9.92376,0.81904,0.19643,1.7787,6.36189,2787.09476,447.84993,1.07622,0.44741,111.5747,1.89438,3336.8806,316.01648,14.45175
+"12369","YPR021C",31,119,10,12.65413,0.7791,0.19674,1.88667,6.06474,2596.04068,381.37512,0.99097,0.41856,95.93043,1.83017,2876.2598,255.96859,14.4096
+"12370","YPR021C",43,119,10,12.55466,0.82786,0.20116,1.53942,5.00376,2921.71645,484.60911,1.09202,0.36717,127.2869,1.43802,3647.8052,347.79919,15.09977
+"12371","YPR021C",55,119,10,12.15822,0.82568,0.20069,1.96621,4.19082,2606.82577,414.55674,0.98054,0.40631,110.54601,1.79209,3151.3081,289.0162,14.65689
+"12372","YPR021C",67,119,10,11.80702,0.80869,0.19959,1.52912,5.24772,2571.4433,365.43788,0.9738,0.40859,98.167,1.39084,2789.45935,244.32029,14.96097
+"12373","YPR021C",79,119,10,9.12475,0.82167,0.20014,1.70747,5.05731,2474.36718,379.90231,0.93831,0.4409,108.76464,1.72056,2835.31023,255.59878,15.23014
+"12374","YPR021C",91,119,10,24.0878,0.8228,0.19314,1.80335,4.35915,2638.06363,376.94823,1.01839,0.39944,84.06814,1.6429,2775.84814,188.27896,14.90122
+"12375","YPR065W",60,88,1,30.31517,1.3919,0.1886,1.74063,6.75587,2932.11919,302.38022,1.05037,1.99358,81.33209,3.89921,2983.86601,310.44308,14.06464
+"12376","YPR065W",72,88,1,31.04435,1.3388,0.17618,1.69873,5.55346,2769.84125,284.46103,0.98802,1.89655,66.00216,3.63051,2787.70052,286.15077,13.83609
+"12377","YPR065W",84,88,1,36.8974,1.37154,0.18078,1.67991,6.16082,2804.80844,259.35367,0.98719,1.99737,51.48458,3.91599,2648.74328,237.09483,15.42041
+"12378","YPR065W",96,88,1,111.58158,1.34061,0.1814,2.27176,8.46351,2437.43892,247.89618,0.98315,1.96654,61.27371,4.63105,2378.95565,207.66149,18.27035
+"12379","YPR065W",60,89,1,30.5325,1.35531,0.18326,2.50673,6.76611,3113.77642,314.39828,1.0896,1.87675,64.22379,3.91015,2965.30242,304.73136,15.75363
+"12380","YPR065W",72,89,1,23.97599,1.35254,0.17627,1.78067,4.9053,2676.89749,284.94486,0.9849,1.85414,84.40852,4.35783,2764.12012,283.73519,15.08459
+"12381","YPR065W",84,89,1,25.96231,1.4047,0.18178,1.92369,6.71421,2721.36414,302.6173,0.99063,1.93969,69.76296,4.20548,2796.34271,262.88832,15.9679
+"12382","YPR065W",96,89,1,17.41495,1.38886,0.17878,1.83939,6.36531,2505.87527,223.99602,0.88693,2.12109,91.43394,3.80825,2239.37702,167.37011,14.89638
+"12383","YPR065W",60,90,1,33.33971,1.38698,0.19251,4.26138,7.01881,3285.09982,330.19292,1.14373,1.88608,59.17636,3.66178,3196.23379,320.85577,15.62595
+"12384","YPR065W",72,90,1,29.59293,1.33731,0.18477,2.74134,7.06711,3064.56412,331.87712,1.1082,1.80002,67.44091,3.68359,3090.89514,361.73044,14.28272
+"12385","YPR065W",84,90,1,28.14871,1.34454,0.17965,3.03218,13.49642,2894.5091,292.03365,1.09771,1.73948,60.89596,3.65624,2861.0761,303.14498,14.2247
+"12386","YPR065W",96,90,1,32.22916,1.34009,0.17348,2.44192,8.99346,2439.28331,226.81254,0.93311,2.0989,53.33379,4.25731,2291.01424,181.02069,14.63249
+"12387","YPR065W",60,94,2,11.15993,1.31204,0.17644,1.72155,10.48467,2854.96734,238.88206,0.96279,1.33091,62.33442,3.75096,2067.89089,194.30042,11.9441
+"12388","YPR065W",72,94,2,16.3542,1.35935,0.1798,2.37051,10.86564,2971.82115,247.80477,1.01902,1.27411,59.88888,4.77577,2341.65342,222.29642,13.10828
+"12389","YPR065W",84,94,2,27.44541,1.34355,0.17213,1.7631,11.80602,2895.00398,246.35941,1.04013,1.2961,62.61999,4.74988,2265.05811,235.55855,13.76017
+"12390","YPR065W",96,94,2,45.90346,1.5691,0.20669,2.2121,11.45637,3409.91976,337.81298,1.28959,1.66987,98.36884,5.77077,3111.21439,377.46042,17.74238
+"12391","YPR065W",60,95,2,8.34689,1.22523,0.16311,1.52458,8.14501,2641.20932,191.99935,0.8688,1.21061,46.09934,3.17098,1755.70108,134.98431,10.86001
+"12392","YPR065W",72,95,2,15.89702,1.32464,0.17177,1.59875,9.66492,2939.55825,241.39676,0.98783,1.23349,71.56567,3.55372,2278.20613,267.77326,12.7745
+"12393","YPR065W",84,95,2,17.27386,1.36603,0.1752,1.75447,9.64652,3055.86003,270.49655,1.02437,1.44482,65.62342,3.59513,2613.8561,227.03489,13.10622
+"12394","YPR065W",96,95,2,34.9634,1.50062,0.19699,1.88459,11.59566,3519.27246,391.38308,1.22366,1.62292,124.30647,4.05907,3366.38844,500.63635,15.86466
+"12395","YPR065W",60,96,2,29.46518,1.22805,0.1688,1.63718,9.53724,2737.8912,230.37031,0.89683,1.30595,60.14961,3.19511,2105.23648,196.50229,12.66664
+"12396","YPR065W",72,96,2,31.19847,1.29748,0.17445,1.69417,9.3837,2680.19553,253.52112,0.96388,1.18471,97.32741,3.82396,2227.11965,187.6741,13.96816
+"12397","YPR065W",84,96,2,30.75113,1.29059,0.17386,1.67667,12.45243,3078.79023,316.39717,1.06324,1.19377,84.01715,3.52615,2714.77721,282.75355,13.50648
+"12398","YPR065W",96,96,2,39.79285,1.40187,0.18226,1.79312,10.6961,2936.16005,322.14696,1.07081,1.46146,121.16626,3.951,2885.59886,344.0568,15.61979
+"12399","YPR065W",60,97,3,42.49388,1.52497,0.20105,2.22354,13.84561,3429.26941,393.15397,1.28117,1.35173,130.70204,4.7817,3545.23167,335.87141,18.00209
+"12400","YPR065W",72,97,3,37.32297,1.5102,0.19719,2.18478,11.25218,3461.35943,381.17806,1.22406,1.23166,105.81752,4.61077,3455.13894,289.87503,17.74914
+"12401","YPR065W",84,97,3,29.49668,1.5373,0.19386,2.15318,11.25138,3309.54952,311.39914,1.16181,1.49792,82.02577,4.67778,2960.5326,244.17604,17.68171
+"12402","YPR065W",96,97,3,43.90741,1.63141,0.21191,3.83343,12.7422,3407.20976,360.67025,1.25712,1.44775,112.66591,4.71436,3421.7759,383.91274,20.62692
+"12403","YPR065W",60,98,3,35.2565,1.51469,0.19858,2.01586,10.52025,3284.16685,338.28598,1.15562,1.4671,106.95241,4.08771,3171.47485,309.58802,16.9458
+"12404","YPR065W",72,98,3,25.70337,1.53299,0.19846,1.97364,10.71031,3323.77073,336.08925,1.15971,1.25595,96.24155,4.04008,3258.46397,303.36712,16.45043
+"12405","YPR065W",84,98,3,29.18566,1.48238,0.1858,1.82318,10.61905,3021.0071,300.89552,1.06793,1.33039,75.59213,3.85058,2806.08172,165.91435,16.799
+"12406","YPR065W",96,98,3,49.7866,1.52394,0.20558,2.09454,12.13564,3271.92665,355.945,1.18945,1.48649,103.96539,4.18337,3096.74687,275.01956,20.298
+"12407","YPR065W",60,99,3,22.4216,1.46926,0.20098,1.95104,11.22788,3310.27812,371.14204,1.18703,1.41391,110.63873,3.75174,3423.7187,280.38958,16.03202
+"12408","YPR065W",72,99,3,19.83457,1.46928,0.20042,1.90191,9.82744,3370.49485,361.37621,1.16865,1.22601,102.00636,3.80312,3338.01315,261.1667,16.17865
+"12409","YPR065W",84,99,3,19.28902,1.4845,0.19024,1.89498,10.66561,3040.24226,307.14521,1.07538,1.23889,85.96266,3.70854,2863.16053,194.9256,15.59812
+"12410","YPR065W",96,99,3,29.62981,1.5045,0.20009,2.19723,14.7198,3248.29561,344.955,1.1701,1.44314,106.2108,3.97355,3191.8462,292.06436,17.29684
+"12411","YPR065W",60,100,4,35.76718,1.37678,0.16166,1.28364,4.79481,1825.8899,226.35084,0.86854,0.78533,74.7222,2.83378,1903.16015,359.07387,14.33648
+"12412","YPR065W",72,100,4,32.05278,1.36948,0.15273,1.20487,4.79399,1810.68966,217.66558,0.84439,0.7565,63.9426,2.73801,1714.17796,290.0825,13.68789
+"12413","YPR065W",84,100,4,33.49545,1.4185,0.15515,1.25496,4.79993,1700.12229,199.80252,0.82606,0.84897,62.07449,2.77295,1562.36616,277.21136,13.75238
+"12414","YPR065W",96,100,4,34.30392,1.53897,0.1617,1.35205,5.43237,1793.53955,185.40345,0.84596,0.83674,58.12227,2.79988,1530.0323,281.93968,14.49469
+"12415","YPR065W",60,101,4,25.95496,1.33421,0.15592,1.23018,4.74228,1877.06061,232.21264,0.86122,0.69334,71.94163,2.68768,1951.86793,336.41044,12.33273
+"12416","YPR065W",72,101,4,26.80095,1.34188,0.15367,1.21352,3.99886,1749.63301,198.62814,0.81703,0.69195,63.83586,2.59343,1628.54926,310.60828,12.32039
+"12417","YPR065W",84,101,4,28.81884,1.44553,0.16832,1.31847,4.96404,1923.47628,224.84419,0.88488,0.78942,69.78429,2.86003,1919.59832,315.62098,13.45817
+"12418","YPR065W",96,101,4,31.36249,1.48757,0.15758,1.24518,4.99609,1806.50951,177.43919,0.83524,0.7179,55.97401,2.68484,1496.7819,253.40446,13.2613
+"12419","YPR065W",60,102,4,30.36655,1.34904,0.1601,1.27875,5.16655,1906.11673,228.67323,0.95322,0.74821,64.59011,2.86879,1843.08476,324.48457,13.3155
+"12420","YPR065W",72,102,4,27.02819,1.28095,0.14751,1.18035,4.94727,1719.61464,195.54873,0.8753,0.8885,58.68545,2.60409,1597.38776,271.85172,12.25946
+"12421","YPR065W",84,102,4,32.6021,1.30433,0.13858,1.82527,5.67174,1550.66215,166.57738,0.98278,0.6796,52.40211,2.67493,1430.37032,236.7852,13.66566
+"12422","YPR065W",96,102,4,49.11932,1.43376,0.15384,1.60539,6.42735,1677.79942,181.14516,1.10326,0.88515,60.63369,3.41629,1500.43614,258.53119,16.88071
+"12423","YPR065W",60,103,5,23.00265,1.61181,0.20581,1.56858,5.51752,3112.89537,441.79372,1.29892,0.73859,125.5235,3.86639,3547.24487,417.16523,16.79006
+"12424","YPR065W",72,103,5,11.29205,1.51669,0.17332,1.29843,2.92564,2398.88641,268.63135,1.00991,0.65436,73.47115,3.11566,2262.04387,225.13841,13.54716
+"12425","YPR065W",84,103,5,7.73865,1.55796,0.17703,1.31776,2.83473,2439.5355,257.20646,1.02265,0.71714,64.45324,3.16804,2122.51979,160.84218,14.16097
+"12426","YPR065W",96,103,5,13.27585,1.53516,0.17034,1.38644,3.505,2328.80105,238.64499,0.99653,0.72062,60.65205,3.05919,1919.71848,165.35129,14.88317
+"12427","YPR065W",60,104,5,11.60355,1.5683,0.19216,1.43273,3.06753,2797.41811,353.48284,1.18848,0.6798,88.8822,3.40449,2779.16815,243.82226,15.41562
+"12428","YPR065W",72,104,5,11.1588,1.59306,0.19547,1.43459,3.4086,2658.2444,322.64089,1.14632,0.70989,66.06717,3.33313,2503.50721,257.7879,14.98167
+"12429","YPR065W",84,104,5,9.37748,1.59505,0.18614,1.41969,2.83667,2413.1366,291.54472,1.08014,0.64686,76.00632,3.36696,2339.2395,216.47583,14.79737
+"12430","YPR065W",96,104,5,11.88143,1.59017,0.17517,1.36857,3.16903,2518.90083,270.17782,1.08407,0.59412,68.07544,3.17379,2244.16313,227.81364,14.65338
+"12431","YPR065W",60,105,5,10.35071,1.52584,0.18669,1.35613,2.60188,2617.73759,337.13319,1.13864,0.8248,80.56738,3.40179,2504.48186,223.92636,14.35539
+"12432","YPR065W",72,105,5,10.00836,1.55819,0.17771,1.41524,3.12567,2582.10987,293.32094,1.09242,0.64774,73.48143,3.00413,2357.38266,249.3486,13.58192
+"12433","YPR065W",84,105,5,10.52057,1.53816,0.17851,1.32918,3.31155,2386.59628,280.37801,1.06263,0.63327,73.14328,3.14803,2218.51144,186.97077,14.6506
+"12434","YPR065W",96,105,5,15.65529,1.52837,0.17696,1.32714,3.52419,2365.5099,252.67852,1.03837,0.90109,68.77003,3.0289,2035.29928,241.5567,14.43907
+"12435","YPR065W",60,106,6,16.02547,1.18708,0.13458,0.95023,2.78047,1955.18234,256.99843,0.73725,0.49282,49.71443,2.26851,1899.82116,227.69195,10.78072
+"12436","YPR065W",72,106,6,14.1201,1.21693,0.13635,0.91034,1.6457,1745.14911,242.02938,0.69872,0.39595,48.80589,2.24581,1735.48553,155.53141,10.55701
+"12437","YPR065W",84,106,6,11.89866,1.21371,0.13895,0.98908,1.46484,1859.65718,252.76692,0.69721,0.35301,44.77378,2.29875,1766.22592,110.97093,10.68011
+"12438","YPR065W",96,106,6,14.96253,1.17392,0.14228,0.8149,2.86139,2076.30335,313.51793,0.76364,0.37326,59.61738,2.40747,2245.85431,156.0821,10.94385
+"12439","YPR065W",60,107,6,13.46852,1.18738,0.14546,0.85365,3.83626,2012.03419,331.26586,0.80703,0.65726,66.06985,2.40272,2296.21564,269.77916,11.60617
+"12440","YPR065W",72,107,6,9.81718,1.25291,0.14616,0.85528,3.46451,1875.36969,243.02445,0.72378,0.43705,42.31589,2.37543,1632.74839,160.47092,11.16276
+"12441","YPR065W",84,107,6,9.39396,1.22222,0.15043,0.8067,4.83304,1981.20601,258.18856,0.76314,1.3389,37.04925,2.31346,1864.79962,135.04663,10.94239
+"12442","YPR065W",96,107,6,12.8899,1.35101,0.16773,0.932,3.21403,2395.92914,318.3924,0.90892,0.434,52.3741,2.6848,2339.01422,179.11558,12.68577
+"12443","YPR065W",60,108,6,14.6841,1.151,0.12693,0.75144,1.94088,1615.50142,237.7221,0.68397,0.4305,60.16355,2.18555,1651.58982,220.602,11.20721
+"12444","YPR065W",72,108,6,8.96331,1.16258,0.13496,0.73998,2.48813,1559.30769,228.78245,0.65144,0.45502,62.27747,2.13787,1651.27648,180.97906,10.68031
+"12445","YPR065W",84,108,6,6.52128,1.16868,0.13161,0.71732,2.44726,1571.04721,231.24975,0.63348,0.45099,48.58642,2.06345,1651.70334,110.98875,10.48349
+"12446","YPR065W",96,108,6,22.20191,1.18386,0.15308,0.86001,2.96959,2017.8751,314.5653,0.77711,0.51654,80.97986,2.42162,2338.56422,185.67421,13.31923
+"12447","YPR065W",60,109,7,28.17134,1.382,0.18554,1.23924,4.37437,2266.31902,360.70509,1.01977,0.66844,128.37176,3.07974,2463.40647,356.11559,15.2073
+"12448","YPR065W",72,109,7,32.94101,1.37051,0.18636,1.29874,3.79893,2595.91867,419.94887,1.08059,0.51658,143.60631,3.26163,2995.68028,452.02567,16.96539
+"12449","YPR065W",84,109,7,40.74895,1.4164,0.19633,1.37393,4.53141,2699.25977,496.58091,1.14824,0.44608,174.7065,3.76331,3498.21995,554.86185,19.00981
+"12450","YPR065W",96,109,7,39.75329,1.47853,0.19933,1.36543,4.76131,2952.34857,411.62782,1.18336,0.4735,123.90572,3.55925,3021.52339,484.90798,20.84687
+"12451","YPR065W",60,110,7,27.10551,1.36151,0.18529,1.26037,4.24036,2286.79083,387.17916,1.02211,0.61447,131.29069,3.16384,2773.6215,390.39205,14.93511
+"12452","YPR065W",72,110,7,30.68636,1.42722,0.2022,1.38972,5.61988,2819.98223,460.70965,1.17076,0.47136,137.65358,3.35513,3151.49707,468.66435,16.4259
+"12453","YPR065W",84,110,7,40.70197,1.42828,0.19358,1.30158,4.37857,2701.3496,445.64002,1.13686,0.54016,140.96093,3.36599,3181.99559,459.61564,20.45339
+"12454","YPR065W",96,110,7,37.97454,1.50455,0.20302,1.39659,5.06176,2816.92753,464.68761,1.18367,0.47381,145.53915,3.60382,3333.83097,483.11282,18.84293
+"12455","YPR065W",60,111,7,29.10513,1.33559,0.18478,1.23516,3.21533,2443.76325,432.29791,1.05734,0.52448,133.3394,2.95067,3011.45598,432.98549,15.91529
+"12456","YPR065W",72,111,7,34.32313,1.4483,0.2039,1.37306,3.86906,2795.24077,540.44517,1.16182,0.52921,186.79397,3.44266,3781.72688,605.53478,17.11502
+"12457","YPR065W",84,111,7,29.10044,1.31013,0.17838,1.19191,2.92772,2186.93157,359.45377,0.98801,0.48948,133.74475,3.01439,2476.64869,369.92392,15.36767
+"12458","YPR065W",96,111,7,42.80693,1.37452,0.18057,1.24618,3.67269,2551.07914,436.84035,1.10563,0.49476,143.28364,3.16437,3040.40886,414.70026,18.2123
+"12459","YPR065W",60,112,8,29.93487,1.05262,0.17825,1.25752,6.18834,2151.08382,281.26821,0.94707,0.67226,84.61029,3.71962,2277.66839,300.65792,14.14061
+"12460","YPR065W",72,112,8,31.31121,1.08408,0.18286,1.7644,6.45603,2409.31558,292.48016,1.03886,0.57486,79.93909,3.78344,2438.31513,320.79451,15.06246
+"12461","YPR065W",84,112,8,39.85034,1.09663,0.18728,1.38017,7.0478,2300.23876,297.66622,1.01037,0.59864,91.03635,3.92275,2402.03263,319.21568,15.56366
+"12462","YPR065W",96,112,8,41.52712,1.12923,0.18685,1.37228,8.25809,2460.85952,305.37021,1.04394,0.61803,84.03294,3.70655,2558.0248,364.48175,16.35818
+"12463","YPR065W",60,113,8,34.84674,1.01354,0.17516,1.36707,7.43887,2136.27224,274.5666,0.98996,0.64523,79.54363,4.48065,2260.65419,287.11086,14.54753
+"12464","YPR065W",72,113,8,45.65063,1.00967,0.17887,1.30797,7.66343,2245.89784,279.59411,1.01281,0.594,77.42896,3.97953,2314.51857,303.23762,14.93831
+"12465","YPR065W",84,113,8,35.71598,1.05592,0.18064,1.35761,7.8891,2310.35018,290.29062,1.06174,0.56506,82.28451,4.1149,2400.32892,308.37372,15.14855
+"12466","YPR065W",96,113,8,34.92766,1.06553,0.17724,1.39272,8.63578,2078.05093,277.48501,1.01335,0.53939,90.8578,4.10098,2272.28841,307.4471,14.7638
+"12467","YPR065W",60,114,8,26.06468,0.97776,0.1669,1.1611,8.56217,2047.85782,262.78024,0.93684,0.67583,74.09134,3.27325,2152.67309,263.4438,13.60886
+"12468","YPR065W",72,114,8,33.65047,1.19635,0.18298,1.37424,7.44304,2667.52621,412.46466,1.18205,0.61892,104.87453,3.65976,3423.92582,461.558,16.35357
+"12469","YPR065W",84,114,8,28.75357,0.97228,0.172,1.20101,7.53671,2226.08462,278.71583,0.97401,0.66643,64.16251,3.32153,2288.87977,292.13675,14.42085
+"12470","YPR065W",96,114,8,28.08147,0.98489,0.17206,1.20199,8.09116,2178.60692,250.11973,0.97741,0.65955,64.1155,3.24405,2117.16428,270.05724,14.09221
+"12471","YPR065W",60,115,9,15.61146,1.38962,0.20687,1.73089,5.64887,2886.31306,345.54879,1.13776,0.54327,112.26769,3.94373,2399.86411,280.24782,14.42543
+"12472","YPR065W",72,115,9,21.06137,1.40331,0.21367,1.79264,5.93575,3228.33117,409.36433,1.25007,0.63923,127.50198,4.10235,2710.50326,425.19347,14.31048
+"12473","YPR065W",84,115,9,31.98413,1.50484,0.23148,1.83935,6.43593,3563.07598,479.02702,1.37777,1.32176,170.3823,4.91646,3326.76601,597.45629,15.50974
+"12474","YPR065W",96,115,9,70.69603,1.46006,0.22653,2.16092,6.79001,3847.43157,549.15511,1.70093,0.56328,181.02338,4.60027,3767.86372,711.93658,18.79151
+"12475","YPR065W",60,116,9,21.47363,1.43811,0.2164,1.92341,5.73204,2999.70171,350.80147,1.21615,0.68442,115.62669,4.13663,2397.87791,305.62055,14.05435
+"12476","YPR065W",72,116,9,29.98029,1.30283,0.21341,2.74112,7.74093,3186.57399,411.24612,1.25719,0.60735,132.60396,4.18529,2766.36944,419.3833,18.97265
+"12477","YPR065W",84,116,9,43.85938,1.42624,0.22301,3.50047,7.01472,3498.37093,458.08171,1.38997,0.62718,165.05294,4.86153,3211.18719,555.71743,15.66516
+"12478","YPR065W",96,116,9,81.34247,1.42801,0.22775,2.89785,7.6165,3776.8266,513.31279,1.47319,0.58794,175.59632,4.95721,3546.28849,648.88045,16.21433
+"12479","YPR065W",60,117,9,18.2736,1.36675,0.2094,1.66515,6.26272,2541.90582,314.65899,1.06091,0.79872,110.57165,3.75462,2133.80507,253.32559,14.46296
+"12480","YPR065W",72,117,9,40.38563,1.3802,0.21025,1.80825,5.47748,2916.17439,389.13922,1.21262,0.59252,146.30023,4.11848,2596.69559,413.84792,14.66983
+"12481","YPR065W",84,117,9,34.58998,1.45704,0.22636,1.77593,6.55631,3515.07035,473.57838,1.37586,0.65388,169.72973,4.16636,3295.90714,581.10293,15.03556
+"12482","YPR065W",96,117,9,42.23748,1.4578,0.23734,1.90404,8.25705,3919.61256,523.36634,1.46603,0.61133,176.5283,4.31812,3734.96986,673.29745,16.52071
+"12483","YPR065W",60,118,10,9.80006,1.24237,0.19647,1.55321,9.87896,2569.6607,309.71251,1.13796,0.65192,58.54897,4.73401,2568.99037,216.05511,13.60982
+"12484","YPR065W",72,118,10,10.20777,1.30051,0.23464,1.89847,7.80478,2719.6478,324.30463,1.12894,0.66698,57.10235,5.6822,2760.4381,222.98788,13.58166
+"12485","YPR065W",84,118,10,12.4793,1.30582,0.20212,1.85241,8.35312,2667.35794,312.38476,1.22009,0.59065,59.86004,9.26885,2629.60168,210.06642,14.94654
+"12486","YPR065W",96,118,10,10.85534,1.31014,0.19329,2.42545,7.32818,2799.39733,331.73785,1.13475,0.47129,55.24693,6.60455,2838.23494,232.57163,14.1695
+"12487","YPR065W",60,119,10,9.90556,1.26504,0.20485,3.72869,5.74544,2698.83427,321.18248,1.15057,0.49534,56.16556,4.58814,2657.31049,210.52048,15.00173
+"12488","YPR065W",72,119,10,18.81016,1.28572,0.20398,1.58772,5.57674,2916.39172,336.05048,1.1734,0.45407,98.46596,4.57558,2795.12698,604.73759,13.91592
+"12489","YPR065W",84,119,10,9.70235,1.31869,0.20127,2.75712,6.28267,2673.68716,323.49527,1.09162,0.51287,65.24425,4.43384,2756.21271,224.11884,14.50589
+"12490","YPR065W",96,119,10,6.65923,1.34246,0.20315,1.78752,4.88766,2882.13828,341.75597,1.16021,0.53769,57.49967,4.79877,2885.14928,223.08232,14.55647
+"12491","YPR065W",60,120,10,8.16738,1.24752,0.20257,1.37307,5.03708,2664.36766,312.08441,1.09579,0.57444,53.08273,3.53516,2683.31627,225.86965,13.64461
+"12492","YPR065W",72,120,10,8.60431,1.26504,0.20085,1.46166,5.18127,2639.1391,326.7008,1.09514,0.52265,66.25352,3.69341,2665.46061,230.29241,13.39677
+"12493","YPR065W",84,120,10,5.76112,1.32195,0.20431,1.45193,5.52519,2633.51966,331.77831,1.07914,0.49187,72.61822,3.79703,2744.65835,222.08981,13.99053
+"12494","YPR065W",96,120,10,8.46788,1.29027,0.19828,1.43877,4.49379,2564.19122,334.43907,1.06184,0.52374,67.72108,3.81017,2748.41595,202.33728,14.10784