changeset 0:ea8215239735 draft default tip

planemo upload for repository https://github.com/galaxyproject/tools-iuc/tree/master/tools/raceid commit 39918bfdb08f06862ca395ce58a6f5e4f6dd1a5e
author iuc
date Sat, 03 Mar 2018 17:33:56 -0500
parents
children
files macros.xml raceid_diffgenes.xml scripts/RaceID_class.R scripts/common.R scripts/raceID_diffgenes.R scripts/raceID_filter.R scripts/raceID_kmeans_heatmap.R scripts/raceID_outlierdetect.R scripts/raceID_tsne.R test-data/gdiff_cl.1.tsv test-data/gdiff_cl.2.tsv test-data/in_diffgene.rdat test-data/out_1.html test-data/out_2.html test-data/out_3.html test-data/out_diffgene1.html test-data/out_diffgene2.html test-data/out_filter2.table test-data/out_filter3.table test-data/out_outlier1.table test-data/out_outlier2.table test-data/out_outlier3.table test-data/out_tsne1.rdat test-data/out_tsne2.rdat test-data/out_tsne3.rdat test-data/transcript_counts_intestine_sub.tsv test-data/transcript_output.tsv
diffstat 25 files changed, 1818 insertions(+), 0 deletions(-) [+]
line wrap: on
line diff
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/macros.xml	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,37 @@
+<?xml version="1.0"?>
+<macros>
+    <xml name="citations">
+        <citations>
+            <citation type="doi">10.1038/nature14966</citation>
+        </citations>
+    </xml>
+    <xml name="requirements">
+        <requirements>
+            <requirement type="package" >r</requirement>
+            <requirement type="package" >r-tsne</requirement>
+            <requirement type="package" >r-pheatmap</requirement>
+            <requirement type="package" >r-mass</requirement>
+            <requirement type="package" >r-mclust</requirement>
+            <requirement type="package" >r-flexmix</requirement>
+            <requirement type="package" >r-lattice</requirement>
+            <requirement type="package" >r-fpc</requirement>
+            <requirement type="package" >r-rcolorbrewer</requirement>
+            <requirement type="package" >r-permute</requirement>
+            <requirement type="package" >r-amap</requirement>
+            <requirement type="package" >r-locfit</requirement>
+        </requirements>
+    </xml>
+    <token name="@VERSION@">1.0</token>
+    <token name="@SCRIPT_DIR@">$__tool_directory__/scripts</token>
+    
+    <!-- Set hidden/retired outputs -->
+    <token name="@out_rdat_filter@">out_rdat_filter.rds</token>
+    <token name="@out_rdat_kmeans@">out_rdat_kmeans.rds</token>
+    <token name="@out_rdat_outlier@">out_rdat_outlier.rds</token>
+
+    <!-- Set hidden/retired inputs -->
+    <!-- tsne -> outlier -> kmeans -> filter -->
+    <token name="@inp_rdat_kmeans@">out_rdat_filter.rds</token>
+    <token name="@inp_rdat_outlier@">out_rdat_kmeans.rds</token>
+    <token name="@inp_rdat_tsne@">out_rdat_outlier.rds</token>   
+</macros>
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/raceid_diffgenes.xml	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,120 @@
+<tool id="raceid_diffgene" name="RaceID differential gene expression analysis" version="@VERSION@.0">
+    <description>Identify differentially regulated genes</description>
+    <macros>
+        <import>macros.xml</import>
+    </macros>
+    <expand macro="requirements" />
+    <command detect_errors="exit_code"><![CDATA[
+    Rscript '@SCRIPT_DIR@/raceID_diffgenes.R' '@SCRIPT_DIR@' '$rconf_source'
+
+    #if $compare_clusters_select.do_compare_clusters.value == "T":
+        &&
+        mkdir '${out_html.files_path}' &&
+        mv plot_*.svg '${out_html.files_path}' &&
+
+        echo '<html><head></head>
+        <body>
+        <h1>RaceID Differential Gene Analysis</h1>
+        <br /><h3>Expression of ${compare_clusters_select.gene} between ${compare_clusters_select.cl1} and ${compare_clusters_select.cl2}</h3>
+        <img src="plot_diffgenes.svg" ><br />
+        </body>
+        </html>' > '$out_html'
+    #end if
+
+    ]]></command>
+
+    <configfiles>
+        <configfile name="rconf_source" >
+            sc = readRDS( '$inp_rdat' )
+
+            c_pval = as.numeric( '$pval' )
+            generate_extable = as.logical( '$gen_gexpr_table.value' )
+            outtable_dir = 'tables'
+            compare_clusters = as.logical( '$compare_clusters_select.do_compare_clusters.value' )
+
+            #if $compare_clusters_select.do_compare_clusters.value == "T":
+            gene_name = '$compare_clusters_select.gene'
+            clust1 = '$compare_clusters_select.cl1'
+            clust2 = '$compare_clusters_select.cl2'
+            mcount = as.integer( '$compare_clusters_select.mincount' )
+            #end if
+        </configfile>
+    </configfiles>
+
+    <inputs>
+        <param name="inp_rdat" type="data" format="rdata" label="Count matrix with clusters" help="This file is the output of the RaceID pipeline." />
+        <param name="pval" type="float" value="0.01" min="1e-10" max="0.5" label="Retain genes with p-value smaller than threshold" help="The p-value for observing the difference in mean expression between the cluster and all cells based on binomial counting statistics." />
+        <param name="gen_gexpr_table" type="boolean" checked="true" truevalue="T" falsevalue="F" label="Generate table of all differentially expressed genes?" />
+        <conditional name="compare_clusters_select">
+            <param name="do_compare_clusters" type="select" label="Compare the expression of a specific gene between two sets of clusters?" >
+                <option value="T" >Yes</option>
+                <option value="F" selected="true" >No</option>
+            </param>
+            <when value="F" />
+            <when value="T" >
+                <param name="gene" type="text" label="Gene name of interest" >
+                    <sanitizer invalid_char="" >
+                        <valid initial="string.letters,string.digits">
+                            <add value="_"/><add value="+" /><add value="-" />
+                        </valid>
+                    </sanitizer>
+                </param>
+                <param name="cl1" type="text" value="1" label="Cluster set 1" help="e.g. if you wish to compare cluster 2 to clusters 1 and 3, then type '2' here and '1,3' in the next input." >
+                    <sanitizer invalid_char="" >
+                        <valid initial="string.digits"><add value="," /></valid>
+                    </sanitizer>
+                </param>
+                <param name="cl2" type="text" value="2" label="Cluster set 2" help="You can also compare sets of clusters to one another: e.g. 1,4,5 against 2,3." >
+                    <sanitizer invalid_char="" >
+                        <valid initial="string.digits"><add value="," /></valid>
+                    </sanitizer>
+                </param>
+                <param name="mincount" type="integer" value="5" min="1" label="Only count genes with more than this number of transcripts in at least one cell within Cluster set 1 or Cluster set 2" />
+            </when>
+        </conditional>
+    </inputs>
+
+    <outputs>
+        <data name="out_html" format="html" label="${tool.name} on ${on_string}: Web Report" />
+        <data format="tsv" name="out_tables" label="${tool.name} on ${on_string}: DiffExpr Tables" >
+            <discover_datasets pattern="__designation_and_ext__" directory="tables" visible="true" />
+       </data>
+    </outputs>
+
+    <tests>
+        <test>
+            <param name="inp_rdat" value="in_diffgene.rdat" />
+            <output name="out_html" value="out_diffgene1.html" />
+            <!-- verify just two of the outputs -->
+            <output name="out_tables" >
+                <!-- Problems here... help appreciated -->
+                <discovered_dataset designation="gdiff_cl.1" ftype="tsv" file="gdiff_cl.1.tsv" />
+                <discovered_dataset designation="gdiff_cl.2" ftype="tsv" file="gdiff_cl.2.tsv" />
+            </output>
+        </test>
+        <test>
+            <!-- Diff Cluster plot only -->
+            <param name="inp_rdat" value="in_diffgene.rdat" />
+            <param name="pval" value="0.05" />
+            <param name="gen_gexpr_table" value="F" />
+            <param name="do_compare_clusters" value="T" />
+            <param name="gene" value="1110038F14Rik__chr15" />
+            <param name="cl1" value="1" />
+            <param name="cl2" value="2,3" />
+            <param name="mincount" value="2" />
+            <output name="out_html" value="out_diffgene2.html" />
+        </test>
+    </tests>
+    <help><![CDATA[
+*****************
+RaceID Diff Genes
+*****************
+
+Generates a table of all differentially expressed genes, and a plot representing the expression of a specific gene of interest between different clusters.
+
+The RaceID pipeline must be run prior to using this tool, as the input of this tool is generated from the output of the pipeline.
+
+
+    ]]></help>
+    <expand macro="citations" />
+</tool>
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/scripts/RaceID_class.R	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,683 @@
+## load required packages.
+require(tsne)
+require(pheatmap)
+require(MASS)
+require(cluster)
+require(mclust)
+require(flexmix)
+require(lattice)
+require(fpc)
+require(amap)
+require(RColorBrewer)
+require(locfit)
+
+## class definition
+SCseq <- setClass("SCseq", slots = c(expdata = "data.frame", ndata = "data.frame", fdata = "data.frame", distances = "matrix", tsne = "data.frame", kmeans = "list", background = "list", out = "list", cpart = "vector", fcol = "vector", filterpar = "list", clusterpar = "list", outlierpar ="list" ))
+
+setValidity("SCseq",
+            function(object) {
+              msg <- NULL
+              if ( ! is.data.frame(object@expdata) ){
+                msg <- c(msg, "input data must be data.frame")
+              }else if ( nrow(object@expdata) < 2 ){
+                msg <- c(msg, "input data must have more than one row")
+              }else if ( ncol(object@expdata) < 2 ){
+                msg <- c(msg, "input data must have more than one column")
+              }else if (sum( apply( is.na(object@expdata),1,sum ) ) > 0 ){
+                msg <- c(msg, "NAs are not allowed in input data")
+              }else if (sum( apply( object@expdata,1,min ) ) < 0 ){
+                msg <- c(msg, "negative values are not allowed in input data")
+              }
+              if (is.null(msg)) TRUE
+              else msg
+            }
+            )
+
+setMethod("initialize",
+          signature = "SCseq",
+          definition = function(.Object, expdata ){
+            .Object@expdata <- expdata
+            .Object@ndata <- expdata
+            .Object@fdata <- expdata
+            validObject(.Object)
+            return(.Object)
+          }
+          )
+
+setGeneric("filterdata", function(object, mintotal=3000, minexpr=5, minnumber=1, maxexpr=500, downsample=FALSE, dsn=1, rseed=17000) standardGeneric("filterdata"))
+
+setMethod("filterdata",
+          signature = "SCseq",
+          definition = function(object,mintotal,minexpr,minnumber,maxexpr,downsample,dsn,rseed) {
+            if ( ! is.numeric(mintotal) ) stop( "mintotal has to be a positive number" ) else if ( mintotal <= 0 ) stop( "mintotal has to be a positive number" )
+            if ( ! is.numeric(minexpr) ) stop( "minexpr has to be a non-negative number" ) else if ( minexpr < 0 ) stop( "minexpr has to be a non-negative number" )
+            if ( ! is.numeric(minnumber) ) stop( "minnumber has to be a non-negative integer number" ) else if ( round(minnumber) != minnumber | minnumber < 0 ) stop( "minnumber has to be a non-negative integer number" )
+            if ( ! ( is.numeric(downsample) | is.logical(downsample) ) ) stop( "downsample has to be logical (TRUE/FALSE)" )
+            if ( ! is.numeric(dsn) ) stop( "dsn has to be a positive integer number" ) else if ( round(dsn) != dsn | dsn <= 0 ) stop( "dsn has to be a positive integer number" )
+            object@filterpar <- list(mintotal=mintotal, minexpr=minexpr, minnumber=minnumber, maxexpr=maxexpr, downsample=downsample, dsn=dsn)
+            object@ndata <- object@expdata[,apply(object@expdata,2,sum,na.rm=TRUE) >= mintotal]
+            if ( downsample ){
+              set.seed(rseed)
+              object@ndata <- downsample(object@expdata,n=mintotal,dsn=dsn)
+            }else{
+              x <- object@ndata
+              object@ndata <- as.data.frame( t(t(x)/apply(x,2,sum))*median(apply(x,2,sum,na.rm=TRUE)) + .1 )
+            }
+            x <- object@ndata
+            object@fdata <- x[apply(x>=minexpr,1,sum,na.rm=TRUE) >= minnumber,]
+            x <- object@fdata
+            object@fdata <- x[apply(x,1,max,na.rm=TRUE) < maxexpr,]
+            return(object)
+          }
+          )
+
+
+downsample <- function(x,n,dsn){
+  x <- round( x[,apply(x,2,sum,na.rm=TRUE) >= n], 0)
+  nn <- min( apply(x,2,sum) )
+  for ( j in 1:dsn ){
+    z  <- data.frame(GENEID=rownames(x))
+    rownames(z) <- rownames(x)
+    initv <- rep(0,nrow(z))
+    for ( i in 1:dim(x)[2] ){
+      y <- aggregate(rep(1,nn),list(sample(rep(rownames(x),x[,i]),nn)),sum)
+      na <- names(x)[i]
+      names(y) <- c("GENEID",na)
+      rownames(y) <- y$GENEID
+      z[,na] <- initv
+      k <- intersect(rownames(z),y$GENEID)
+      z[k,na] <- y[k,na]
+      z[is.na(z[,na]),na] <- 0
+    }
+    rownames(z) <- as.vector(z$GENEID)
+    ds <- if ( j == 1 ) z[,-1] else ds + z[,-1]
+  }
+  ds <- ds/dsn + .1
+  return(ds)
+}
+
+dist.gen <- function(x,method="euclidean", ...) if ( method %in% c("spearman","pearson","kendall") ) as.dist( 1 - cor(t(x),method=method,...) ) else dist(x,method=method,...)
+
+dist.gen.pairs <- function(x,y,...) dist.gen(t(cbind(x,y)),...)
+
+clustfun <- function(x,clustnr=20,bootnr=50,metric="pearson",do.gap=TRUE,SE.method="Tibs2001SEmax",SE.factor=.25,B.gap=50,cln=0,rseed=17000)
+{
+  if ( clustnr < 2) stop("Choose clustnr > 1")
+  di <- dist.gen(t(x),method=metric)
+  if ( do.gap | cln > 0 ){
+    gpr <- NULL
+    if ( do.gap ){
+      set.seed(rseed)
+      gpr <- clusGap(as.matrix(di), FUN = kmeans, K.max = clustnr, B = B.gap) 
+      if ( cln == 0 ) cln <- maxSE(gpr$Tab[,3],gpr$Tab[,4],method=SE.method,SE.factor)
+    }    
+    if ( cln <= 1 ) {
+      clb <- list(result=list(partition=rep(1,dim(x)[2])),bootmean=1)
+      names(clb$result$partition) <- names(x)
+      return(list(x=x,clb=clb,gpr=gpr,di=di))
+    }
+    clb <- clusterboot(di,B=bootnr,distances=FALSE,bootmethod="boot",clustermethod=KmeansCBI,krange=cln,scaling=FALSE,multipleboot=FALSE,bscompare=TRUE,seed=rseed)
+    return(list(x=x,clb=clb,gpr=gpr,di=di))
+  }
+}
+
+KmeansCBI <- function (data, krange, k = NULL, scaling = FALSE, runs = 1, 
+    criterion = "ch", method="euclidean",...) 
+{
+    if (!is.null(k)) 
+        krange <- k
+    if (!identical(scaling, FALSE)) 
+        sdata <- scale(data, center = TRUE, scale = scaling)
+    else sdata <- data
+    c1 <- Kmeansruns(sdata, krange, runs = runs, criterion = criterion, method = method,
+        ...)
+    partition <- c1$cluster
+    cl <- list()
+    nc <- krange
+    for (i in 1:nc) cl[[i]] <- partition == i
+    out <- list(result = c1, nc = nc, clusterlist = cl, partition = partition, 
+        clustermethod = "kmeans")
+    out
+}
+
+Kmeansruns <- function (data, krange = 2:10, criterion = "ch", iter.max = 100, 
+    runs = 100, scaledata = FALSE, alpha = 0.001, critout = FALSE, 
+    plot = FALSE, method="euclidean", ...) 
+{
+    data <- as.matrix(data)
+    if (criterion == "asw") 
+        sdata <- dist(data)
+    if (scaledata) 
+        data <- scale(data)
+    cluster1 <- 1 %in% krange
+    crit <- numeric(max(krange))
+    km <- list()
+    for (k in krange) {
+        if (k > 1) {
+            minSS <- Inf
+            kmopt <- NULL
+            for (i in 1:runs) {
+                options(show.error.messages = FALSE)
+                repeat {
+                  kmm <- try(Kmeans(data, k, iter.max = iter.max, method=method,
+                    ...))
+                  if (class(kmm) != "try-error") 
+                    break
+                }
+                options(show.error.messages = TRUE)
+                swss <- sum(kmm$withinss)
+                if (swss < minSS) {
+                  kmopt <- kmm
+                  minSS <- swss
+                }
+                if (plot) {
+                  par(ask = TRUE)
+                  pairs(data, col = kmm$cluster, main = swss)
+                }
+            }
+            km[[k]] <- kmopt
+            crit[k] <- switch(criterion, asw = cluster.stats(sdata, 
+                km[[k]]$cluster)$avg.silwidth, ch = calinhara(data, 
+                km[[k]]$cluster))
+            if (critout) 
+                cat(k, " clusters ", crit[k], "\n")
+        }
+    }
+    if (cluster1) 
+        cluster1 <- dudahart2(data, km[[2]]$cluster, alpha = alpha)$cluster1
+    k.best <- which.max(crit)
+    if (cluster1) 
+        k.best <- 1
+    km[[k.best]]$crit <- crit
+    km[[k.best]]$bestk <- k.best
+    out <- km[[k.best]]
+    out
+}
+
+binompval <- function(p,N,n){
+  pval   <- pbinom(n,round(N,0),p,lower.tail=TRUE)
+  pval[!is.na(pval) & pval > 0.5] <- 1-pval[!is.na(pval) & pval > 0.5]
+  return(pval)
+}
+
+setGeneric("clustexp", function(object,clustnr=20,bootnr=50,metric="pearson",do.gap=TRUE,SE.method="Tibs2001SEmax",SE.factor=.25,B.gap=50,cln=0,rseed=17000) standardGeneric("clustexp"))
+
+setMethod("clustexp",
+          signature = "SCseq",
+          definition = function(object,clustnr,bootnr,metric,do.gap,SE.method,SE.factor,B.gap,cln,rseed) {
+            if ( ! is.numeric(clustnr) ) stop("clustnr has to be a positive integer") else if ( round(clustnr) != clustnr | clustnr <= 0 ) stop("clustnr has to be a positive integer")
+            if ( ! is.numeric(bootnr) ) stop("bootnr has to be a positive integer") else if ( round(bootnr) != bootnr | bootnr <= 0 ) stop("bootnr has to be a positive integer")
+            if ( ! ( metric %in% c( "spearman","pearson","kendall","euclidean","maximum","manhattan","canberra","binary","minkowski") ) ) stop("metric has to be one of the following: spearman, pearson, kendall, euclidean, maximum, manhattan, canberra, binary, minkowski")
+            if ( ! ( SE.method %in% c( "firstSEmax","Tibs2001SEmax","globalSEmax","firstmax","globalmax") ) ) stop("SE.method has to be one of the following: firstSEmax, Tibs2001SEmax, globalSEmax, firstmax, globalmax")
+            if ( ! is.numeric(SE.factor) ) stop("SE.factor has to be a non-negative integer") else if  ( SE.factor < 0 )  stop("SE.factor has to be a non-negative integer")
+            if ( ! ( is.numeric(do.gap) | is.logical(do.gap) ) ) stop( "do.gap has to be logical (TRUE/FALSE)" )
+            if ( ! is.numeric(B.gap) ) stop("B.gap has to be a positive integer") else if ( round(B.gap) != B.gap | B.gap <= 0 ) stop("B.gap has to be a positive integer")
+            if ( ! is.numeric(cln) ) stop("cln has to be a non-negative integer") else if ( round(cln) != cln | cln < 0 ) stop("cln has to be a non-negative integer")          
+            if ( ! is.numeric(rseed) ) stop("rseed has to be numeric")
+            if ( !do.gap & cln == 0 ) stop("cln has to be a positive integer or do.gap has to be TRUE")
+            object@clusterpar <- list(clustnr=clustnr,bootnr=bootnr,metric=metric,do.gap=do.gap,SE.method=SE.method,SE.factor=SE.factor,B.gap=B.gap,cln=cln,rseed=rseed)
+            y <- clustfun(object@fdata,clustnr,bootnr,metric,do.gap,SE.method,SE.factor,B.gap,cln,rseed)
+            object@kmeans    <- list(kpart=y$clb$result$partition, jaccard=y$clb$bootmean, gap=y$gpr)
+            object@distances <- as.matrix( y$di )
+            set.seed(111111)
+            object@fcol <- sample(rainbow(max(y$clb$result$partition)))
+            return(object)
+          }
+          )
+
+setGeneric("findoutliers", function(object,outminc=5,outlg=2,probthr=1e-3,thr=2**-(1:40),outdistquant=.75) standardGeneric("findoutliers"))
+
+setMethod("findoutliers",
+          signature = "SCseq",
+          definition = function(object,outminc,outlg,probthr,thr,outdistquant) {
+            if ( length(object@kmeans$kpart) == 0 ) stop("run clustexp before findoutliers")
+            if ( ! is.numeric(outminc) ) stop("outminc has to be a non-negative integer") else if ( round(outminc) != outminc | outminc < 0 ) stop("outminc has to be a non-negative integer")
+            if ( ! is.numeric(outlg) ) stop("outlg has to be a non-negative integer") else if ( round(outlg) != outlg | outlg < 0 ) stop("outlg has to be a non-negative integer")
+            if ( ! is.numeric(probthr) ) stop("probthr has to be a number between 0 and 1") else if (  probthr < 0 | probthr > 1 ) stop("probthr has to be a number between 0 and 1")
+            if ( ! is.numeric(thr) ) stop("thr hast to be a vector of numbers between 0 and 1") else if ( min(thr) < 0 | max(thr) > 1 ) stop("thr hast to be a vector of numbers between 0 and 1")
+            if ( ! is.numeric(outdistquant) ) stop("outdistquant has to be a number between 0 and 1") else if (  outdistquant < 0 | outdistquant > 1 ) stop("outdistquant has to be a number between 0 and 1")
+                      
+            object@outlierpar <- list( outminc=outminc,outlg=outlg,probthr=probthr,thr=thr,outdistquant=outdistquant )
+            ### calibrate background model
+            m <- log2(apply(object@fdata,1,mean))
+            v <- log2(apply(object@fdata,1,var))
+            f <- m > -Inf & v > -Inf
+            m <- m[f]
+            v <- v[f]
+            mm <- -8
+            repeat{
+              fit <- lm(v ~ m + I(m^2)) 
+              if( coef(fit)[3] >= 0 | mm >= 3){
+                break
+              }
+              mm <- mm + .5
+              f <- m > mm
+              m <- m[f]
+              v <- v[f]
+            }
+            object@background <- list()
+            object@background$vfit <- fit
+            object@background$lvar <- function(x,object) 2**(coef(object@background$vfit)[1] + log2(x)*coef(object@background$vfit)[2] + coef(object@background$vfit)[3] * log2(x)**2)
+            object@background$lsize <- function(x,object) x**2/(max(x + 1e-6,object@background$lvar(x,object)) - x)
+
+            ### identify outliers
+            out   <- c()
+            stest <- rep(0,length(thr))
+            cprobs <- c()
+            for ( n in 1:max(object@kmeans$kpart) ){     
+              if ( sum(object@kmeans$kpart == n) == 1 ){ cprobs <- append(cprobs,.5); names(cprobs)[length(cprobs)] <- names(object@kmeans$kpart)[object@kmeans$kpart == n]; next }
+              x <- object@fdata[,object@kmeans$kpart == n]
+              x <- x[apply(x,1,max) > outminc,]
+              z <- t( apply(x,1,function(x){ apply( cbind( pnbinom(round(x,0),mu=mean(x),size=object@background$lsize(mean(x),object)) , 1 - pnbinom(round(x,0),mu=mean(x),size=object@background$lsize(mean(x),object)) ),1, min) } ) )
+              cp <- apply(z,2,function(x){ y <- p.adjust(x,method="BH"); y <- y[order(y,decreasing=FALSE)]; return(y[outlg]);})
+              f <- cp < probthr
+              cprobs <- append(cprobs,cp)
+              if ( sum(f) > 0 ) out <- append(out,names(x)[f])
+              for ( j in 1:length(thr) )  stest[j] <-  stest[j] + sum( cp < thr[j] )  
+            }
+            object@out <-list(out=out,stest=stest,thr=thr,cprobs=cprobs)
+
+            ### cluster outliers
+            clp2p.cl <- c()
+            cols <- names(object@fdata)
+            di <- as.data.frame(object@distances)
+            for ( i in 1:max(object@kmeans$kpart) ) {
+              tcol <- cols[object@kmeans$kpart == i]
+              if ( sum(!(tcol %in% out)) > 1 ) clp2p.cl <- append(clp2p.cl,as.vector(t(di[tcol[!(tcol %in% out)],tcol[!(tcol %in% out)]])))
+            }
+            clp2p.cl <- clp2p.cl[clp2p.cl>0]
+  
+            cpart <- object@kmeans$kpart
+            cadd  <- list()
+            if ( length(out) > 0 ){
+              if (length(out) == 1){
+                cadd <- list(out)
+              }else{
+                n <- out
+                m <- as.data.frame(di[out,out])
+                
+                for ( i in 1:length(out) ){
+                  if ( length(n) > 1 ){
+                    o   <- order(apply(cbind(m,1:dim(m)[1]),1,function(x)  min(x[1:(length(x)-1)][-x[length(x)]])),decreasing=FALSE)
+                    m <- m[o,o]
+                    n <- n[o]          
+                    f <- m[,1] < quantile(clp2p.cl,outdistquant) | m[,1] == min(clp2p.cl)
+                    ind <- 1  
+                    if ( sum(f) > 1 ) for ( j in 2:sum(f) ) if ( apply(m[f,f][j,c(ind,j)] > quantile(clp2p.cl,outdistquant) ,1,sum) == 0 ) ind <- append(ind,j)
+                    cadd[[i]] <- n[f][ind]
+                    g <- ! n %in% n[f][ind]
+                    n <- n[g]
+                    m <- m[g,g]
+                    if ( sum(g) == 0 ) break
+          
+                  }else if (length(n) == 1){
+                    cadd[[i]] <- n
+                    break
+                  }
+                }
+              }
+    
+              for ( i in 1:length(cadd) ){
+                cpart[cols %in% cadd[[i]]] <- max(cpart) + 1
+              }
+            }
+
+            ### determine final clusters
+            for ( i in 1:max(cpart) ){
+              d <- object@fdata[,cols[cpart == i]]
+              if ( sum(cpart == i) == 1 ) cent <- d else cent <- apply(d,1,mean)
+              if ( i == 1 ) dcent <- data.frame(cent) else dcent <- cbind(dcent,cent)
+              if ( i == 1 ) tmp <- data.frame(apply(object@fdata[,cols],2,dist.gen.pairs,y=cent,method=object@clusterpar$metric)) else tmp <- cbind(tmp,apply(object@fdata[,cols],2,dist.gen.pairs,y=cent,method=object@clusterpar$metric))
+            }    
+            cpart <- apply(tmp,1,function(x) order(x,decreasing=FALSE)[1])
+  
+            for  ( i in max(cpart):1){if (sum(cpart==i)==0) cpart[cpart>i] <- cpart[cpart>i] - 1 }
+
+            object@cpart <- cpart
+
+            set.seed(111111)
+            object@fcol <- sample(rainbow(max(cpart)))
+            return(object)
+          }
+        )
+
+setGeneric("plotgap", function(object) standardGeneric("plotgap"))
+
+setMethod("plotgap",
+          signature = "SCseq",
+          definition = function(object){
+            if ( length(object@kmeans$kpart) == 0 ) stop("run clustexp before plotgap")
+            plot(object@kmeans$gap)
+          }
+          )
+
+setGeneric("plotsilhouette", function(object) standardGeneric("plotsilhouette"))
+
+setMethod("plotsilhouette",
+          signature = "SCseq",
+          definition = function(object){
+            if ( length(object@kmeans$kpart) == 0 ) stop("run clustexp before plotsilhouette")
+            if ( length(unique(object@kmeans$kpart)) < 2 ) stop("only a single cluster: no silhouette plot")
+            kpart <- object@kmeans$kpart
+            distances  <- dist.gen(object@distances)
+            si <- silhouette(kpart,distances)
+            plot(si)
+          }
+          )
+
+setGeneric("plotjaccard", function(object) standardGeneric("plotjaccard"))
+
+setMethod("plotjaccard",
+          signature = "SCseq",
+          definition = function(object){
+            if ( length(object@kmeans$kpart) == 0 ) stop("run clustexp before plotjaccard")
+            if ( length(unique(object@kmeans$kpart)) < 2 ) stop("only a single cluster: no Jaccard's similarity plot")
+            barplot(object@kmeans$jaccard,names.arg=1:length(object@kmeans$jaccard),ylab="Jaccard's similarity")
+          }
+          )
+
+setGeneric("plotoutlierprobs", function(object) standardGeneric("plotoutlierprobs"))
+
+setMethod("plotoutlierprobs",
+          signature = "SCseq",
+          definition = function(object){
+            if ( length(object@cpart) == 0 ) stop("run findoutliers before plotoutlierprobs")
+            p <- object@kmeans$kpart[ order(object@kmeans$kpart,decreasing=FALSE)]
+            x <- object@out$cprobs[names(p)]
+            fcol <- object@fcol
+            for ( i in 1:max(p) ){
+              y <- -log10(x + 2.2e-16)
+              y[p != i] <- 0
+              if ( i == 1 ) b <- barplot(y,ylim=c(0,max(-log10(x + 2.2e-16))*1.1),col=fcol[i],border=fcol[i],names.arg=FALSE,ylab="-log10prob") else barplot(y,add=TRUE,col=fcol[i],border=fcol[i],names.arg=FALSE,axes=FALSE)
+  }
+            abline(-log10(object@outlierpar$probthr),0,col="black",lty=2)
+            d <- b[2,1] - b[1,1]
+            y <- 0
+            for ( i in 1:max(p) ) y <- append(y,b[sum(p <=i),1] + d/2)
+            axis(1,at=(y[1:(length(y)-1)] + y[-1])/2,lab=1:max(p))
+            box()
+          }
+          )
+
+setGeneric("plotbackground", function(object) standardGeneric("plotbackground"))
+
+setMethod("plotbackground",
+          signature = "SCseq",
+          definition = function(object){
+            if ( length(object@cpart) == 0 ) stop("run findoutliers before plotbackground")
+            m <- apply(object@fdata,1,mean)
+            v <- apply(object@fdata,1,var)
+            fit <- locfit(v~lp(m,nn=.7),family="gamma",maxk=500)
+            plot(log2(m),log2(v),pch=20,xlab="log2mean",ylab="log2var",col="grey")
+            lines(log2(m[order(m)]),log2(object@background$lvar(m[order(m)],object)),col="red",lwd=2)
+            lines(log2(m[order(m)]),log2(fitted(fit)[order(m)]),col="orange",lwd=2,lty=2)
+            legend("topleft",legend=substitute(paste("y = ",a,"*x^2 + ",b,"*x + ",d,sep=""),list(a=round(coef(object@background$vfit)[3],2),b=round(coef(object@background$vfit)[2],2),d=round(coef(object@background$vfit)[1],2))),bty="n")
+          }
+          )
+
+setGeneric("plotsensitivity", function(object) standardGeneric("plotsensitivity"))
+
+setMethod("plotsensitivity",
+          signature = "SCseq",
+          definition = function(object){
+            if ( length(object@cpart) == 0 ) stop("run findoutliers before plotsensitivity")
+            plot(log10(object@out$thr), object@out$stest, type="l",xlab="log10 Probability cutoff", ylab="Number of outliers")
+            abline(v=log10(object@outlierpar$probthr),col="red",lty=2)
+          }
+          )
+
+setGeneric("clustdiffgenes", function(object,pvalue=.01) standardGeneric("clustdiffgenes"))
+
+setMethod("clustdiffgenes",
+          signature = "SCseq",
+          definition = function(object,pvalue){
+            if ( length(object@cpart) == 0 ) stop("run findoutliers before clustdiffgenes")
+            if ( ! is.numeric(pvalue) ) stop("pvalue has to be a number between 0 and 1") else if (  pvalue < 0 | pvalue > 1 ) stop("pvalue has to be a number between 0 and 1")
+            cdiff <- list()
+            x     <- object@ndata
+            y     <- object@expdata[,names(object@ndata)]
+            part  <- object@cpart
+            for ( i in 1:max(part) ){
+              if ( sum(part == i) == 0 ) next
+              m <- apply(x,1,mean)
+              n <- if ( sum(part == i) > 1 ) apply(x[,part == i],1,mean) else x[,part == i]
+              no <- if ( sum(part == i) > 1 ) median(apply(y[,part == i],2,sum))/median(apply(x[,part == i],2,sum)) else sum(y[,part == i])/sum(x[,part == i])
+              m <- m*no
+              n <- n*no
+              pv <- binompval(m/sum(m),sum(n),n)
+              d <- data.frame(mean.all=m,mean.cl=n,fc=n/m,pv=pv)[order(pv,decreasing=FALSE),]
+              cdiff[[paste("cl",i,sep=".")]] <- d[d$pv < pvalue,]
+            }
+            return(cdiff)
+          }
+          )
+
+setGeneric("diffgenes", function(object,cl1,cl2,mincount=5) standardGeneric("diffgenes"))
+
+setMethod("diffgenes",
+          signature = "SCseq",
+          definition = function(object,cl1,cl2,mincount){
+            part <- object@cpart
+            cl1 <- c(cl1)
+            cl2 <- c(cl2)
+            if ( length(part) == 0 ) stop("run findoutliers before diffgenes")
+            if ( ! is.numeric(mincount) ) stop("mincount has to be a non-negative number") else if (  mincount < 0 ) stop("mincount has to be a non-negative number")
+            if ( length(intersect(cl1, part)) < length(unique(cl1)) ) stop( paste("cl1 has to be a subset of ",paste(sort(unique(part)),collapse=","),"\n",sep="") )
+            if ( length(intersect(cl2, part)) < length(unique(cl2)) ) stop( paste("cl2 has to be a subset of ",paste(sort(unique(part)),collapse=","),"\n",sep="") )
+            f <- apply(object@ndata[,part %in% c(cl1,cl2)],1,max) > mincount
+            x <- object@ndata[f,part %in% cl1]
+            y <- object@ndata[f,part %in% cl2]
+            if ( sum(part %in% cl1) == 1 ) m1 <- x else m1 <- apply(x,1,mean)
+            if ( sum(part %in% cl2) == 1 ) m2 <- y else m2 <- apply(y,1,mean)
+            if ( sum(part %in% cl1) == 1 ) s1 <- sqrt(x) else s1 <- sqrt(apply(x,1,var))
+            if ( sum(part %in% cl2) == 1 ) s2 <- sqrt(y) else s2 <- sqrt(apply(y,1,var))
+            
+            d <- ( m1 - m2 )/ apply( cbind( s1, s2 ),1,mean )
+            names(d) <- rownames(object@ndata)[f]
+            if ( sum(part %in% cl1) == 1 ){
+              names(x) <- names(d)
+              x <- x[order(d,decreasing=TRUE)]
+            }else{
+              x <- x[order(d,decreasing=TRUE),]
+            }
+            if ( sum(part %in% cl2) == 1 ){
+              names(y) <- names(d)
+              y <- y[order(d,decreasing=TRUE)]
+            }else{
+              y <- y[order(d,decreasing=TRUE),]
+            }
+            return(list(z=d[order(d,decreasing=TRUE)],cl1=x,cl2=y,cl1n=cl1,cl2n=cl2))
+          }
+          )
+
+plotdiffgenes <- function(z,gene=g){
+  if ( ! is.list(z) ) stop("first arguments needs to be output of function diffgenes")
+  if ( length(z) < 5 ) stop("first arguments needs to be output of function diffgenes")
+  if ( sum(names(z) == c("z","cl1","cl2","cl1n","cl2n")) < 5 ) stop("first arguments needs to be output of function diffgenes")
+  if ( length(gene) > 1 ) stop("only single value allowed for argument gene")
+  if ( !is.numeric(gene) & !(gene %in% names(z$z)) ) stop("argument gene needs to be within rownames of first argument or a positive integer number")
+  if ( is.numeric(gene) ){ if ( gene < 0 | round(gene) != gene ) stop("argument gene needs to be within rownames of first argument or a positive integer number") }
+  x <- if ( is.null(dim(z$cl1)) ) z$cl1[gene] else t(z$cl1[gene,])
+  y <- if ( is.null(dim(z$cl2)) ) z$cl2[gene] else t(z$cl2[gene,])
+  plot(1:length(c(x,y)),c(x,y),ylim=c(0,max(c(x,y))),xlab="",ylab="Expression",main=gene,cex=0,axes=FALSE)
+  axis(2)
+  box()
+  u <- 1:length(x)
+  rect(u - .5,0,u + .5,x,col="red")
+  v <- c(min(u) - .5,max(u) + .5)
+  axis(1,at=mean(v),lab=paste(z$cl1n,collapse=","))
+  lines(v,rep(mean(x),length(v)))
+  lines(v,rep(mean(x)-sqrt(var(x)),length(v)),lty=2)
+  lines(v,rep(mean(x)+sqrt(var(x)),length(v)),lty=2)
+  
+  u <- ( length(x) + 1 ):length(c(x,y))
+  v <- c(min(u) - .5,max(u) + .5)
+  rect(u - .5,0,u + .5,y,col="blue")
+  axis(1,at=mean(v),lab=paste(z$cl2n,collapse=","))
+  lines(v,rep(mean(y),length(v)))
+  lines(v,rep(mean(y)-sqrt(var(y)),length(v)),lty=2)
+  lines(v,rep(mean(y)+sqrt(var(y)),length(v)),lty=2)
+  abline(v=length(x) + .5)
+}
+
+setGeneric("clustheatmap", function(object,final=FALSE,hmethod="single") standardGeneric("clustheatmap"))
+
+setMethod("clustheatmap",
+          signature = "SCseq",
+          definition = function(object,final,hmethod){
+            if ( final & length(object@cpart) == 0 ) stop("run findoutliers before clustheatmap")
+            if ( !final & length(object@kmeans$kpart) == 0 ) stop("run clustexp before clustheatmap")
+            x <- object@fdata  
+            part <- if ( final ) object@cpart else object@kmeans$kpart
+            na <- c()
+            j <- 0
+            for ( i in 1:max(part) ){
+              if ( sum(part == i) == 0 ) next
+              j <- j + 1
+              na <- append(na,i)
+              d <- x[,part == i]
+              if ( sum(part == i) == 1 ) cent <- d else cent <- apply(d,1,mean)
+              if ( j == 1 ) tmp <- data.frame(cent) else tmp <- cbind(tmp,cent)
+            }
+            names(tmp) <- paste("cl",na,sep=".")
+            if ( max(part) > 1 )  cclmo <- hclust(dist.gen(as.matrix(dist.gen(t(tmp),method=object@clusterpar$metric))),method=hmethod)$order else cclmo <- 1
+            q <- part
+            for ( i in 1:max(part) ){
+              q[part == na[cclmo[i]]] <- i
+            }
+            part <- q
+            di <- as.data.frame( as.matrix( dist.gen(t(object@distances)) ) )
+            pto <- part[order(part,decreasing=FALSE)]
+            ptn <- c()
+            for ( i in 1:max(pto) ){ pt <- names(pto)[pto == i]; z <- if ( length(pt) == 1 ) pt else pt[hclust(as.dist(t(di[pt,pt])),method=hmethod)$order]; ptn <- append(ptn,z) }
+            col <- object@fcol
+            mi  <- min(di,na.rm=TRUE)
+            ma  <- max(di,na.rm=TRUE)
+            layout(matrix(data=c(1,3,2,4), nrow=2, ncol=2), widths=c(5,1,5,1), heights=c(5,1,1,1))
+            ColorRamp   <- colorRampPalette(brewer.pal(n = 7,name = "RdYlBu"))(100)
+            ColorLevels <- seq(mi, ma, length=length(ColorRamp))
+            if ( mi == ma ){
+              ColorLevels <- seq(0.99*mi, 1.01*ma, length=length(ColorRamp))
+            }
+            par(mar = c(3,5,2.5,2))
+            image(as.matrix(di[ptn,ptn]),col=ColorRamp,axes=FALSE)
+            abline(0,1)
+            box()
+            
+            tmp <- c()
+            for ( u in 1:max(part) ){
+              ol <- (0:(length(part) - 1)/(length(part) - 1))[ptn %in% names(x)[part == u]]
+              points(rep(0,length(ol)),ol,col=col[cclmo[u]],pch=15,cex=.75)
+              points(ol,rep(0,length(ol)),col=col[cclmo[u]],pch=15,cex=.75)
+              tmp <- append(tmp,mean(ol))
+            }
+            axis(1,at=tmp,lab=cclmo)
+            axis(2,at=tmp,lab=cclmo)
+            par(mar = c(3,2.5,2.5,2))
+            image(1, ColorLevels,
+                  matrix(data=ColorLevels, ncol=length(ColorLevels),nrow=1),
+                  col=ColorRamp,
+                  xlab="",ylab="",
+                  xaxt="n")
+            layout(1)
+            return(cclmo)
+          }
+          )
+
+setGeneric("comptsne", function(object,rseed=15555) standardGeneric("comptsne"))
+
+setMethod("comptsne",
+          signature = "SCseq",
+          definition = function(object,rseed){
+            if ( length(object@kmeans$kpart) == 0 ) stop("run clustexp before comptsne")
+            set.seed(rseed)
+            di <- dist.gen(as.matrix(object@distances))
+            ts <- tsne(di,k=2)
+            object@tsne <- as.data.frame(ts)
+            return(object)
+          }
+          )
+
+setGeneric("plottsne", function(object,final=TRUE) standardGeneric("plottsne"))
+
+setMethod("plottsne",
+          signature = "SCseq",
+          definition = function(object,final){
+            if ( length(object@tsne) == 0 ) stop("run comptsne before plottsne")
+            if ( final & length(object@cpart) == 0 ) stop("run findoutliers before plottsne")
+            if ( !final & length(object@kmeans$kpart) == 0 ) stop("run clustexp before plottsne")
+            part <- if ( final ) object@cpart else object@kmeans$kpart
+            plot(object@tsne,xlab="Dim 1",ylab="Dim 2",pch=20,cex=1.5,col="lightgrey")
+            for ( i in 1:max(part) ){
+              if ( sum(part == i) > 0 ) text(object@tsne[part == i,1],object@tsne[part == i,2],i,col=object@fcol[i],cex=.75,font=4)
+            }
+          }
+          )
+
+setGeneric("plotlabelstsne", function(object,labels=NULL) standardGeneric("plotlabelstsne"))
+
+setMethod("plotlabelstsne",
+          signature = "SCseq",
+          definition = function(object,labels){
+            if ( is.null(labels ) ) labels <- names(object@ndata)
+            if ( length(object@tsne) == 0 ) stop("run comptsne before plotlabelstsne")
+            plot(object@tsne,xlab="Dim 1",ylab="Dim 2",pch=20,cex=1.5,col="lightgrey")
+            text(object@tsne[,1],object@tsne[,2],labels,cex=.5)
+          }
+          )
+
+setGeneric("plotsymbolstsne", function(object,types=NULL) standardGeneric("plotsymbolstsne"))
+
+setMethod("plotsymbolstsne",
+          signature = "SCseq",
+          definition = function(object,types){
+            if ( is.null(types) ) types <- names(object@fdata)
+            if ( length(object@tsne) == 0 ) stop("run comptsne before plotsymbolstsne")
+            if ( length(types) != ncol(object@fdata) ) stop("types argument has wrong length. Length has to equal to the column number of object@ndata")
+            coloc <- rainbow(length(unique(types)))
+            syms <- c()
+            plot(object@tsne,xlab="Dim 1",ylab="Dim 2",pch=20,col="grey")
+            for ( i in 1:length(unique(types)) ){
+              f <- types == sort(unique(types))[i]
+              syms <- append( syms, ( (i-1) %% 25 ) + 1 )
+              points(object@tsne[f,1],object@tsne[f,2],col=coloc[i],pch=( (i-1) %% 25 ) + 1,cex=1)
+            }
+            legend("topleft", legend=sort(unique(types)), col=coloc, pch=syms)
+          }
+          )
+
+setGeneric("plotexptsne", function(object,g,n="",logsc=FALSE) standardGeneric("plotexptsne"))
+
+setMethod("plotexptsne",
+          signature = "SCseq",
+          definition = function(object,g,n="",logsc=FALSE){
+            if ( length(object@tsne) == 0 ) stop("run comptsne before plottsne")
+            if ( length(intersect(g,rownames(object@ndata))) < length(unique(g)) ) stop("second argument does not correspond to set of rownames slot ndata of SCseq object")
+            if ( !is.numeric(logsc) & !is.logical(logsc) ) stop("argument logsc has to be logical (TRUE/FALSE)")
+            if ( n == "" ) n <- g[1]
+            l <- apply(object@ndata[g,] - .1,2,sum) + .1
+            if (logsc) {
+              f <- l == 0
+              l <- log(l)
+              l[f] <- NA
+            }
+            mi <- min(l,na.rm=TRUE)
+            ma <- max(l,na.rm=TRUE)
+            ColorRamp <- colorRampPalette(rev(brewer.pal(n = 7,name = "RdYlBu")))(100)
+            ColorLevels <- seq(mi, ma, length=length(ColorRamp))
+            v <- round((l - mi)/(ma - mi)*99 + 1,0)
+            layout(matrix(data=c(1,3,2,4), nrow=2, ncol=2), widths=c(5,1,5,1), heights=c(5,1,1,1))
+            par(mar = c(3,5,2.5,2))
+            plot(object@tsne,xlab="Dim 1",ylab="Dim 2",main=n,pch=20,cex=0,col="grey")
+            for ( k in 1:length(v) ){
+              points(object@tsne[k,1],object@tsne[k,2],col=ColorRamp[v[k]],pch=20,cex=1.5)
+            }
+            par(mar = c(3,2.5,2.5,2))
+            image(1, ColorLevels,
+                  matrix(data=ColorLevels, ncol=length(ColorLevels),nrow=1),
+                  col=ColorRamp,
+                  xlab="",ylab="",
+                  xaxt="n")
+            layout(1)
+          }
+          )
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/scripts/common.R	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,23 @@
+# Load libs
+arr <- c("methods", "tsne","pheatmap","MASS","cluster","mclust","flexmix","lattice","fpc","RColorBrewer","permute","amap","locfit")
+res <- lapply(arr, require, character.only = TRUE)
+
+
+if (is.na(script_dir) || is.na(config_file) || script_dir == "None" || config_file == "None"){
+   stop("Could not find script_dir or config_file")
+}
+
+source(paste(script_dir, "RaceID_class.R", sep="/"))
+
+# Load params
+source(config_file)
+
+# Common functions
+message <- function(...){ print(sprintf(...)) }
+plotter <- function(fname, funct){
+    name <- paste(fname, "svg", sep=".")
+    svg(name,width=10,height=10)
+    force(funct)
+    dev.off()
+}
+
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/scripts/raceID_diffgenes.R	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,50 @@
+#!/usr/bin/env Rscript
+
+args = commandArgs(trailingOnly=T)
+
+script_dir = args[1]
+config_file = args[2]
+
+                                        # Load libs, common functions, source RaceID,
+                                        # Galaxy Params, and read input data (sc)
+source(paste(script_dir, "common.R", sep="/"))
+
+                                        # Read input data
+message("Count matrix with %.0f cells and %.0f genes", dim(sc@fdata)[1], dim(sc@fdata)[2])
+
+cdiff <- clustdiffgenes(sc, pvalue=c_pval)
+
+if (generate_extable){
+                                        # differentially expressed genes in cluster
+
+    if (!(dir.exists(outtable_dir))){
+        dir.create(outtable_dir)
+    }
+    
+    for ( n in names(cdiff) ){
+        write.table(
+            data.frame(
+                GENEID=rownames(cdiff[[n]]),
+                cdiff[[n]]
+            ),
+            paste(outtable_dir, "/gdiff", "_", n, ".tsv", sep=""),  # gdiff_cl.n.tsv
+            row.names=FALSE,
+            col.names=TRUE,
+            sep="\t",
+            quote=FALSE
+        )        
+    }
+}
+
+if (compare_clusters){   
+    clust1 <- c(unlist(lapply(strsplit(clust1, "\\s*,\\s*"), as.integer)))
+    clust2 <- c(unlist(lapply(strsplit(clust2, "\\s*,\\s*"), as.integer)))
+
+    if (length(clust1) == 1){ clust1 <- clust1[[1]] }
+    if (length(clust2) == 1){ clust2 <- clust2[[1]] }
+
+    message("Performing diffgenes with cl1=%s, cl2=%s, mincount=%.0f, gene='%s'", clust1, clust2, mcount, gene_name)
+    d <- diffgenes(sc,cl1 = clust1, cl2 = clust2, mincount = mcount)
+
+    plotter("plot_diffgenes", plotdiffgenes(d,gene= gene_name))
+}
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/scripts/raceID_filter.R	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,58 @@
+#!/usr/bin/env Rscript
+
+args = commandArgs(trailingOnly=T)
+
+script_dir = args[1]
+config_file = args[2]
+
+# Load libs, common functions, source RaceID and Galaxy Params
+source(paste(script_dir, "common.R", sep="/"))
+
+# Read input data
+x <- read.csv(count_matrix, sep="\t", header=TRUE)
+rownames(x) <- x[,1]
+
+message("Count matrix with %.0f cells and %.0f genes", dim(x)[1], dim(x)[2])
+
+# Control gene filtering
+# (if blank do nothing)
+if (!( (!exists("control_genes_filter")) || control_genes_filter == "" || control_genes_filter == "None")){
+    c_genes <- unlist(strsplit(control_genes_filter, "\\s*,\\s"))
+    for (cg in c_genes){
+        x <- x[grep(cg, rownames(x), invert=T), -1]
+        message("Filtering against %s yielded %.0f cells and %.0f genes", cg, dim(x)[1], dim(x)[2])
+    }
+} else {
+  x <- x[grep("INVALID", rownames(x), invert=T), -1]
+}
+
+if (!filtering){
+   # No filtering, just return an SCseq object
+   sc <- SCseq(x)
+   saveRDS(sc, output_rdat)
+   quit(status=0)
+}
+
+
+sc <- SCseq(x)
+
+if (c_maxexpr == 0){
+   c_maxexpr = Inf
+}
+
+# Perform actual filtering beyond this point
+message("Applying filtering parameters: mintotal = %.0f, minexpr = %.0f, minnumber= %.0f, maxexpr= %.0f, downsample= %.0f, dsn= %.0f, rseed=%.0f", c_mintotal, c_minexpr, c_minnumber, c_maxexpr, c_downsample, c_dsn, c_rseed)
+
+sc <- filterdata(sc,
+   mintotal=c_mintotal,
+   minexpr=c_minexpr,
+   minnumber=c_minnumber,
+   maxexpr=c_maxexpr, downsample = c_downsample, dsn=c_dsn, rseed=c_rseed)
+   
+message("Output matrix yielded %.0f cells and %.0f genes", dim(sc@fdata)[1], dim(sc@fdata)[2])
+
+# Output table
+write.table(sc@fdata, output_table, row.names = T, col.names = T, sep="\t", quote=F)
+# Output R object
+saveRDS(sc, output_rdat)
+
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/scripts/raceID_kmeans_heatmap.R	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,40 @@
+#!/usr/bin/env Rscript
+
+args = commandArgs(trailingOnly=T)
+
+script_dir = args[1]
+config_file = args[2]
+
+                                        # Load libs, common functions, source RaceID,
+                                        # Galaxy Params, and read input data (sc)
+source(paste(script_dir, "common.R", sep="/"))
+
+                                        # Read input data
+message("Count matrix with %.0f cells and %.0f genes", dim(sc@fdata)[1], dim(sc@fdata)[2])
+message("Performing clustering using the following parameters: metric=%s, cln=%.0f, do.gap=%.0f clustnr=%.0f, B.gap=%.0f, SE.method=%s, SE.factor=%.2f, bootnr=%.0f, rseed=%.0f", c_metric, c_cln, dogap, c_clustnr, bgap, semethod, sefactor, c_bootnr, c_rseed)
+
+sc <- clustexp(
+    sc,
+    metric=c_metric, cln=c_cln, do.gap=dogap, clustnr=c_clustnr,
+    B.gap=bgap, SE.method=semethod, SE.factor=sefactor,
+    bootnr=c_bootnr, rseed=c_rseed
+)
+
+message("Plotting images")
+plotter("plot_gap", plotgap(sc))
+plotter("plot_jaccard", plotjaccard(sc))
+plotter("plot_silhouette", plotsilhouette(sc))
+plotter("plot_clustheatmap", x <- clustheatmap(sc, final=FALSE, hmethod="single"))
+
+
+message("Finished plots")
+
+if (generate_final_rdata){
+    message("Saving SC object")
+    saveRDS(sc, output_rdat)
+}
+
+
+
+
+
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/scripts/raceID_outlierdetect.R	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,45 @@
+#!/usr/bin/env Rscript
+
+args = commandArgs(trailingOnly=T)
+
+script_dir = args[1]
+config_file = args[2]
+
+                                        # Load libs, common functions, source RaceID,
+                                        # Galaxy Params, and read input data (sc)
+source(paste(script_dir, "common.R", sep="/"))
+
+                                        # Read input data
+message("Count matrix with %.0f cells and %.0f genes", dim(sc@fdata)[1], dim(sc@fdata)[2])
+message("Detecting outliers using the following parameters: outminc=%.0f, outlg=%.0f, probthr=%.0f outdistquant=%.0f", c_outminc, c_outlg, c_probthr, c_outdistquant)
+
+sc <- findoutliers(
+    sc, outminc=c_outminc, outlg=c_outlg, probthr=c_probthr,
+    thr=2**-(1:40), outdistquant=c_outdistquant
+)
+
+message("Plotting images")
+plotter("plot_background", plotbackground(sc))
+plotter("plot_sensitivity", plotsensitivity(sc))
+plotter("plot_outlierprobs", plotoutlierprobs(sc))
+plotter("plot_finalheat", y <- clustheatmap(sc,final=TRUE,hmethod="single"))
+
+
+message("Finished plots")
+
+message("Generating data tables")
+x <- data.frame( CELLID=names(sc@cpart), cluster=sc@cpart )
+write.table(
+    x[order(x$cluster,decreasing=FALSE),], output_table,
+    row.names=FALSE, col.names=TRUE, sep="\t", quote=FALSE
+)
+
+if (generate_final_rdata){
+    message("Saving SC object")
+    saveRDS(sc, output_rdat)
+}
+
+
+
+
+
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/scripts/raceID_tsne.R	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,47 @@
+##!/usr/bin/env Rscript
+
+args = commandArgs(trailingOnly=T)
+
+script_dir = args[1]
+config_file = args[2]
+
+                                        # Load libs, common functions, source RaceID,
+                                        # Galaxy Params, and read input data (sc)
+source(paste(script_dir, "common.R", sep="/"))
+
+                                        # Read input data
+message("Count matrix with %.0f cells and %.0f genes", dim(sc@fdata)[1], dim(sc@fdata)[2])
+
+sc <- comptsne(sc,rseed = c_rseed)
+
+message("Plotting initial and final tSNEs")
+
+plotter("plot_initial", plottsne(sc,final = F))
+plotter("plot_final", plottsne(sc,final = T))
+
+if (gene_sets != "" ){
+####all_sets <- strsplit(gene_sets, "+?\\s*__split__\\s*,?")
+    all_sets <- strsplit(gene_sets, '\\s*\\+?\\s*_split_\\s*,?')
+    print(all_sets)
+
+    for (given in all_sets){
+        given <- trimws(given)
+        message("Plotting %s", given)
+        g <- c(unlist(strsplit(given,'\\s*\\+\\s*')))
+        plotter(paste("plot", given, sep="_"), plotexptsne(sc,g, n=given, logsc=T))
+    }
+}
+
+
+if (regex_val != ""){
+    message("using subcell groups")
+    plotter("plot_labels", plotlabelstsne(sc, labels = sub(regex_val, "", names(sc@ndata))))
+    plotter("plot_symbols", plotsymbolstsne(sc, types = sub(regex_val, "", names(sc@ndata))))
+} else {
+    message("using all cell ids")
+    plotter("plot_labels", plotlabelstsne(sc, labels = names(sc@ndata)))
+    plotter("plot_symbols", plotsymbolstsne(sc, types = names(sc@ndata)))
+}
+
+message("Saving SC object")
+saveRDS(sc, output_rdat)
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/gdiff_cl.1.tsv	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,1 @@
+GENEID	mean.all	mean.cl	fc	pv
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/gdiff_cl.2.tsv	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,1 @@
+GENEID	mean.all	mean.cl	fc	pv
Binary file test-data/in_diffgene.rdat has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/out_1.html	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,4 @@
+ <html><head></head> <body> <h1>RaceID k-means</title></h1><br /> <h3>Gap statistic</h3> <img src="plot_gap.svg" ><br /> <h3>Jaccard Similarity</h3> <img src="plot_jaccard.svg" ><br /> <h3>Silhouette Plot</h3> <img src="plot_silhouette.svg" ><br /> <h3>Cluster Heatmap</h3> <img src="plot_clustheatmap.svg" ><br /> 
+ <br/> <h1>RaceID Outlier Detection</h1><br /> <h3>Background</h3> <img src="plot_background.svg" ><br /> <h3>Sensitivity</h3> <img src="plot_sensitivity.svg" ><br /> <h3>Outlier Probability</h3> <img src="plot_outlierprobs.svg" ><br /> <h3>Final Heatmap</h3> <img src="plot_finalheat.svg" ><br /> 
+ <br/> <h1>RaceID tSNE</h1><br /> <h3>Initial k-means clusters</h3> <br /><img src="plot_initial.svg" > <h3>Final clusters</h3> <br /><img src="plot_final.svg" > <h3>Labelled</h3> <br /><img src="plot_labels.svg" > <h3>Symbols</h3> <br /><img src="plot_symbols.svg" > 
+</body></html>
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/out_2.html	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,4 @@
+ <html><head></head> <body> <h1>RaceID k-means</title></h1><br /> <h3>Gap statistic</h3> <img src="plot_gap.svg" ><br /> <h3>Jaccard Similarity</h3> <img src="plot_jaccard.svg" ><br /> <h3>Silhouette Plot</h3> <img src="plot_silhouette.svg" ><br /> <h3>Cluster Heatmap</h3> <img src="plot_clustheatmap.svg" ><br /> 
+ <br/> <h1>RaceID Outlier Detection</h1><br /> <h3>Background</h3> <img src="plot_background.svg" ><br /> <h3>Sensitivity</h3> <img src="plot_sensitivity.svg" ><br /> <h3>Outlier Probability</h3> <img src="plot_outlierprobs.svg" ><br /> <h3>Final Heatmap</h3> <img src="plot_finalheat.svg" ><br /> 
+ <br/> <h1>RaceID tSNE</h1><br /> <h3>Initial k-means clusters</h3> <br /><img src="plot_initial.svg" > <h3>Final clusters</h3> <br /><img src="plot_final.svg" > <h3>Labelled</h3> <br /><img src="plot_labels.svg" > <h3>Symbols</h3> <br /><img src="plot_symbols.svg" > 
+</body></html>
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/out_3.html	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,8 @@
+ <html><head></head> <body> <h1>RaceID k-means</title></h1><br /> <h3>Gap statistic</h3> <img src="plot_gap.svg" ><br /> <h3>Jaccard Similarity</h3> <img src="plot_jaccard.svg" ><br /> <h3>Silhouette Plot</h3> <img src="plot_silhouette.svg" ><br /> <h3>Cluster Heatmap</h3> <img src="plot_clustheatmap.svg" ><br /> 
+ <br/> <h1>RaceID Outlier Detection</h1><br /> <h3>Background</h3> <img src="plot_background.svg" ><br /> <h3>Sensitivity</h3> <img src="plot_sensitivity.svg" ><br /> <h3>Outlier Probability</h3> <img src="plot_outlierprobs.svg" ><br /> <h3>Final Heatmap</h3> <img src="plot_finalheat.svg" ><br /> 
+ <br/> <h1>RaceID tSNE</h1><br /> <h3>Initial k-means clusters</h3> <br /><img src="plot_initial.svg" > <h3>Final clusters</h3> <br /><img src="plot_final.svg" > <h3>Labelled</h3> <br /><img src="plot_labels.svg" > <h3>Symbols</h3> <br /><img src="plot_symbols.svg" > 
+<h3>Expression for: [1110007C09Rik__chr13+1110037F02Rik__chr4+1300002K09Rik__chr4]</h3>
+<br /><img src="plot_1110007C09Rik__chr13+1110037F02Rik__chr4+1300002K09Rik__chr4" >
+<h3>Expression for: [0610010K14Rik__chr11+1500009L16Rik__chr10]</h3>
+<br /><img src="plot_0610010K14Rik__chr11+1500009L16Rik__chr10" >
+</body></html>
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/out_diffgene2.html	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,1 @@
+<html><head></head> <body> <h1>RaceID Differential Gene Analysis</h1> <br /><h3>Expression of 1110038F14Rik__chr15 between 1 and 2,3</h3> <img src="plot_diffgenes.svg" ><br /> </body> </html>
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/out_filter2.table	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,68 @@
+I_1	I_3	I_4	I_5	I_6	I_7	I_8	I_9	I_10	I_13	I_14	I_15	I_16	I_17	I_19	I_21	I_22	I_23	I_24	I_25	I_26	I_28	I_29	I_32	I_35	I_36	I_37	I_38	I_39	I_40	I_41	I_42	I_43	I_44	I_45	I_48	I_49	I_50	I_51	I_52	I_53	I_54	I_55	I_56	I_57	I_58	I_59	I_60	I_61	I_62	I_64	I_65	I_66	I_67	I_68	I_69	I_70	I_71	I_72	I_73	I_75	I_76	I_77	I_78	I_79	I_80	I_81	I_82	I_83	I_84	I_85	I_86	I_87	I_88	I_89	I_91	I_92	I_93	I_94	I_95	I_96	II_1	II_2	II_3	II_4	II_5	II_6	II_8	II_9	II_10	II_11	II_12	II_13	II_14	II_15	II_17	II_18	II_19	II_20	II_21	II_23	II_24	II_26	II_27	II_28	II_29	II_30	II_31	II_33	II_34	II_35	II_36	II_37	II_39	II_41	II_42	II_44	II_46	II_47	II_48	II_51	II_52	II_53	II_54	II_56	II_57	II_58	II_59	II_62	II_63	II_64	II_66	II_67	II_68	II_69	II_70	II_72	II_73	II_74	II_75	II_76	II_77	II_78	II_80	II_83	II_85	II_87	II_89	II_93	II_95	III_1	III_8	III_10	III_14	III_16	III_17
+0610005C13Rik__chr7	2.1	0.1	1.1	2.1	0.1	2.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	2.1	0.1	0.1	2.1	1.1	0.1	1.1	2.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	2.1	0.1	1.1	1.1	1.1	0.1	0.1	2.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	2.1	0.1	1.1	0.1	1.1	1.1	2.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	1.1	1.1	0.1	1.1	0.1	1.1	1.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	2.1	0.1	0.1	3.1	2.1	0.1	0.1	1.1	0.1	0.1	4.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	1.1	0.1	0.1	2.1	1.1	0.1	1.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	2.1	0.1	0.1	0.1	1.1	1.1	0.1
+0610007N19Rik__chr15	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+0610007P14Rik__chr12	1.1	0.1	2.1	1.1	0.1	1.1	1.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	2.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	2.1	2.1	1.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	2.1	1.1	1.1	1.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	1.1	0.1	1.1	0.1	0.1	1.1	1.1	0.1	2.1	2.1	0.1	0.1	0.1	1.1	1.1	1.1	1.1	0.1	0.1	1.1	1.1	1.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	1.1	3.1	1.1	2.1	1.1	2.1	0.1	0.1	0.1	0.1	1.1	0.1	2.1	2.1	0.1	0.1	1.1	1.1	0.1	1.1	1.1	0.1	0.1	0.1	1.1
+0610008F07Rik__chr2	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+0610009B14Rik__chr12	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+0610009B22Rik__chr11	1.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1
+0610009D07Rik__chr12	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	3.1	1.1	1.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	2.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	2.1	1.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	0.1	1.1	1.1	1.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	1.1	2.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	1.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1
+0610009L18Rik__chr11	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+0610009O20Rik__chr18	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+0610010B08Rik__chr2	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+0610010F05Rik__chr11	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+0610010K14Rik__chr11	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	3.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1
+0610011F06Rik__chr17	1.1	1.1	1.1	0.1	0.1	2.1	0.1	1.1	0.1	3.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	1.1	1.1	2.1	1.1	0.1	0.1	0.1	0.1	1.1	2.1	2.1	1.1	1.1	2.1	0.1	0.1	1.1	0.1	0.1	1.1	3.1	2.1	3.1	0.1	0.1	0.1	0.1	2.1	1.1	0.1	0.1	1.1	1.1	1.1	0.1	1.1	0.1	0.1	1.1	1.1	2.1	0.1	0.1	0.1	1.1	1.1	0.1	1.1	0.1	1.1	0.1	1.1	2.1	0.1	1.1	0.1	0.1	1.1	0.1	2.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	1.1	0.1	1.1	1.1	0.1	2.1	1.1	2.1	1.1	1.1	2.1	0.1	2.1	1.1	0.1	3.1	0.1	1.1	0.1	1.1	2.1	1.1	0.1	1.1	1.1	0.1	2.1	0.1	1.1	0.1	2.1	3.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	2.1	0.1	1.1	1.1	0.1	0.1	2.1	1.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	2.1	3.1	0.1	0.1
+0610012G03Rik__chr16	0.1	2.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	2.1	2.1	2.1	2.1	1.1	0.1	1.1	1.1	1.1	0.1	1.1	0.1	1.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	2.1	1.1	0.1	2.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	2.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	2.1	0.1	0.1	3.1	0.1	0.1	1.1	0.1	1.1	1.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	3.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	3.1	1.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	2.1	1.1	0.1	0.1	2.1	0.1	3.1	1.1	0.1	0.1	1.1	1.1	3.1	0.1	0.1	1.1	1.1	0.1	1.1	0.1	1.1	0.1
+0610030E20Rik__chr6	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1
+0610031J06Rik__chr3	0.1	0.1	1.1	0.1	0.1	0.1	1.1	1.1	0.1	1.1	1.1	1.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	2.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	2.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	2.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	1.1	2.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	1.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	2.1	1.1	0.1	0.1	1.1	2.1	1.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	2.1	1.1	2.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	1.1	0.1	1.1	0.1
+0610037L13Rik__chr4	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	1.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1
+0610040B10Rik__chr5	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+0610040J01Rik__chr5	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	1.1	1.1	1.1	0.1	0.1	2.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1
+1110001A16Rik__chr17	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110001J03Rik__chr6	0.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	0.1	1.1	1.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	3.1	1.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	2.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	2.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	2.1	0.1	0.1	1.1	1.1	1.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	2.1	1.1	1.1	1.1	1.1	1.1	0.1	1.1	0.1
+1110004E09Rik__chr16	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1
+1110004F10Rik__chr7	1.1	0.1	0.1	1.1	0.1	1.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	2.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	1.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	2.1	0.1	0.1	0.1	1.1	1.1	1.1	1.1	0.1	0.1	0.1	2.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110006O24Rik__chr5	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110007C09Rik__chr13	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	2.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110008F13Rik__chr2	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	2.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1
+1110008J03Rik__chr5	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110008L16Rik__chr12	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1
+1110008P14Rik__chr2	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	2.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	2.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	2.1	1.1	1.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1
+1110012L19Rik__chrX	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1
+1110018G07Rik__chr12	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110019D14Rik__chr6	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110020A21Rik__chr17	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110028F11Rik__chr11	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1
+1110032A03Rik__chr9	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110032F04Rik__chr3	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110034G24Rik__chr2	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1
+1110037F02Rik__chr4	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110038B12Rik__chr17	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	4.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	2.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	1.1	1.1	0.1	1.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	1.1	1.1	2.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	1.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110038F14Rik__chr15	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	2.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110046J04Rik__chr13	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110054M08Rik__chr16	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1
+1110057K04Rik__chr12	3.1	1.1	0.1	3.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	2.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	1.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	1.1	1.1	1.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1
+1110058L19Rik__chr1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	1.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1
+1110059E24Rik__chr19	0.1	0.1	0.1	0.1	1.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	2.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	2.1	0.1	1.1	0.1	1.1	1.1
+1110059G10Rik__chr9	0.1	1.1	0.1	1.1	0.1	2.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	2.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1
+1110065P20Rik__chr4	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	2.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1190002F15Rik__chr6	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1190002N15Rik__chr9	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1
+1190003J15Rik__chr7	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1190005I06Rik__chr8	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1190007I07Rik__chr10	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1
+1200011I18Rik__chr14	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1
+1200014J11Rik__chr11	0.1	1.1	1.1	0.1	1.1	0.1	3.1	0.1	1.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	3.1	1.1	3.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	1.1	1.1	0.1	0.1	0.1	2.1	1.1	0.1	1.1	0.1	1.1	1.1	1.1	0.1	0.1	1.1	0.1	2.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	2.1	1.1	0.1	2.1	0.1	1.1	2.1	1.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	3.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	1.1	1.1	2.1	0.1	1.1	1.1	0.1	1.1	0.1	0.1
+1300002E11Rik__chr16	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	2.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1
+1300002K09Rik__chr4	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1300018J18Rik__chr15	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1500009L16Rik__chr10	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1500011B03Rik__chr5	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1500011K16Rik__chr2	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	1.1	2.1	0.1	0.1	0.1	0.1	2.1	2.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1500012F01Rik__chr2	0.1	0.1	1.1	0.1	5.1	0.1	1.1	1.1	1.1	1.1	0.1	1.1	1.1	0.1	1.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	2.1	0.1	0.1	1.1	0.1	2.1	0.1	0.1	1.1	0.1	2.1	0.1	1.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	2.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	1.1	0.1	2.1	0.1	1.1	0.1	1.1	0.1	2.1	1.1	0.1	0.1	0.1	3.1	0.1	0.1	0.1	3.1	2.1	1.1	1.1	3.1	0.1	0.1	2.1	1.1	3.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	1.1	0.1	0.1	0.1	2.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	2.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	2.1	1.1	2.1	1.1	1.1	1.1	2.1	0.1	1.1	0.1	2.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	1.1	0.1	0.1	1.1	1.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	2.1
+1500012K07Rik__chr7	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1500015A07Rik__chr18	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1600002H07Rik__chr17	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1600002K03Rik__chr10	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1600012H06Rik__chr17	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1
+1600014C10Rik__chr7	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	1.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	1.1	1.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	1.1	0.1	0.1	0.1	1.1	2.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	1.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/out_filter3.table	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,57 @@
+I_1	I_3	I_4	I_5	I_6	I_7	I_8	I_9	I_10	I_13	I_14	I_15	I_16	I_17	I_19	I_21	I_22	I_23	I_24	I_25	I_26	I_28	I_29	I_32	I_35	I_36	I_37	I_38	I_39	I_40	I_41	I_42	I_43	I_44	I_45	I_48	I_49	I_50	I_51	I_52	I_53	I_54	I_55	I_56	I_57	I_58	I_59	I_60	I_61	I_62	I_64	I_65	I_66	I_67	I_68	I_69	I_70	I_71	I_72	I_73	I_75	I_76	I_77	I_78	I_79	I_80	I_81	I_82	I_83	I_84	I_85	I_86	I_87	I_88	I_89	I_91	I_92	I_93	I_94	I_95	I_96	II_1	II_2	II_3	II_4	II_5	II_6	II_8	II_9	II_10	II_11	II_12	II_13	II_14	II_15	II_17	II_18	II_19	II_20	II_21	II_23	II_24	II_26	II_27	II_28	II_29	II_30	II_31	II_33	II_34	II_35	II_36	II_37	II_39	II_41	II_42	II_44	II_46	II_47	II_48	II_51	II_52	II_53	II_54	II_56	II_57	II_58	II_59	II_62	II_63	II_64	II_66	II_67	II_68	II_69	II_70	II_72	II_73	II_74	II_75	II_76	II_77	II_78	II_80	II_83	II_85	II_87	II_89	II_93	II_95	III_1	III_8	III_10	III_14	III_16	III_17
+0610005C13Rik__chr7	2.1	0.1	1.43333333333333	2.1	0.433333333333333	1.43333333333333	0.1	0.433333333333333	0.1	0.433333333333333	0.1	1.1	0.1	1.1	0.1	0.1	0.433333333333333	1.76666666666667	0.1	0.1	1.43333333333333	0.766666666666667	0.1	0.766666666666667	0.766666666666667	0.766666666666667	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.766666666666667	0.1	0.433333333333333	1.1	0.766666666666667	1.43333333333333	0.1	1.76666666666667	0.1	1.1	1.1	0.766666666666667	0.1	0.1	1.43333333333333	1.1	0.1	0.1	1.43333333333333	0.1	0.1	0.1	1.1	1.43333333333333	0.1	1.76666666666667	0.1	1.76666666666667	0.766666666666667	1.43333333333333	0.1	0.433333333333333	0.1	1.1	1.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	1.1	0.766666666666667	1.43333333333333	0.1	0.766666666666667	1.1	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.766666666666667	0.1	0.1	0.1	0.1	1.43333333333333	0.1	1.1	0.433333333333333	0.1	1.76666666666667	0.1	0.1	3.1	1.43333333333333	0.1	0.1	1.1	0.766666666666667	0.1	4.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.433333333333333	0.1	0.433333333333333	0.1	0.766666666666667	0.433333333333333	0.433333333333333	0.766666666666667	0.1	0.1	1.76666666666667	1.1	0.1	0.766666666666667	0.1	0.1	0.1	0.766666666666667	1.76666666666667	0.1	0.433333333333333	1.1	0.1	1.76666666666667	0.1	0.1	0.1	1.1	0.766666666666667	0.1
+0610007N19Rik__chr15	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+0610007P14Rik__chr12	1.1	0.766666666666667	1.1	1.1	0.1	0.433333333333333	0.766666666666667	0.766666666666667	0.433333333333333	0.433333333333333	0.766666666666667	1.76666666666667	0.433333333333333	0.1	0.433333333333333	0.766666666666667	0.1	1.43333333333333	0.433333333333333	0.433333333333333	0.1	1.76666666666667	0.1	0.1	0.766666666666667	1.43333333333333	0.1	0.1	0.433333333333333	0.766666666666667	1.76666666666667	2.1	0.433333333333333	1.43333333333333	0.1	0.1	0.433333333333333	1.43333333333333	0.1	1.1	0.1	0.433333333333333	0.766666666666667	1.1	0.433333333333333	0.1	0.1	0.766666666666667	1.1	1.1	0.433333333333333	0.766666666666667	0.1	0.1	1.1	0.766666666666667	0.1	0.766666666666667	1.1	0.1	0.433333333333333	0.766666666666667	0.433333333333333	0.1	0.766666666666667	0.433333333333333	1.43333333333333	0.766666666666667	0.433333333333333	0.433333333333333	0.766666666666667	1.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.766666666666667	0.1	0.766666666666667	1.1	0.433333333333333	0.1	0.1	1.76666666666667	0.433333333333333	0.1	0.766666666666667	0.1	0.1	1.1	1.43333333333333	0.1	1.1	1.1	0.1	0.433333333333333	0.1	0.766666666666667	0.766666666666667	1.1	0.766666666666667	0.1	0.1	1.1	1.1	1.1	0.766666666666667	1.43333333333333	1.1	0.1	0.433333333333333	0.433333333333333	0.1	1.76666666666667	0.1	0.766666666666667	0.1	0.766666666666667	0.1	0.1	0.1	1.1	1.1	0.433333333333333	0.766666666666667	1.1	0.433333333333333	1.1	1.43333333333333	1.76666666666667	1.43333333333333	1.76666666666667	0.766666666666667	0.1	0.1	0.1	0.433333333333333	1.43333333333333	0.433333333333333	1.43333333333333	2.1	0.1	0.433333333333333	1.1	1.43333333333333	0.1	0.766666666666667	0.766666666666667	0.1	0.1	0.433333333333333	0.766666666666667
+0610009B14Rik__chr12	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+0610009B22Rik__chr11	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.433333333333333	0.433333333333333	0.433333333333333	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	1.1	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.433333333333333	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	1.1	0.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.766666666666667	0.766666666666667	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.766666666666667	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	1.1	0.1	0.433333333333333	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1
+0610009D07Rik__chr12	0.1	0.1	0.1	1.1	0.1	0.1	0.766666666666667	0.1	1.76666666666667	0.766666666666667	0.766666666666667	0.1	0.433333333333333	0.1	0.433333333333333	0.433333333333333	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	1.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	1.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.766666666666667	0.1	0.433333333333333	1.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	1.1	0.433333333333333	0.1	0.433333333333333	0.1	1.1	0.433333333333333	0.1	0.766666666666667	1.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.766666666666667	1.1	0.1	0.1	0.766666666666667	1.43333333333333	1.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.433333333333333	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.766666666666667	1.1	0.766666666666667	1.1	0.1	1.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	2.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	1.43333333333333	0.1	1.1	0.1	0.1
+0610009L18Rik__chr11	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	1.76666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+0610009O20Rik__chr18	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+0610010K14Rik__chr11	0.1	0.1	0.1	0.1	0.766666666666667	0.1	1.43333333333333	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.433333333333333	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	1.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	1.1	0.433333333333333	0.433333333333333	0.433333333333333	0.1	0.1	0.766666666666667	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.766666666666667	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.766666666666667	1.76666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	1.1
+0610011F06Rik__chr17	1.1	1.43333333333333	0.766666666666667	0.1	0.1	1.76666666666667	1.1	0.433333333333333	0.433333333333333	1.76666666666667	0.1	0.433333333333333	1.1	0.1	0.766666666666667	0.433333333333333	0.433333333333333	0.1	0.1	0.766666666666667	1.43333333333333	1.1	0.1	0.1	0.766666666666667	0.433333333333333	0.433333333333333	0.433333333333333	0.1	0.766666666666667	2.76666666666667	0.766666666666667	1.1	2.76666666666667	1.1	0.1	0.766666666666667	0.433333333333333	0.1	0.766666666666667	1.76666666666667	2.1	1.43333333333333	1.1	1.43333333333333	0.1	0.1	1.1	0.1	0.433333333333333	0.766666666666667	1.43333333333333	2.1	1.1	0.1	0.1	0.1	0.1	1.76666666666667	0.766666666666667	0.1	0.1	0.766666666666667	1.1	0.766666666666667	0.766666666666667	2.76666666666667	0.433333333333333	0.433333333333333	0.433333333333333	0.766666666666667	2.1	0.766666666666667	0.433333333333333	0.1	0.433333333333333	1.1	0.1	1.1	0.1	1.1	0.1	0.433333333333333	1.76666666666667	0.766666666666667	0.766666666666667	0.766666666666667	0.1	0.766666666666667	0.1	2.1	0.1	0.1	0.1	0.766666666666667	0.1	1.43333333333333	0.433333333333333	0.433333333333333	0.1	0.766666666666667	0.766666666666667	0.766666666666667	2.43333333333333	0.766666666666667	2.1	0.766666666666667	1.43333333333333	1.1	0.1	2.1	1.43333333333333	0.1	2.1	0.1	0.433333333333333	0.1	1.1	2.1	0.766666666666667	0.1	0.433333333333333	0.766666666666667	0.433333333333333	1.43333333333333	0.1	2.1	0.1	1.76666666666667	2.43333333333333	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.433333333333333	0.766666666666667	1.43333333333333	0.1	2.1	0.433333333333333	0.433333333333333	0.1	1.43333333333333	0.766666666666667	0.1	0.1	0.766666666666667	0.1	0.766666666666667	0.766666666666667	0.1	2.1	2.76666666666667	0.766666666666667	0.1
+0610012G03Rik__chr16	0.1	1.43333333333333	0.433333333333333	0.1	0.1	1.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	1.76666666666667	0.1	0.766666666666667	0.766666666666667	0.1	0.1	0.766666666666667	0.1	1.43333333333333	0.433333333333333	0.1	0.1	0.1	1.43333333333333	1.1	1.43333333333333	1.1	1.43333333333333	1.1	1.1	1.43333333333333	0.766666666666667	0.1	1.1	0.766666666666667	0.766666666666667	0.433333333333333	0.1	0.1	0.766666666666667	1.1	0.1	0.1	0.1	1.43333333333333	0.766666666666667	0.1	1.43333333333333	0.766666666666667	1.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.766666666666667	0.433333333333333	1.1	0.433333333333333	0.433333333333333	0.433333333333333	1.43333333333333	1.1	0.433333333333333	0.1	0.766666666666667	0.433333333333333	0.766666666666667	0.1	1.1	0.433333333333333	0.766666666666667	0.433333333333333	0.1	1.76666666666667	0.1	0.1	1.76666666666667	1.43333333333333	0.433333333333333	1.43333333333333	0.766666666666667	0.433333333333333	1.1	0.1	0.433333333333333	0.766666666666667	0.766666666666667	1.43333333333333	0.1	0.433333333333333	0.1	0.1	0.433333333333333	2.76666666666667	0.433333333333333	0.1	1.1	0.433333333333333	0.766666666666667	0.433333333333333	0.766666666666667	1.1	0.1	1.1	0.1	3.1	1.1	1.1	0.1	1.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	1.43333333333333	1.43333333333333	0.433333333333333	1.1	0.433333333333333	0.1	0.1	0.433333333333333	1.43333333333333	0.433333333333333	0.1	2.1	0.766666666666667	0.433333333333333	0.433333333333333	2.76666666666667	0.433333333333333	3.1	1.1	0.1	0.766666666666667	1.1	1.1	2.1	0.766666666666667	0.433333333333333	1.43333333333333	1.1	0.1	1.1	0.1	1.1	0.1
+0610030E20Rik__chr6	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	1.1	0.766666666666667	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	1.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	1.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	1.1	0.1	0.1	0.1	0.1
+0610031J06Rik__chr3	0.1	0.766666666666667	0.766666666666667	0.1	0.1	0.433333333333333	0.766666666666667	0.766666666666667	0.1	0.766666666666667	0.766666666666667	0.766666666666667	0.433333333333333	0.766666666666667	0.1	0.766666666666667	0.1	1.43333333333333	0.1	0.1	0.1	1.76666666666667	0.766666666666667	0.766666666666667	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.766666666666667	1.1	0.1	0.766666666666667	0.1	1.1	1.1	1.1	0.433333333333333	0.1	0.1	0.1	1.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.1	1.43333333333333	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	1.1	0.433333333333333	0.1	0.433333333333333	1.1	0.1	0.433333333333333	0.1	0.433333333333333	1.1	0.433333333333333	0.1	1.43333333333333	0.1	0.433333333333333	0.1	1.1	0.433333333333333	0.1	0.433333333333333	0.1	1.1	0.766666666666667	0.766666666666667	0.433333333333333	1.1	0.433333333333333	0.1	0.433333333333333	0.1	1.76666666666667	0.1	0.1	0.766666666666667	0.766666666666667	0.433333333333333	0.1	0.766666666666667	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.1	1.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	1.43333333333333	0.433333333333333	0.1	0.1	1.76666666666667	0.766666666666667	0.433333333333333	0.766666666666667	1.43333333333333	1.76666666666667	1.1	0.1	0.1	0.1	0.433333333333333	1.43333333333333	0.433333333333333	1.1	0.1	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	1.1	0.1	0.433333333333333	0.1	1.1	0.1	1.76666666666667	1.1	2.1	0.433333333333333	0.1	0.766666666666667	1.1	0.1	1.1	1.1	0.1	1.1	0.1	0.1	0.766666666666667	0.1	1.1	0.1
+0610037L13Rik__chr4	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	1.76666666666667	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	1.43333333333333	0.1	1.1	0.433333333333333	0.1	1.43333333333333	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.766666666666667	1.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.766666666666667	0.1
+0610040B10Rik__chr5	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+0610040J01Rik__chr5	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	1.1	0.1	0.1	0.433333333333333	0.1	0.1	1.1	0.1	1.43333333333333	0.1	0.766666666666667	0.766666666666667	1.1	0.1	0.1	1.43333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.433333333333333	0.1	0.766666666666667	0.1	1.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	1.76666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.766666666666667	0.766666666666667	0.1	0.1	1.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.766666666666667	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	1.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.766666666666667	1.43333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	1.1	0.1	0.1
+1110001A16Rik__chr17	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	1.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.76666666666667	0.1	1.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.1	0.1	0.766666666666667	1.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	1.43333333333333	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1
+1110001J03Rik__chr6	0.1	1.43333333333333	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.433333333333333	1.1	0.433333333333333	0.1	0.1	0.1	0.1	0.766666666666667	1.1	1.1	0.1	0.766666666666667	0.766666666666667	0.766666666666667	0.1	0.766666666666667	0.766666666666667	1.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.433333333333333	1.43333333333333	0.1	0.1	0.1	1.1	1.1	0.433333333333333	0.1	1.1	2.76666666666667	0.433333333333333	0.433333333333333	0.1	0.766666666666667	0.766666666666667	0.1	1.1	0.766666666666667	0.1	0.433333333333333	0.1	0.433333333333333	0.433333333333333	0.1	0.766666666666667	0.766666666666667	1.1	0.766666666666667	1.1	0.433333333333333	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	1.43333333333333	1.1	0.1	1.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.433333333333333	2.1	0.1	0.1	1.1	1.1	0.766666666666667	0.433333333333333	1.1	0.1	0.1	0.766666666666667	0.433333333333333	0.433333333333333	0.1	0.1	1.1	1.1	0.1	0.1	1.43333333333333	1.1	0.766666666666667	0.1	0.766666666666667	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	1.1	0.433333333333333	1.43333333333333	0.1	0.433333333333333	0.433333333333333	1.76666666666667	0.433333333333333	0.1	0.433333333333333	0.766666666666667	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.766666666666667	1.1	0.1	0.1	0.1	0.1	1.43333333333333	1.1	1.1	1.43333333333333	0.766666666666667	0.766666666666667	0.1	0.766666666666667	0.1
+1110004E09Rik__chr16	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	1.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.766666666666667	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	1.43333333333333	0.1	0.1	0.1	0.1	0.1
+1110004F10Rik__chr7	1.1	0.1	0.1	1.1	1.1	0.766666666666667	0.1	0.766666666666667	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	1.1	0.433333333333333	2.43333333333333	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.766666666666667	0.1	0.433333333333333	0.766666666666667	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	1.1	0.1	0.1	0.433333333333333	1.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.433333333333333	0.433333333333333	1.1	0.433333333333333	0.1	0.433333333333333	0.433333333333333	0.1	1.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.433333333333333	1.1	0.1	1.1	0.1	0.1	1.1	0.1	0.433333333333333	0.433333333333333	0.1	1.43333333333333	0.433333333333333	0.1	0.1	1.1	0.766666666666667	0.433333333333333	0.766666666666667	1.1	0.1	0.1	1.76666666666667	0.766666666666667	0.1	1.1	0.1	1.1	0.433333333333333	0.1	1.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	1.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	1.1	0.766666666666667	0.1	0.433333333333333	0.766666666666667	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1
+1110006O24Rik__chr5	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110007C09Rik__chr13	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	1.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	1.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	1.76666666666667	0.1	0.433333333333333	0.1	0.1	0.433333333333333	1.43333333333333	0.1	0.1	0.1	1.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1
+1110008F13Rik__chr2	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	1.1	0.1	1.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.766666666666667	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.766666666666667	0.1	1.43333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.766666666666667	0.766666666666667	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	1.76666666666667
+1110008L16Rik__chr12	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	1.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.433333333333333	0.1	1.43333333333333	0.1	0.766666666666667	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	1.1	0.433333333333333	0.766666666666667	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	1.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	2.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	1.1	0.1	0.1	0.1	0.1	1.1
+1110008P14Rik__chr2	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	2.1	0.1	0.1	0.766666666666667	0.1	1.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.766666666666667	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	1.76666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	1.1	0.1	0.1	1.1	0.1	1.1	0.1	0.433333333333333	0.1	0.433333333333333	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.76666666666667	0.433333333333333	0.1	0.766666666666667	0.1	1.43333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	1.76666666666667	2.1	0.433333333333333	0.766666666666667	0.433333333333333	0.433333333333333	0.1	0.1	0.766666666666667	0.766666666666667	1.1	0.433333333333333	2.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.433333333333333	0.766666666666667	0.1	0.1	0.1
+1110012L19Rik__chrX	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.766666666666667	0.1	0.1	0.766666666666667	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	1.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1
+1110018G07Rik__chr12	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	1.76666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	1.1	0.433333333333333	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110019D14Rik__chr6	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110020A21Rik__chr17	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110032A03Rik__chr9	0.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1
+1110034G24Rik__chr2	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1
+1110037F02Rik__chr4	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110038B12Rik__chr17	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	1.76666666666667	0.1	1.1	3.1	0.1	0.1	0.766666666666667	1.43333333333333	1.76666666666667	0.1	0.1	0.1	0.1	1.1	1.1	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	1.43333333333333	0.1	0.1	0.1	0.1	1.76666666666667	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	1.43333333333333	0.1	0.766666666666667	0.433333333333333	0.1	1.43333333333333	0.766666666666667	0.1	1.1	0.766666666666667	0.1	0.1	1.1	1.76666666666667	0.1	0.1	0.1	0.766666666666667	0.1	0.1	1.1	0.1	0.766666666666667	0.1	0.766666666666667	0.433333333333333	0.766666666666667	0.1	1.1	0.766666666666667	1.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	1.1	0.433333333333333	0.1	0.433333333333333	0.1	0.766666666666667	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1
+1110038F14Rik__chr15	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.766666666666667	0.766666666666667	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.1	2.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1110054M08Rik__chr16	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	1.76666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667
+1110057K04Rik__chr12	3.1	0.766666666666667	0.433333333333333	3.1	0.1	0.433333333333333	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	1.1	0.1	0.1	0.766666666666667	0.1	0.1	1.1	0.1	0.1	0.1	1.1	0.766666666666667	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.1	1.1	0.1	0.433333333333333	0.766666666666667	0.1	1.1	0.433333333333333	0.433333333333333	0.1	0.766666666666667	0.433333333333333	0.1	0.433333333333333	0.433333333333333	1.43333333333333	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.766666666666667	0.1	0.766666666666667	2.43333333333333	0.433333333333333	0.433333333333333	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.433333333333333	1.1	0.1	0.1	1.1	0.1	0.433333333333333	0.1	0.1	0.1	1.1	0.766666666666667	0.1	0.766666666666667	0.433333333333333	0.433333333333333	0.1	1.1	0.1	0.1	0.1	0.433333333333333	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.433333333333333	0.1	0.433333333333333	1.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	1.1	0.1
+1110058L19Rik__chr1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	1.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	1.1	0.1	0.433333333333333	0.766666666666667	0.1	1.1	1.43333333333333	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	2.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	1.1	0.1
+1110059E24Rik__chr19	0.1	0.1	1.1	0.1	0.766666666666667	0.1	0.433333333333333	1.43333333333333	0.1	0.1	0.1	0.1	1.43333333333333	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	1.1	1.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.766666666666667	0.1	0.766666666666667	0.433333333333333	0.1	1.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.433333333333333	1.43333333333333	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	1.1	1.76666666666667	0.1	1.1	0.1	1.1	1.1
+1110059G10Rik__chr9	0.1	0.766666666666667	0.766666666666667	1.1	0.1	1.43333333333333	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	1.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	1.1	0.766666666666667	1.43333333333333	0.1	1.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.433333333333333	0.1	0.1	1.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.766666666666667	0.433333333333333	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.76666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	1.1	0.1	0.1	0.1	1.43333333333333	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.433333333333333	0.1	0.1	0.433333333333333	0.1	1.1	0.1	0.1
+1110065P20Rik__chr4	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	1.43333333333333	0.1	1.1	1.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1190002F15Rik__chr6	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1190002N15Rik__chr9	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.1	0.433333333333333	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	1.43333333333333	0.1	0.1	0.433333333333333	0.766666666666667	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.43333333333333	1.1	0.1	0.1
+1190003J15Rik__chr7	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.433333333333333	0.1	0.433333333333333	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1190007I07Rik__chr10	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.433333333333333	0.1	1.43333333333333	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	1.43333333333333	0.1	1.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	1.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	1.43333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	1.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.766666666666667
+1200011I18Rik__chr14	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.1	0.1	1.76666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	2.1	0.1
+1200014J11Rik__chr11	0.766666666666667	0.433333333333333	0.433333333333333	0.1	1.1	0.1	1.1	0.1	0.433333333333333	0.1	1.1	1.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	1.1	0.433333333333333	2.76666666666667	1.1	2.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.766666666666667	1.1	0.1	0.1	0.433333333333333	1.43333333333333	0.433333333333333	0.766666666666667	1.1	0.766666666666667	1.1	0.433333333333333	0.766666666666667	0.1	2.1	0.766666666666667	0.1	0.433333333333333	0.433333333333333	1.1	0.766666666666667	0.766666666666667	0.1	0.1	0.766666666666667	0.1	1.43333333333333	0.1	1.1	0.1	0.433333333333333	0.1	0.1	0.1	2.1	1.1	0.433333333333333	1.1	0.1	0.766666666666667	1.1	1.43333333333333	0.766666666666667	0.433333333333333	1.1	0.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.1	0.766666666666667	0.766666666666667	0.433333333333333	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.433333333333333	1.1	0.766666666666667	0.766666666666667	0.1	0.1	1.1	0.1	1.1	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	1.43333333333333	0.433333333333333	0.1	1.76666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	1.1	0.433333333333333	0.433333333333333	0.1	1.76666666666667	0.766666666666667	1.1	1.43333333333333	0.1	0.433333333333333	1.43333333333333	0.1	0.766666666666667	0.1	0.1
+1300002E11Rik__chr16	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	1.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.1	1.43333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1
+1300002K09Rik__chr4	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1500011B03Rik__chr5	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.76666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1500011K16Rik__chr2	0.1	0.433333333333333	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	1.1	0.1	0.1	0.433333333333333	0.433333333333333	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	2.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	1.43333333333333	0.1	0.1	0.1	0.1	1.43333333333333	2.1	0.1	0.1	0.433333333333333	0.433333333333333	0.1	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.766666666666667	0.766666666666667	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	1.43333333333333	1.1	0.766666666666667	0.766666666666667	0.1	1.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.1	0.1	1.1	0.1	1.43333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.433333333333333	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1500012F01Rik__chr2	0.1	0.1	0.766666666666667	0.1	3.43333333333333	0.1	1.1	0.433333333333333	0.766666666666667	1.43333333333333	0.1	1.1	1.1	0.1	1.43333333333333	0.433333333333333	0.1	0.433333333333333	1.1	0.433333333333333	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.433333333333333	1.43333333333333	0.1	0.433333333333333	0.766666666666667	0.1	1.76666666666667	0.1	0.1	1.1	0.1	2.1	0.1	1.43333333333333	0.766666666666667	0.1	0.1	2.1	1.1	0.766666666666667	0.1	2.76666666666667	1.1	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.433333333333333	1.1	0.766666666666667	0.1	1.43333333333333	0.766666666666667	1.1	0.1	0.766666666666667	0.433333333333333	1.43333333333333	1.1	0.1	0.1	0.433333333333333	3.1	0.433333333333333	0.1	0.1	2.43333333333333	1.43333333333333	0.766666666666667	1.1	1.43333333333333	0.1	0.433333333333333	2.1	0.766666666666667	2.1	0.1	0.1	0.433333333333333	0.766666666666667	1.1	1.43333333333333	0.1	1.1	0.1	0.1	0.1	1.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	2.1	0.766666666666667	0.1	0.1	0.1	1.76666666666667	0.766666666666667	0.1	0.433333333333333	0.766666666666667	1.1	0.1	2.1	1.1	1.76666666666667	1.1	0.766666666666667	0.433333333333333	1.1	0.1	1.1	0.1	1.43333333333333	0.766666666666667	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.433333333333333	2.76666666666667	0.766666666666667	0.1	0.1	0.766666666666667	1.1	0.1	0.1	1.1	0.1	0.766666666666667	0.1	0.1	0.1	1.43333333333333	0.766666666666667	0.1	0.1	2.1
+1500015A07Rik__chr18	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1600002H07Rik__chr17	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1600002K03Rik__chr10	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.433333333333333	0.1	0.766666666666667	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1
+1600012H06Rik__chr17	0.1	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.766666666666667	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.766666666666667	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1
+1600014C10Rik__chr7	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.433333333333333	0.1	0.433333333333333	0.433333333333333	0.1	0.433333333333333	0.433333333333333	0.433333333333333	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.1	0.1	0.1	1.1	0.1	0.1	1.43333333333333	0.1	0.1	0.766666666666667	0.766666666666667	0.766666666666667	0.766666666666667	1.76666666666667	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.433333333333333	0.433333333333333	1.1	1.1	0.1	0.1	1.1	2.1	0.1	0.1	1.1	0.1	0.1	1.1	0.766666666666667	0.1	0.1	0.1	0.1	1.43333333333333	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.433333333333333	1.1	0.433333333333333	0.1	0.433333333333333	0.1	0.1	1.43333333333333	0.766666666666667	0.1	0.1	0.433333333333333	0.433333333333333	0.1	0.1	0.433333333333333	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.1	0.1	1.1	0.1	0.1	0.1	0.1	0.766666666666667	0.1	0.1	0.766666666666667	0.1	0.1	0.1	0.1	0.1	0.433333333333333	1.1	0.433333333333333	0.1	0.1	0.1	0.433333333333333	0.766666666666667	0.1	0.433333333333333	0.1	0.1	0.433333333333333	0.1	1.43333333333333	0.1	0.766666666666667	0.1	0.766666666666667	0.1	1.1	0.1	0.1	0.1	0.1	0.766666666666667	0.766666666666667	1.1	0.1	0.1	0.1	0.1	0.1
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/out_outlier1.table	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,157 @@
+CELLID	cluster
+I_1	1
+I_3	1
+I_4	1
+I_5	1
+I_7	1
+I_9	1
+I_13	1
+I_14	1
+I_15	1
+I_16	1
+I_17	1
+I_23	1
+I_26	1
+I_28	1
+I_32	1
+I_35	1
+I_36	1
+I_39	1
+I_40	1
+I_41	1
+I_42	1
+I_44	1
+I_45	1
+I_49	1
+I_51	1
+I_52	1
+I_53	1
+I_54	1
+I_55	1
+I_57	1
+I_58	1
+I_59	1
+I_62	1
+I_64	1
+I_65	1
+I_66	1
+I_67	1
+I_68	1
+I_70	1
+I_72	1
+I_73	1
+I_77	1
+I_79	1
+I_80	1
+I_81	1
+I_83	1
+I_85	1
+I_86	1
+I_88	1
+I_91	1
+I_92	1
+I_93	1
+I_96	1
+II_3	1
+II_4	1
+II_9	1
+II_11	1
+II_15	1
+II_18	1
+II_19	1
+II_20	1
+II_23	1
+II_24	1
+II_27	1
+II_28	1
+II_29	1
+II_30	1
+II_33	1
+II_34	1
+II_35	1
+II_36	1
+II_39	1
+II_41	1
+II_42	1
+II_44	1
+II_46	1
+II_47	1
+II_56	1
+II_58	1
+II_62	1
+II_63	1
+II_66	1
+II_67	1
+II_68	1
+II_69	1
+II_70	1
+II_72	1
+II_73	1
+II_75	1
+II_76	1
+II_80	1
+II_83	1
+II_87	1
+II_89	1
+II_95	1
+III_1	1
+III_10	1
+III_14	1
+III_16	1
+I_6	2
+I_8	2
+I_10	2
+I_19	2
+I_21	2
+I_22	2
+I_24	2
+I_25	2
+I_29	2
+I_37	2
+I_38	2
+I_43	2
+I_48	2
+I_50	2
+I_56	2
+I_60	2
+I_61	2
+I_69	2
+I_71	2
+I_75	2
+I_76	2
+I_78	2
+I_82	2
+I_84	2
+I_87	2
+I_89	2
+I_94	2
+I_95	2
+II_1	2
+II_2	2
+II_5	2
+II_6	2
+II_8	2
+II_10	2
+II_12	2
+II_13	2
+II_14	2
+II_17	2
+II_21	2
+II_26	2
+II_31	2
+II_37	2
+II_48	2
+II_51	2
+II_52	2
+II_53	2
+II_54	2
+II_57	2
+II_59	2
+II_64	2
+II_74	2
+II_77	2
+II_78	2
+II_85	2
+II_93	2
+III_8	2
+III_17	2
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/out_outlier2.table	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,157 @@
+CELLID	cluster
+I_3	1
+I_4	1
+I_15	1
+I_23	1
+I_28	1
+I_35	1
+I_36	1
+I_39	1
+I_49	1
+I_58	1
+I_59	1
+I_62	1
+I_77	1
+I_79	1
+I_80	1
+I_83	1
+I_87	1
+I_93	1
+I_96	1
+II_10	1
+II_19	1
+II_23	1
+II_34	1
+II_36	1
+II_44	1
+II_67	1
+II_69	1
+II_72	1
+II_76	1
+II_83	1
+II_87	1
+II_89	1
+II_95	1
+III_16	1
+I_7	2
+I_9	2
+I_13	2
+I_16	2
+I_41	2
+I_42	2
+I_44	2
+I_53	2
+I_54	2
+I_57	2
+I_64	2
+I_65	2
+I_66	2
+I_67	2
+I_72	2
+I_81	2
+I_85	2
+I_86	2
+II_3	2
+II_9	2
+II_11	2
+II_15	2
+II_18	2
+II_27	2
+II_29	2
+II_33	2
+II_35	2
+II_39	2
+II_42	2
+II_46	2
+II_47	2
+II_56	2
+II_58	2
+II_62	2
+II_63	2
+II_66	2
+II_70	2
+II_73	2
+II_80	2
+III_1	2
+III_10	2
+III_14	2
+I_1	3
+I_5	3
+I_14	3
+I_17	3
+I_22	3
+I_26	3
+I_32	3
+I_40	3
+I_45	3
+I_48	3
+I_51	3
+I_52	3
+I_55	3
+I_68	3
+I_69	3
+I_70	3
+I_71	3
+I_73	3
+I_76	3
+I_88	3
+I_91	3
+I_92	3
+II_1	3
+II_4	3
+II_20	3
+II_24	3
+II_28	3
+II_30	3
+II_41	3
+II_68	3
+II_75	3
+II_93	3
+I_6	4
+I_8	4
+I_10	4
+I_19	4
+I_21	4
+I_24	4
+I_25	4
+I_29	4
+I_37	4
+I_38	4
+I_43	4
+I_50	4
+I_56	4
+I_60	4
+I_61	4
+I_75	4
+I_78	4
+I_82	4
+I_84	4
+I_89	4
+I_94	4
+I_95	4
+II_2	4
+II_5	4
+II_6	4
+II_8	4
+II_12	4
+II_13	4
+II_14	4
+II_17	4
+II_21	4
+II_26	4
+II_31	4
+II_37	4
+II_48	4
+II_51	4
+II_52	4
+II_53	4
+II_54	4
+II_57	4
+II_59	4
+II_64	4
+II_74	4
+II_77	4
+II_78	4
+II_85	4
+III_8	4
+III_17	4
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/out_outlier3.table	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,157 @@
+CELLID	cluster
+I_1	1
+I_5	1
+I_45	1
+I_51	1
+I_66	1
+I_70	1
+I_72	1
+I_76	1
+I_86	1
+I_92	1
+II_9	1
+II_24	1
+II_35	1
+II_47	1
+II_62	1
+II_75	1
+III_14	1
+I_13	2
+I_26	2
+I_41	2
+I_43	2
+I_44	2
+I_55	2
+I_81	2
+II_3	2
+II_11	2
+II_18	2
+II_27	2
+II_31	2
+II_36	2
+II_46	2
+II_57	2
+II_58	2
+II_63	2
+II_70	2
+II_73	2
+II_80	2
+II_93	2
+III_10	2
+I_22	3
+I_37	3
+I_48	3
+I_69	3
+I_77	3
+I_91	3
+II_10	3
+II_20	3
+II_30	3
+II_41	3
+II_54	3
+II_76	3
+II_87	3
+I_6	4
+I_24	4
+I_38	4
+I_50	4
+I_56	4
+I_57	4
+I_60	4
+I_82	4
+I_84	4
+I_89	4
+I_94	4
+II_2	4
+II_8	4
+II_17	4
+II_21	4
+II_37	4
+II_48	4
+II_51	4
+II_52	4
+II_68	4
+II_78	4
+III_8	4
+III_17	4
+I_8	5
+I_9	5
+I_10	5
+I_14	5
+I_16	5
+I_19	5
+I_21	5
+I_25	5
+I_52	5
+I_61	5
+I_64	5
+I_65	5
+I_71	5
+I_73	5
+I_78	5
+I_85	5
+I_95	5
+II_5	5
+II_6	5
+II_12	5
+II_13	5
+II_14	5
+II_15	5
+II_26	5
+II_33	5
+II_53	5
+II_59	5
+II_64	5
+II_74	5
+II_77	5
+II_85	5
+I_3	6
+I_4	6
+I_7	6
+I_15	6
+I_17	6
+I_23	6
+I_28	6
+I_29	6
+I_32	6
+I_35	6
+I_36	6
+I_39	6
+I_40	6
+I_42	6
+I_49	6
+I_53	6
+I_54	6
+I_58	6
+I_59	6
+I_62	6
+I_67	6
+I_68	6
+I_75	6
+I_79	6
+I_80	6
+I_83	6
+I_87	6
+I_88	6
+I_93	6
+I_96	6
+II_1	6
+II_4	6
+II_19	6
+II_23	6
+II_28	6
+II_29	6
+II_34	6
+II_39	6
+II_42	6
+II_44	6
+II_56	6
+II_66	6
+II_67	6
+II_69	6
+II_72	6
+II_83	6
+II_89	6
+II_95	6
+III_1	6
+III_16	6
Binary file test-data/out_tsne1.rdat has changed
Binary file test-data/out_tsne2.rdat has changed
Binary file test-data/out_tsne3.rdat has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/transcript_counts_intestine_sub.tsv	Sat Mar 03 17:33:56 2018 -0500
@@ -0,0 +1,100 @@
+GENEID	I_1	I_2	I_3	I_4	I_5	I_6	I_7	I_8	I_9	I_10	I_11	I_12	I_13	I_14	I_15	I_16	I_17	I_18	I_19	I_20	I_21	I_22	I_23	I_24	I_25	I_26	I_27	I_28	I_29	I_30	I_31	I_32	I_33	I_34	I_35	I_36	I_37	I_38	I_39	I_40	I_41	I_42	I_43	I_44	I_45	I_46	I_47	I_48	I_49	I_50	I_51	I_52	I_53	I_54	I_55	I_56	I_57	I_58	I_59	I_60	I_61	I_62	I_63	I_64	I_65	I_66	I_67	I_68	I_69	I_70	I_71	I_72	I_73	I_74	I_75	I_76	I_77	I_78	I_79	I_80	I_81	I_82	I_83	I_84	I_85	I_86	I_87	I_88	I_89	I_90	I_91	I_92	I_93	I_94	I_95	I_96	II_1	II_2	II_3	II_4	II_5	II_6	II_7	II_8	II_9	II_10	II_11	II_12	II_13	II_14	II_15	II_16	II_17	II_18	II_19	II_20	II_21	II_22	II_23	II_24	II_25	II_26	II_27	II_28	II_29	II_30	II_31	II_32	II_33	II_34	II_35	II_36	II_37	II_38	II_39	II_40	II_41	II_42	II_43	II_44	II_45	II_46	II_47	II_48	II_49	II_50	II_51	II_52	II_53	II_54	II_55	II_56	II_57	II_58	II_59	II_60	II_61	II_62	II_63	II_64	II_65	II_66	II_67	II_68	II_69	II_70	II_71	II_72	II_73	II_74	II_75	II_76	II_77	II_78	II_79	II_80	II_81	II_82	II_83	II_84	II_85	II_86	II_87	II_88	II_89	II_90	II_91	II_92	II_93	II_94	II_95	II_96	III_1	III_2	III_3	III_4	III_5	III_6	III_7	III_8	III_9	III_10	III_11	III_12	III_13	III_14	III_15	III_16	III_17	III_18	III_19
+0610005C13Rik__chr7	2.00785343002263	1.0019582262109	0	5.04947336903132	2.00785343002263	1.0019582262109	5.04947336903132	0	2.00785343002263	0	1.0019582262109	1.0019582262109	2.00785343002263	0	3.01771667252281	0	1.0019582262109	0	3.01771667252281	0	0	1.0019582262109	3.01771667252281	0	0	3.01771667252281	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	0	2.00785343002263	3.01771667252281	1.0019582262109	0	6.07143081403291	4.03157938384363	0	2.00785343002263	0	1.0019582262109	1.0019582262109	1.0019582262109	0	1.0019582262109	2.00785343002263	0	2.00785343002263	9.16201161000583	2.00785343002263	1.0019582262109	5.04947336903132	0	1.0019582262109	3.01771667252281	1.0019582262109	0	0	2.00785343002263	2.00785343002263	0	0	0	7.09748429180284	13.3416962915876	0	2.00785343002263	0	2.00785343002263	2.00785343002263	0	3.01771667252281	1.0019582262109	4.03157938384363	0	9.16201161000583	1.0019582262109	3.01771667252281	0	3.01771667252281	0	2.00785343002263	1.0019582262109	1.0019582262109	6.07143081403291	0	0	3.01771667252281	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	0	2.00785343002263	0	0	2.00785343002263	1.0019582262109	0	2.00785343002263	0	2.00785343002263	0	3.01771667252281	2.00785343002263	0	0	0	4.03157938384363	3.01771667252281	1.0019582262109	0	0	5.04947336903132	2.00785343002263	2.00785343002263	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	5.04947336903132	0	1.0019582262109	5.04947336903132	2.00785343002263	0	0	0	3.01771667252281	3.01771667252281	0	2.00785343002263	0	0	0	2.00785343002263	1.0019582262109	0	0	2.00785343002263	1.0019582262109	0	0	2.00785343002263	0	1.0019582262109	0	2.00785343002263	0	3.01771667252281	0	4.03157938384363	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0
+0610007N19Rik__chr15	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+0610007P14Rik__chr12	1.0019582262109	0	1.0019582262109	3.01771667252281	1.0019582262109	0	2.00785343002263	1.0019582262109	2.00785343002263	3.01771667252281	0	0	3.01771667252281	1.0019582262109	5.04947336903132	2.00785343002263	0	0	5.04947336903132	1.0019582262109	7.09748429180284	0	3.01771667252281	1.0019582262109	1.0019582262109	0	0	2.00785343002263	0	0	0	0	1.0019582262109	0	1.0019582262109	2.00785343002263	2.00785343002263	0	4.03157938384363	4.03157938384363	8.12766676853256	5.04947336903132	1.0019582262109	2.00785343002263	0	0	1.0019582262109	0	1.0019582262109	4.03157938384363	0	8.12766676853256	2.00785343002263	1.0019582262109	3.01771667252281	1.0019582262109	2.00785343002263	0	0	1.0019582262109	2.00785343002263	1.0019582262109	0	3.01771667252281	2.00785343002263	0	0	10.2005525880831	2.00785343002263	0	1.0019582262109	1.0019582262109	2.00785343002263	0	1.0019582262109	3.01771667252281	2.00785343002263	3.01771667252281	4.03157938384363	1.0019582262109	3.01771667252281	3.01771667252281	7.09748429180284	4.03157938384363	5.04947336903132	1.0019582262109	0	5.04947336903132	0	0	0	0	1.0019582262109	1.0019582262109	2.00785343002263	3.01771667252281	0	6.07143081403291	1.0019582262109	1.0019582262109	0	0	0	9.16201161000583	1.0019582262109	1.0019582262109	1.0019582262109	0	0	2.00785343002263	2.00785343002263	0	0	2.00785343002263	3.01771667252281	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	2.00785343002263	1.0019582262109	0	0	1.0019582262109	0	3.01771667252281	1.0019582262109	1.0019582262109	4.03157938384363	5.04947336903132	0	2.00785343002263	0	1.0019582262109	1.0019582262109	0	0	0	4.03157938384363	0	2.00785343002263	0	0	0	3.01771667252281	0	0	0	0	1.0019582262109	2.00785343002263	3.01771667252281	0	0	1.0019582262109	2.00785343002263	3.01771667252281	0	2.00785343002263	5.04947336903132	4.03157938384363	2.00785343002263	3.01771667252281	1.0019582262109	3.01771667252281	0	1.0019582262109	0	2.00785343002263	4.03157938384363	1.0019582262109	0	2.00785343002263	0	1.0019582262109	2.00785343002263	0	1.0019582262109	0	2.00785343002263	0	2.00785343002263	0	0	1.0019582262109	10.2005525880831	0	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0
+0610008F07Rik__chr2	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+0610009B14Rik__chr12	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+0610009B22Rik__chr11	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	3.01771667252281	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	1.0019582262109	3.01771667252281	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	3.01771667252281	0	2.00785343002263	2.00785343002263	0	1.0019582262109	0	1.0019582262109	0	0	0	0	1.0019582262109	1.0019582262109	0	4.03157938384363	0	0	1.0019582262109	0	2.00785343002263	0	0	0	0	0	0	3.01771667252281	0	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	1.0019582262109	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	1.0019582262109	2.00785343002263	2.00785343002263	3.01771667252281	0	0	1.0019582262109	0	0	0	0	2.00785343002263	0	3.01771667252281	0	0	2.00785343002263	0	0	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	2.00785343002263	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	2.00785343002263	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	4.03157938384363	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109
+0610009D07Rik__chr12	0	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	1.0019582262109	0	6.07143081403291	0	0	4.03157938384363	1.0019582262109	1.0019582262109	2.00785343002263	0	0	2.00785343002263	0	2.00785343002263	3.01771667252281	0	2.00785343002263	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	2.00785343002263	3.01771667252281	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	2.00785343002263	0	1.0019582262109	2.00785343002263	0	0	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	3.01771667252281	3.01771667252281	0	2.00785343002263	7.09748429180284	1.0019582262109	0	2.00785343002263	0	2.00785343002263	0	2.00785343002263	1.0019582262109	1.0019582262109	5.04947336903132	1.0019582262109	0	0	3.01771667252281	3.01771667252281	0	2.00785343002263	0	1.0019582262109	1.0019582262109	0	0	5.04947336903132	1.0019582262109	0	1.0019582262109	3.01771667252281	1.0019582262109	1.0019582262109	3.01771667252281	1.0019582262109	0	0	1.0019582262109	0	2.00785343002263	2.00785343002263	0	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	0	2.00785343002263	2.00785343002263	0	0	0	1.0019582262109	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	4.03157938384363	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	0	0	1.0019582262109	1.0019582262109	3.01771667252281	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	2.00785343002263	0	1.0019582262109	2.00785343002263	0	1.0019582262109	0	0	0	1.0019582262109	2.00785343002263	1.0019582262109	1.0019582262109	2.00785343002263	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	3.01771667252281	0	0	0	0	0	1.0019582262109	0	0	0	0	0
+0610009L18Rik__chr11	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+0610009O20Rik__chr18	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	3.01771667252281	0	0	0	0	0	0	0	1.0019582262109	0	0	0	2.00785343002263	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	3.01771667252281	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+0610010B08Rik__chr2	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0
+0610010F05Rik__chr11	0	0	0	0	0	0	2.00785343002263	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	3.01771667252281	0	0	0	0	0	2.00785343002263	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+0610010K14Rik__chr11	0	0	0	0	0	3.01771667252281	0	3.01771667252281	1.0019582262109	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	2.00785343002263	0	2.00785343002263	2.00785343002263	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	3.01771667252281	0	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	3.01771667252281	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	2.00785343002263	0	1.0019582262109	0	1.0019582262109	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	2.00785343002263	1.0019582262109	0	0	0	1.0019582262109	0	2.00785343002263	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	2.00785343002263	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	2.00785343002263	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	2.00785343002263	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	2.00785343002263	3.01771667252281	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109
+0610011F06Rik__chr17	1.0019582262109	1.0019582262109	2.00785343002263	7.09748429180284	0	0	3.01771667252281	3.01771667252281	2.00785343002263	2.00785343002263	0	0	10.2005525880831	0	1.0019582262109	3.01771667252281	0	0	3.01771667252281	0	2.00785343002263	1.0019582262109	1.0019582262109	1.0019582262109	2.00785343002263	2.00785343002263	1.0019582262109	1.0019582262109	1.0019582262109	0	2.00785343002263	0	0	0	2.00785343002263	2.00785343002263	3.01771667252281	2.00785343002263	3.01771667252281	4.03157938384363	9.16201161000583	2.00785343002263	2.00785343002263	3.01771667252281	1.0019582262109	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	11.2433238873179	3.01771667252281	2.00785343002263	4.03157938384363	1.0019582262109	3.01771667252281	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	3.01771667252281	9.16201161000583	2.00785343002263	4.03157938384363	4.03157938384363	0	0	1.0019582262109	2.00785343002263	6.07143081403291	0	0	0	3.01771667252281	3.01771667252281	8.12766676853256	1.0019582262109	7.09748429180284	2.00785343002263	6.07143081403291	3.01771667252281	2.00785343002263	3.01771667252281	1.0019582262109	5.04947336903132	0	0	1.0019582262109	1.0019582262109	0	2.00785343002263	1.0019582262109	4.03157938384363	0	2.00785343002263	2.00785343002263	2.00785343002263	1.0019582262109	1.0019582262109	0	1.0019582262109	1.0019582262109	1.0019582262109	4.03157938384363	0	0	0	1.0019582262109	0	0	2.00785343002263	3.01771667252281	3.01771667252281	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	6.07143081403291	1.0019582262109	2.00785343002263	1.0019582262109	2.00785343002263	0	3.01771667252281	0	2.00785343002263	2.00785343002263	0	1.0019582262109	3.01771667252281	0	0	1.0019582262109	0	0	0	4.03157938384363	2.00785343002263	2.00785343002263	1.0019582262109	0	0	3.01771667252281	2.00785343002263	1.0019582262109	0	2.00785343002263	1.0019582262109	3.01771667252281	3.01771667252281	1.0019582262109	0	2.00785343002263	4.03157938384363	1.0019582262109	3.01771667252281	3.01771667252281	2.00785343002263	0	1.0019582262109	4.03157938384363	0	2.00785343002263	3.01771667252281	0	5.04947336903132	1.0019582262109	1.0019582262109	1.0019582262109	0	2.00785343002263	0	0	1.0019582262109	2.00785343002263	1.0019582262109	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	2.00785343002263	0	1.0019582262109	0	1.0019582262109	0	0	0	0	2.00785343002263	0	1.0019582262109	0	3.01771667252281	0	0	0	3.01771667252281	0	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109
+0610012G03Rik__chr16	0	1.0019582262109	2.00785343002263	4.03157938384363	0	2.00785343002263	3.01771667252281	0	2.00785343002263	1.0019582262109	2.00785343002263	1.0019582262109	3.01771667252281	0	3.01771667252281	1.0019582262109	1.0019582262109	0	4.03157938384363	0	1.0019582262109	0	1.0019582262109	0	3.01771667252281	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	2.00785343002263	3.01771667252281	7.09748429180284	4.03157938384363	4.03157938384363	5.04947336903132	2.00785343002263	5.04947336903132	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	3.01771667252281	0	6.07143081403291	2.00785343002263	1.0019582262109	0	0	0	2.00785343002263	1.0019582262109	0	5.04947336903132	2.00785343002263	1.0019582262109	3.01771667252281	2.00785343002263	0	5.04947336903132	5.04947336903132	0	0	0	1.0019582262109	4.03157938384363	1.0019582262109	3.01771667252281	1.0019582262109	3.01771667252281	5.04947336903132	5.04947336903132	1.0019582262109	2.00785343002263	1.0019582262109	8.12766676853256	2.00785343002263	4.03157938384363	0	1.0019582262109	5.04947336903132	1.0019582262109	0	1.0019582262109	0	3.01771667252281	1.0019582262109	2.00785343002263	4.03157938384363	2.00785343002263	3.01771667252281	2.00785343002263	2.00785343002263	1.0019582262109	1.0019582262109	1.0019582262109	0	1.0019582262109	2.00785343002263	1.0019582262109	2.00785343002263	0	3.01771667252281	0	0	0	2.00785343002263	8.12766676853256	3.01771667252281	0	0	1.0019582262109	1.0019582262109	0	2.00785343002263	2.00785343002263	1.0019582262109	1.0019582262109	0	1.0019582262109	1.0019582262109	0	3.01771667252281	1.0019582262109	2.00785343002263	0	1.0019582262109	3.01771667252281	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	4.03157938384363	1.0019582262109	2.00785343002263	0	3.01771667252281	1.0019582262109	3.01771667252281	2.00785343002263	1.0019582262109	0	0	0	3.01771667252281	2.00785343002263	3.01771667252281	1.0019582262109	0	3.01771667252281	3.01771667252281	0	1.0019582262109	1.0019582262109	4.03157938384363	1.0019582262109	6.07143081403291	3.01771667252281	0	0	2.00785343002263	0	0	1.0019582262109	1.0019582262109	3.01771667252281	1.0019582262109	5.04947336903132	0	1.0019582262109	1.0019582262109	0	1.0019582262109	4.03157938384363	0	2.00785343002263	0	1.0019582262109	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0
+0610012H03Rik__chr2	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+0610030E20Rik__chr6	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	3.01771667252281	0	0	3.01771667252281	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	6.07143081403291	1.0019582262109	0	0	0	0	0	0	1.0019582262109	2.00785343002263	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	0	2.00785343002263	2.00785343002263	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	2.00785343002263	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	2.00785343002263	0	0	0	0	0	2.00785343002263	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0
+0610031J06Rik__chr3	0	0	1.0019582262109	5.04947336903132	0	0	4.03157938384363	1.0019582262109	1.0019582262109	0	0	0	2.00785343002263	1.0019582262109	2.00785343002263	1.0019582262109	1.0019582262109	0	2.00785343002263	0	2.00785343002263	0	2.00785343002263	0	0	0	0	2.00785343002263	2.00785343002263	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	3.01771667252281	0	6.07143081403291	4.03157938384363	3.01771667252281	2.00785343002263	2.00785343002263	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	2.00785343002263	0	9.16201161000583	0	1.0019582262109	3.01771667252281	0	1.0019582262109	1.0019582262109	0	0	3.01771667252281	0	1.0019582262109	0	3.01771667252281	0	5.04947336903132	3.01771667252281	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	2.00785343002263	1.0019582262109	2.00785343002263	2.00785343002263	4.03157938384363	1.0019582262109	5.04947336903132	1.0019582262109	4.03157938384363	1.0019582262109	1.0019582262109	0	1.0019582262109	3.01771667252281	0	0	2.00785343002263	0	2.00785343002263	1.0019582262109	1.0019582262109	1.0019582262109	2.00785343002263	1.0019582262109	0	1.0019582262109	0	2.00785343002263	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	4.03157938384363	1.0019582262109	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	0	2.00785343002263	0	0	1.0019582262109	0	1.0019582262109	0	0	2.00785343002263	0	2.00785343002263	0	0	3.01771667252281	2.00785343002263	0	1.0019582262109	0	2.00785343002263	2.00785343002263	1.0019582262109	2.00785343002263	0	2.00785343002263	0	0	0	1.0019582262109	0	1.0019582262109	2.00785343002263	1.0019582262109	0	1.0019582262109	0	0	2.00785343002263	1.0019582262109	0	0	0	5.04947336903132	0	1.0019582262109	3.01771667252281	0	1.0019582262109	1.0019582262109	0	3.01771667252281	0	2.00785343002263	4.03157938384363	3.01771667252281	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	0	2.00785343002263	0	1.0019582262109	0	0	0	4.03157938384363	1.0019582262109	3.01771667252281	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0
+0610031O16Rik__chr3	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+0610037L13Rik__chr4	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	0	2.00785343002263	0	0	2.00785343002263	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	2.00785343002263	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	2.00785343002263	0	1.0019582262109	1.0019582262109	0	0	3.01771667252281	2.00785343002263	0	0	1.0019582262109	2.00785343002263	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	4.03157938384363	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	3.01771667252281	0	0	0	0	0	0	4.03157938384363	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	2.00785343002263	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0
+0610038B21Rik__chr8	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+0610038L08Rik__chr17	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+0610039K10Rik__chr2	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+0610040B10Rik__chr5	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+0610040F04Rik__chr6	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+0610040J01Rik__chr5	0	0	0	0	0	1.0019582262109	3.01771667252281	0	4.03157938384363	0	0	0	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0	2.00785343002263	0	1.0019582262109	3.01771667252281	2.00785343002263	0	0	0	2.00785343002263	0	0	0	0	0	0	2.00785343002263	0	0	2.00785343002263	1.0019582262109	2.00785343002263	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	0	0	3.01771667252281	1.0019582262109	0	1.0019582262109	0	0	0	2.00785343002263	0	1.0019582262109	0	0	0	2.00785343002263	0	1.0019582262109	0	0	0	0	0	3.01771667252281	0	0	1.0019582262109	0	1.0019582262109	2.00785343002263	1.0019582262109	2.00785343002263	0	1.0019582262109	4.03157938384363	1.0019582262109	0	0	2.00785343002263	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	2.00785343002263	0	0	2.00785343002263	0	2.00785343002263	0	0	0	1.0019582262109	0	2.00785343002263	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	2.00785343002263	0	2.00785343002263	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	2.00785343002263	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0
+0610043K17Rik__chr4	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1100001G20Rik__chr11	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110001A16Rik__chr17	0	0	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	2.00785343002263	2.00785343002263	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	4.03157938384363	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	4.03157938384363	1.0019582262109	0	0	0	1.0019582262109	0	0	0	2.00785343002263	2.00785343002263	1.0019582262109	1.0019582262109	1.0019582262109	0	2.00785343002263	2.00785343002263	2.00785343002263	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	2.00785343002263	1.0019582262109	0	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	1.0019582262109	2.00785343002263	1.0019582262109	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	0	0	3.01771667252281	0	0	0	0	0	0	1.0019582262109	1.0019582262109	2.00785343002263	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	3.01771667252281	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0
+1110001J03Rik__chr6	0	1.0019582262109	3.01771667252281	3.01771667252281	0	0	3.01771667252281	0	2.00785343002263	2.00785343002263	0	4.03157938384363	2.00785343002263	0	0	3.01771667252281	1.0019582262109	0	3.01771667252281	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	2.00785343002263	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	1.0019582262109	4.03157938384363	5.04947336903132	4.03157938384363	2.00785343002263	4.03157938384363	0	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	8.12766676853256	3.01771667252281	0	0	0	2.00785343002263	1.0019582262109	1.0019582262109	0	1.0019582262109	4.03157938384363	0	6.07143081403291	2.00785343002263	0	3.01771667252281	8.12766676853256	0	1.0019582262109	1.0019582262109	0	4.03157938384363	0	0	1.0019582262109	2.00785343002263	1.0019582262109	7.09748429180284	1.0019582262109	3.01771667252281	2.00785343002263	6.07143081403291	5.04947336903132	6.07143081403291	0	0	8.12766676853256	0	0	2.00785343002263	0	3.01771667252281	2.00785343002263	4.03157938384363	2.00785343002263	2.00785343002263	1.0019582262109	0	0	2.00785343002263	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	1.0019582262109	2.00785343002263	0	0	0	1.0019582262109	2.00785343002263	1.0019582262109	3.01771667252281	2.00785343002263	0	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	2.00785343002263	0	3.01771667252281	0	0	4.03157938384363	4.03157938384363	1.0019582262109	2.00785343002263	0	0	1.0019582262109	0	0	0	3.01771667252281	0	0	1.0019582262109	0	1.0019582262109	3.01771667252281	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	5.04947336903132	1.0019582262109	0	0	1.0019582262109	2.00785343002263	0	4.03157938384363	1.0019582262109	0	1.0019582262109	3.01771667252281	0	2.00785343002263	0	0	1.0019582262109	1.0019582262109	1.0019582262109	2.00785343002263	0	0	0	0	0	0	1.0019582262109	0	0	0	2.00785343002263	0	0	0	5.04947336903132	0	2.00785343002263	0	3.01771667252281	0	0	0	0	0	0	1.0019582262109	0	2.00785343002263	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0
+1110002L01Rik__chr12	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0
+1110004E09Rik__chr16	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	2.00785343002263	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	2.00785343002263	0	3.01771667252281	1.0019582262109	0	0	0	0	0	0	0	0	0	0	3.01771667252281	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	2.00785343002263	1.0019582262109	0	0	1.0019582262109	4.03157938384363	2.00785343002263	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	0	3.01771667252281	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	1.0019582262109	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	4.03157938384363	0	0	0	0	3.01771667252281	0	2.00785343002263	0	0	0	0	2.00785343002263	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	3.01771667252281	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110004F10Rik__chr7	1.0019582262109	0	0	1.0019582262109	1.0019582262109	3.01771667252281	2.00785343002263	0	3.01771667252281	4.03157938384363	0	0	0	0	0	0	0	0	2.00785343002263	0	1.0019582262109	3.01771667252281	2.00785343002263	6.07143081403291	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	0	5.04947336903132	1.0019582262109	4.03157938384363	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	2.00785343002263	1.0019582262109	2.00785343002263	1.0019582262109	0	0	0	0	0	0	0	2.00785343002263	0	0	5.04947336903132	2.00785343002263	0	0	5.04947336903132	1.0019582262109	1.0019582262109	1.0019582262109	0	1.0019582262109	0	1.0019582262109	1.0019582262109	3.01771667252281	1.0019582262109	1.0019582262109	0	0	4.03157938384363	3.01771667252281	3.01771667252281	3.01771667252281	1.0019582262109	0	2.00785343002263	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	5.04947336903132	0	2.00785343002263	1.0019582262109	0	0	3.01771667252281	1.0019582262109	0	4.03157938384363	1.0019582262109	2.00785343002263	0	0	2.00785343002263	1.0019582262109	0	0	1.0019582262109	0	2.00785343002263	2.00785343002263	0	0	3.01771667252281	0	0	2.00785343002263	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	2.00785343002263	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	3.01771667252281	0	3.01771667252281	2.00785343002263	0	2.00785343002263	0	0	0	0	1.0019582262109	2.00785343002263	0	2.00785343002263	0	0	0	0	0	0	0	3.01771667252281	1.0019582262109	1.0019582262109	0	0	0	0	0	2.00785343002263	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110006O24Rik__chr5	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110007C09Rik__chr13	0	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	2.00785343002263	2.00785343002263	1.0019582262109	1.0019582262109	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	2.00785343002263	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	3.01771667252281	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	2.00785343002263	0	2.00785343002263	2.00785343002263	1.0019582262109	0	0	0	2.00785343002263	0	0	0	4.03157938384363	0	0	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	2.00785343002263	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	0	0	2.00785343002263	0	1.0019582262109	0	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	2.00785343002263	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	3.01771667252281	0	0	1.0019582262109	0	0	2.00785343002263	2.00785343002263	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0
+1110008F13Rik__chr2	0	0	0	2.00785343002263	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	2.00785343002263	0	5.04947336903132	0	0	6.07143081403291	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	4.03157938384363	2.00785343002263	2.00785343002263	2.00785343002263	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	8.12766676853256	1.0019582262109	0	0	0	0	0	1.0019582262109	0	2.00785343002263	2.00785343002263	0	0	1.0019582262109	1.0019582262109	5.04947336903132	1.0019582262109	3.01771667252281	1.0019582262109	0	1.0019582262109	0	1.0019582262109	2.00785343002263	0	0	0	2.00785343002263	0	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	3.01771667252281	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	1.0019582262109	0	2.00785343002263	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	2.00785343002263	0	0	0	0	0	0	2.00785343002263	0	0	0	0	3.01771667252281	0	0	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	0	0	2.00785343002263	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	0	9.16201161000583	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0
+1110008J03Rik__chr5	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	3.01771667252281	0	1.0019582262109	0	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110008L16Rik__chr12	0	0	0	0	0	1.0019582262109	0	0	2.00785343002263	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	0	3.01771667252281	0	3.01771667252281	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	4.03157938384363	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	2.00785343002263	0	0	0	1.0019582262109	2.00785343002263	2.00785343002263	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	2.00785343002263	0	1.0019582262109	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	2.00785343002263	1.0019582262109	0	0	0	0	4.03157938384363	1.0019582262109	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	0	0	2.00785343002263	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	2.00785343002263	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	3.01771667252281	1.0019582262109	1.0019582262109	0	0	0	0	0	0	5.04947336903132	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	2.00785343002263	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	2.00785343002263	0	0	0	2.00785343002263	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0
+1110008P14Rik__chr2	0	0	0	3.01771667252281	0	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	2.00785343002263	2.00785343002263	1.0019582262109	2.00785343002263	1.0019582262109	2.00785343002263	0	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	2.00785343002263	0	0	2.00785343002263	0	1.0019582262109	1.0019582262109	2.00785343002263	0	0	0	0	0	0	0	3.01771667252281	4.03157938384363	0	2.00785343002263	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	0	0	2.00785343002263	2.00785343002263	0	2.00785343002263	0	0	1.0019582262109	0	0	0	2.00785343002263	0	2.00785343002263	1.0019582262109	1.0019582262109	0	1.0019582262109	3.01771667252281	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	3.01771667252281	1.0019582262109	0	0	1.0019582262109	0	0	3.01771667252281	0	0	2.00785343002263	0	0	1.0019582262109	0	0	2.00785343002263	0	0	0	0	0	1.0019582262109	0	0	0	0	0	4.03157938384363	0	0	2.00785343002263	1.0019582262109	1.0019582262109	1.0019582262109	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	2.00785343002263	1.0019582262109	1.0019582262109	5.04947336903132	3.01771667252281	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	3.01771667252281	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0
+1110012L19Rik__chrX	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	2.00785343002263	0	0	4.03157938384363	0	1.0019582262109	0	1.0019582262109	0	0	0	0	1.0019582262109	2.00785343002263	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	2.00785343002263	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0
+1110015O18Rik__chr3	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110017D15Rik__chr4	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110018G07Rik__chr12	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	3.01771667252281	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	2.00785343002263	5.04947336903132	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	3.01771667252281	2.00785343002263	2.00785343002263	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	2.00785343002263	0	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109
+1110019D14Rik__chr6	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110020A21Rik__chr17	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110025L11Rik__chr16	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110028F11Rik__chr11	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0
+1110028F18Rik__chr8	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110032A03Rik__chr9	0	0	0	3.01771667252281	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	2.00785343002263	1.0019582262109	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110032F04Rik__chr3	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	4.03157938384363	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110034G24Rik__chr2	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0
+1110035M17Rik__chr11	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110036E04Rik__chr9	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110037F02Rik__chr4	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	2.00785343002263	0	0	2.00785343002263	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	2.00785343002263	0	0	0	0	0	0	0	2.00785343002263	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	0	0	0	2.00785343002263	0	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	2.00785343002263	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	2.00785343002263	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	1.0019582262109	0	2.00785343002263	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0
+1110038B12Rik__chr17	0	0	0	0	0	6.07143081403291	0	0	3.01771667252281	2.00785343002263	0	0	0	0	0	6.07143081403291	0	0	3.01771667252281	0	7.09748429180284	0	0	4.03157938384363	3.01771667252281	4.03157938384363	0	0	0	0	0	0	0	0	0	1.0019582262109	4.03157938384363	6.07143081403291	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	4.03157938384363	0	8.12766676853256	0	0	2.00785343002263	0	3.01771667252281	0	0	0	0	0	0	1.0019582262109	2.00785343002263	0	2.00785343002263	3.01771667252281	0	0	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	3.01771667252281	0	0	0	0	4.03157938384363	6.07143081403291	0	0	0	0	2.00785343002263	0	0	0	0	1.0019582262109	3.01771667252281	0	0	5.04947336903132	0	1.0019582262109	1.0019582262109	0	1.0019582262109	3.01771667252281	1.0019582262109	0	1.0019582262109	3.01771667252281	0	2.00785343002263	1.0019582262109	0	2.00785343002263	0	3.01771667252281	0	4.03157938384363	0	0	0	1.0019582262109	2.00785343002263	0	1.0019582262109	0	2.00785343002263	1.0019582262109	0	2.00785343002263	0	1.0019582262109	1.0019582262109	3.01771667252281	0	0	0	1.0019582262109	0	0	0	0	2.00785343002263	0	0	0	0	0	4.03157938384363	0	0	0	0	0	0	2.00785343002263	0	0	1.0019582262109	0	6.07143081403291	0	0	0	2.00785343002263	0	4.03157938384363	1.0019582262109	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	3.01771667252281	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	0	2.00785343002263	0	0	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0
+1110038F14Rik__chr15	0	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	2.00785343002263	0	0	3.01771667252281	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	2.00785343002263	0	0	0	0	3.01771667252281	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	2.00785343002263	0	0	0	2.00785343002263	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	1.0019582262109	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0
+1110046J04Rik__chr13	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110051M20Rik__chr2	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110054M08Rik__chr16	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	2.00785343002263	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	2.00785343002263	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	2.00785343002263	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	2.00785343002263	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	2.00785343002263	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	2.00785343002263	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	2.00785343002263	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	0
+1110057K04Rik__chr12	3.01771667252281	0	1.0019582262109	4.03157938384363	3.01771667252281	0	2.00785343002263	1.0019582262109	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	0	1.0019582262109	2.00785343002263	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	2.00785343002263	1.0019582262109	1.0019582262109	4.03157938384363	0	0	2.00785343002263	0	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	2.00785343002263	3.01771667252281	1.0019582262109	1.0019582262109	2.00785343002263	0	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	4.03157938384363	1.0019582262109	1.0019582262109	2.00785343002263	8.12766676853256	0	1.0019582262109	1.0019582262109	0	2.00785343002263	0	1.0019582262109	2.00785343002263	2.00785343002263	0	3.01771667252281	1.0019582262109	1.0019582262109	0	2.00785343002263	0	2.00785343002263	2.00785343002263	0	1.0019582262109	0	0	1.0019582262109	3.01771667252281	1.0019582262109	2.00785343002263	4.03157938384363	1.0019582262109	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	0	2.00785343002263	1.0019582262109	0	1.0019582262109	2.00785343002263	0	1.0019582262109	0	0	0	0	2.00785343002263	1.0019582262109	0	0	2.00785343002263	1.0019582262109	0	1.0019582262109	0	2.00785343002263	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	1.0019582262109	3.01771667252281	1.0019582262109	0	1.0019582262109	2.00785343002263	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	3.01771667252281	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	1.0019582262109
+1110058L19Rik__chr1	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	2.00785343002263	0	0	0	0	1.0019582262109	0	0	0	2.00785343002263	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	3.01771667252281	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	1.0019582262109	0	2.00785343002263	1.0019582262109	0	2.00785343002263	2.00785343002263	1.0019582262109	0	0	0	0	0	2.00785343002263	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	3.01771667252281	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	2.00785343002263	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	2.00785343002263	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	2.00785343002263	0	0	0
+1110059E24Rik__chr19	0	0	0	3.01771667252281	0	1.0019582262109	0	2.00785343002263	3.01771667252281	1.0019582262109	0	0	1.0019582262109	0	0	4.03157938384363	1.0019582262109	0	1.0019582262109	0	4.03157938384363	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	2.00785343002263	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	2.00785343002263	0	1.0019582262109	0	0	0	0	0	0	0	3.01771667252281	1.0019582262109	3.01771667252281	3.01771667252281	0	0	2.00785343002263	0	0	1.0019582262109	0	0	1.0019582262109	3.01771667252281	0	0	0	0	2.00785343002263	1.0019582262109	2.00785343002263	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	2.00785343002263	1.0019582262109	0	3.01771667252281	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	3.01771667252281	0	0	0	3.01771667252281	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	2.00785343002263	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	4.03157938384363	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	2.00785343002263	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	2.00785343002263	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0
+1110059G10Rik__chr9	0	0	1.0019582262109	3.01771667252281	1.0019582262109	0	3.01771667252281	0	1.0019582262109	2.00785343002263	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	2.00785343002263	0	0	0	0	1.0019582262109	0	0	1.0019582262109	2.00785343002263	0	1.0019582262109	3.01771667252281	0	0	2.00785343002263	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	3.01771667252281	0	0	1.0019582262109	0	1.0019582262109	0	0	0	2.00785343002263	4.03157938384363	1.0019582262109	0	0	2.00785343002263	0	0	0	2.00785343002263	0	0	0	0	0	2.00785343002263	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	4.03157938384363	0	1.0019582262109	0	0	0	2.00785343002263	0	2.00785343002263	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	2.00785343002263	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0	0	3.01771667252281	0	0	1.0019582262109	0	2.00785343002263	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0
+1110059M19Rik__chrX	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1110065P20Rik__chr4	0	0	0	0	0	0	0	0	2.00785343002263	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	2.00785343002263	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	2.00785343002263	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	3.01771667252281	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	2.00785343002263	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	2.00785343002263	0	0	3.01771667252281	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	2.00785343002263	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	2.00785343002263	0	1.0019582262109	0	0	0	0	0	0	0	2.00785343002263	0	2.00785343002263	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1190002F15Rik__chr6	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	3.01771667252281	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	1.0019582262109	4.03157938384363	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1190002N15Rik__chr9	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	1.0019582262109	0	0	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	1.0019582262109	0	0	2.00785343002263	0	0	1.0019582262109	1.0019582262109	0	4.03157938384363	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	2.00785343002263	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0
+1190003J15Rik__chr7	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	2.00785343002263	0	0	0	0	0	1.0019582262109	0	0	0	2.00785343002263	2.00785343002263	0	0	0	0	0	0	0	1.0019582262109	0	0	0	2.00785343002263	0	0	3.01771667252281	0	0	0	0	2.00785343002263	0	0	0	3.01771667252281	0	0	0	1.0019582262109	0	2.00785343002263	0	1.0019582262109	0	0	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	1.0019582262109	3.01771667252281	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	3.01771667252281	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	3.01771667252281	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0
+1190003K10Rik__chr13	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1190005I06Rik__chr8	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1190007I07Rik__chr10	0	0	0	0	0	0	0	0	3.01771667252281	5.04947336903132	0	0	0	2.00785343002263	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	3.01771667252281	5.04947336903132	1.0019582262109	1.0019582262109	0	2.00785343002263	1.0019582262109	0	0	0	1.0019582262109	0	0	2.00785343002263	0	3.01771667252281	0	0	1.0019582262109	0	0	0	0	0	2.00785343002263	0	0	3.01771667252281	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	2.00785343002263	0	0	0	0	1.0019582262109	0	2.00785343002263	0	0	2.00785343002263	0	0	0	0	0	1.0019582262109	2.00785343002263	1.0019582262109	0	1.0019582262109	1.0019582262109	0	1.0019582262109	1.0019582262109	0	2.00785343002263	0	0	1.0019582262109	2.00785343002263	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	2.00785343002263	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	2.00785343002263	0	0	1.0019582262109	2.00785343002263	0	0	0	2.00785343002263	0	0	0	0	1.0019582262109	0	0	0	0	0	2.00785343002263	0	1.0019582262109	0	0	0	0	1.0019582262109	0	2.00785343002263	0	1.0019582262109	2.00785343002263	0	1.0019582262109	0	0	0	2.00785343002263	0	1.0019582262109	0	0	1.0019582262109	0	3.01771667252281	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	0
+1200011I18Rik__chr14	0	0	0	2.00785343002263	0	0	1.0019582262109	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	2.00785343002263	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	3.01771667252281	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	2.00785343002263	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	2.00785343002263	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	2.00785343002263	0	0	0
+1200014J11Rik__chr11	1.0019582262109	0	1.0019582262109	1.0019582262109	0	2.00785343002263	0	4.03157938384363	2.00785343002263	2.00785343002263	1.0019582262109	2.00785343002263	3.01771667252281	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	0	1.0019582262109	0	4.03157938384363	3.01771667252281	1.0019582262109	0	3.01771667252281	1.0019582262109	0	1.0019582262109	3.01771667252281	0	0	0	0	0	2.00785343002263	3.01771667252281	1.0019582262109	4.03157938384363	0	1.0019582262109	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	2.00785343002263	2.00785343002263	2.00785343002263	2.00785343002263	1.0019582262109	2.00785343002263	1.0019582262109	2.00785343002263	2.00785343002263	1.0019582262109	2.00785343002263	1.0019582262109	0	1.0019582262109	2.00785343002263	4.03157938384363	1.0019582262109	1.0019582262109	23.0032202551964	0	0	4.03157938384363	0	4.03157938384363	2.00785343002263	0	4.03157938384363	0	2.00785343002263	0	0	0	3.01771667252281	4.03157938384363	3.01771667252281	5.04947336903132	0	1.0019582262109	2.00785343002263	2.00785343002263	0	1.0019582262109	1.0019582262109	2.00785343002263	0	1.0019582262109	1.0019582262109	0	2.00785343002263	1.0019582262109	0	1.0019582262109	2.00785343002263	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	2.00785343002263	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	1.0019582262109	7.09748429180284	0	0	0	0	0	1.0019582262109	2.00785343002263	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	2.00785343002263	0	0	0	1.0019582262109	2.00785343002263	0	1.0019582262109	0	0	0	0	0	2.00785343002263	0	1.0019582262109	4.03157938384363	0	1.0019582262109	0	7.09748429180284	0	0	2.00785343002263	0	0	0	3.01771667252281	0	5.04947336903132	2.00785343002263	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	4.03157938384363	0	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	0	0	8.12766676853256	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	3.01771667252281	0	0	1.0019582262109	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	0	0
+1300002E11Rik__chr16	0	0	0	0	0	1.0019582262109	0	2.00785343002263	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	2.00785343002263	0	5.04947336903132	0	0	2.00785343002263	0	0	0	1.0019582262109	0	0	2.00785343002263	0	0	1.0019582262109	0	3.01771667252281	3.01771667252281	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	2.00785343002263	1.0019582262109	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	2.00785343002263	0	0	2.00785343002263	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0
+1300002K09Rik__chr4	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	2.00785343002263	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	4.03157938384363	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	3.01771667252281	0	0	0	0	0	0	0	0	0	0	0	0
+1300015D01Rik__chr2	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1300017J02Rik__chr9	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1300018J18Rik__chr15	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1500002O10Rik__chr2	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1500004A13Rik__chr3	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1500009C09Rik__chr15	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1500009L16Rik__chr10	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1500011B03Rik__chr5	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	2.00785343002263	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	3.01771667252281	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1500011K16Rik__chr2	0	0	1.0019582262109	0	0	0	4.03157938384363	0	1.0019582262109	1.0019582262109	0	0	2.00785343002263	0	2.00785343002263	0	0	0	5.04947336903132	1.0019582262109	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	2.00785343002263	1.0019582262109	0	1.0019582262109	2.00785343002263	0	4.03157938384363	0	0	1.0019582262109	2.00785343002263	0	0	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	2.00785343002263	0	0	0	0	0	1.0019582262109	0	3.01771667252281	5.04947336903132	0	2.00785343002263	1.0019582262109	2.00785343002263	2.00785343002263	0	0	6.07143081403291	0	1.0019582262109	0	3.01771667252281	1.0019582262109	0	0	0	0	2.00785343002263	2.00785343002263	2.00785343002263	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	2.00785343002263	1.0019582262109	2.00785343002263	1.0019582262109	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	2.00785343002263	0	0	4.03157938384363	0	0	0	3.01771667252281	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	2.00785343002263	0	0	0	0	1.0019582262109	1.0019582262109	0	2.00785343002263	0	0	0	0	1.0019582262109	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1500012F01Rik__chr2	0	0	0	2.00785343002263	0	8.12766676853256	0	2.00785343002263	3.01771667252281	2.00785343002263	0	0	7.09748429180284	0	1.0019582262109	4.03157938384363	0	0	6.07143081403291	0	2.00785343002263	0	2.00785343002263	5.04947336903132	2.00785343002263	1.0019582262109	0	0	3.01771667252281	0	0	0	0	0	0	1.0019582262109	8.12766676853256	9.16201161000583	0	1.0019582262109	4.03157938384363	2.00785343002263	2.00785343002263	1.0019582262109	0	0	0	1.0019582262109	0	7.09748429180284	0	17.5907564923013	2.00785343002263	0	1.0019582262109	2.00785343002263	5.04947336903132	1.0019582262109	0	3.01771667252281	2.00785343002263	0	0	3.01771667252281	0	0	3.01771667252281	9.16201161000583	0	0	2.00785343002263	0	3.01771667252281	0	2.00785343002263	1.0019582262109	0	6.07143081403291	7.09748429180284	1.0019582262109	0	1.0019582262109	2.00785343002263	10.2005525880831	6.07143081403291	0	0	4.03157938384363	3.01771667252281	0	1.0019582262109	0	1.0019582262109	5.04947336903132	6.07143081403291	1.0019582262109	2.00785343002263	7.09748429180284	0	1.0019582262109	2.00785343002263	1.0019582262109	0	5.04947336903132	0	0	1.0019582262109	3.01771667252281	1.0019582262109	6.07143081403291	0	0	1.0019582262109	1.0019582262109	2.00785343002263	1.0019582262109	3.01771667252281	0	0	0	0	3.01771667252281	0	0	0	2.00785343002263	2.00785343002263	0	7.09748429180284	0	0	0	3.01771667252281	0	3.01771667252281	0	0	1.0019582262109	0	1.0019582262109	0	4.03157938384363	0	3.01771667252281	0	0	1.0019582262109	4.03157938384363	3.01771667252281	3.01771667252281	0	1.0019582262109	2.00785343002263	0	3.01771667252281	0	0	0	2.00785343002263	5.04947336903132	0	0	1.0019582262109	2.00785343002263	0	1.0019582262109	0	1.0019582262109	4.03157938384363	1.0019582262109	2.00785343002263	0	1.0019582262109	2.00785343002263	0	0	0	0	0	0	3.01771667252281	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0	6.07143081403291	0	0	0	0	0	0	0	0	0	0	5.04947336903132	0	1.0019582262109	0	0	1.0019582262109	0	0	0	2.00785343002263	0	0
+1500012K07Rik__chr7	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1500015A07Rik__chr18	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1500015L24Rik__chr19	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1500015O10Rik__chr1	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1500016L03Rik__chr11	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1500017E21Rik__chr19	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1600002D24Rik__chr16	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1600002H07Rik__chr17	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	2.00785343002263	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0
+1600002K03Rik__chr10	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	3.01771667252281	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	2.00785343002263	0	1.0019582262109	1.0019582262109	0	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1600010M07Rik__chr7	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1600012H06Rik__chr17	0	1.0019582262109	0	2.00785343002263	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	0	1.0019582262109	0	0	1.0019582262109	2.00785343002263	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	4.03157938384363	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	2.00785343002263	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	2.00785343002263	0	0	0	0	0	0	0	0	1.0019582262109	0	4.03157938384363	0	0	2.00785343002263	0	0	1.0019582262109	0	0	0	0	0	2.00785343002263	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	1.0019582262109	0	1.0019582262109	0	1.0019582262109	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	1.0019582262109
+1600014C10Rik__chr7	0	2.00785343002263	2.00785343002263	0	0	0	0	1.0019582262109	0	1.0019582262109	0	0	3.01771667252281	0	2.00785343002263	1.0019582262109	1.0019582262109	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	0	0	2.00785343002263	0	0	0	0	0	0	2.00785343002263	0	0	3.01771667252281	1.0019582262109	3.01771667252281	3.01771667252281	4.03157938384363	0	0	0	0	0	0	0	1.0019582262109	2.00785343002263	1.0019582262109	1.0019582262109	5.04947336903132	0	0	1.0019582262109	2.00785343002263	0	0	2.00785343002263	0	1.0019582262109	0	1.0019582262109	4.03157938384363	7.09748429180284	0	0	0	2.00785343002263	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	4.03157938384363	1.0019582262109	1.0019582262109	0	1.0019582262109	2.00785343002263	3.01771667252281	2.00785343002263	1.0019582262109	2.00785343002263	0	0	2.00785343002263	1.0019582262109	0	0	1.0019582262109	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	2.00785343002263	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	0	0	1.0019582262109	1.0019582262109	1.0019582262109	0	1.0019582262109	1.0019582262109	0	1.0019582262109	0	2.00785343002263	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	1.0019582262109	1.0019582262109	4.03157938384363	4.03157938384363	2.00785343002263	0	0	0	0	1.0019582262109	1.0019582262109	0	0	2.00785343002263	0	0	1.0019582262109	0	0	2.00785343002263	0	2.00785343002263	0	2.00785343002263	1.0019582262109	1.0019582262109	1.0019582262109	2.00785343002263	0	0	0	0	0	0	0	0	0	0	1.0019582262109	2.00785343002263	0	1.0019582262109	0	1.0019582262109	0	0	0	0	1.0019582262109	0	1.0019582262109	1.0019582262109	0	0	0	0	0	0	0	0	0	0
+1600014C23Rik__chr17	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	1.0019582262109	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1600014K23Rik__chrX	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0
+1600015I10Rik__chr6	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0	0