destiny/DESCRIPTION0000644000175200017520000000674114516030526014773 0ustar00biocbuildbiocbuildPackage: destiny Type: Package Title: Creates diffusion maps Version: 3.16.0 Date: 2014-12-19 Authors@R: c( person('Philipp', 'Angerer', NULL, 'phil.angerer@gmail.com', c('cre', 'aut'), comment = c(ORCID = '0000-0002-0369-2888')), person('Laleh', 'Haghverdi', NULL, 'laleh.haghverdi@helmholtz-muenchen.de', 'ctb'), person('Maren', 'Büttner', NULL, 'maren.buettner@helmholtz-muenchen.de', 'ctb', comment = c(ORCID = '0000-0002-6189-3792')), person('Fabian', 'Theis', NULL, 'fabian.theis@helmholtz-muenchen.de', 'ctb', comment = c(ORCID = '0000-0002-2419-1943')), person('Carsten', 'Marr', NULL, 'carsten.marr@helmholtz-muenchen.de', 'ctb', comment = c(ORCID = '0000-0003-2154-4552')), person('Florian', 'Büttner', NULL, 'f.buettner@helmholtz-muenchen.de', 'ctb', comment = c(ORCID = '0000-0001-5587-6761'))) Description: Create and plot diffusion maps. License: GPL-3 URL: https://theislab.github.io/destiny/, https://github.com/theislab/destiny/, https://www.helmholtz-muenchen.de/icb/destiny, https://bioconductor.org/packages/destiny, https://doi.org/10.1093/bioinformatics/btv715 BugReports: https://github.com/theislab/destiny/issues Encoding: UTF-8 Depends: R (>= 3.4.0) Imports: methods, graphics, grDevices, grid, utils, stats, Matrix, Rcpp (>= 0.10.3), RcppEigen, RSpectra (>= 0.14-0), irlba, pcaMethods, Biobase, BiocGenerics, SummarizedExperiment, SingleCellExperiment, ggplot2, ggplot.multistats, tidyr, tidyselect, ggthemes, VIM, knn.covertree, proxy, RcppHNSW, smoother, scales, scatterplot3d LinkingTo: Rcpp, RcppEigen, grDevices SystemRequirements: C++11 NeedsCompilation: yes Enhances: rgl, SingleCellExperiment Suggests: knitr, rmarkdown, igraph, testthat, FNN, tidyverse, gridExtra, cowplot, conflicted, viridis, rgl, scRNAseq, org.Mm.eg.db, scran, repr VignetteBuilder: knitr biocViews: CellBiology, CellBasedAssays, Clustering, Software, Visualization Collate: 'RcppExports.R' 'aaa.r' 'accessor-generics.r' 'censoring.r' 'colorlegend.r' 'cube_helix.r' 'dataset-helpers.r' 'destiny-package.r' 's4-unions.r' 'dist-matrix-coerce.r' 'sigmas.r' 'diffusionmap.r' 'diffusionmap-methods-accession.r' 'diffusionmap-methods.r' 'plothelpers.r' 'diffusionmap-plotting.r' 'dpt-branching.r' 'dpt-helpers.r' 'dpt.r' 'dpt-methods-matrix.r' 'dpt-methods.r' 'utils.r' 'dpt-plotting.r' 'eig_decomp.r' 'expressionset-helpers.r' 'find_dm_k.r' 'gene-relevance.r' 'gene-relevance-methods.r' 'gene-relevance-plotting-differential-map.r' 'gene-relevance-plotting-gr-map.r' 'gene-relevance-plotting-rank.r' 'gene-relevance-plotting.r' 'guo-data.r' 'knn.r' 'l_which.r' 'methods-coercion.r' 'methods-extraction.r' 'methods-update.r' 'predict.r' 'projection-dist.r' 'rankcor.r' 'sigmas-plotting.r' RoxygenNote: 7.1.2 git_url: https://git.bioconductor.org/packages/destiny git_branch: RELEASE_3_18 git_last_commit: 88094ed git_last_commit_date: 2023-10-24 Date/Publication: 2023-10-24 Packaged: 2023-10-24 21:04:22 UTC; biocbuild Author: Philipp Angerer [cre, aut] (), Laleh Haghverdi [ctb], Maren Büttner [ctb] (), Fabian Theis [ctb] (), Carsten Marr [ctb] (), Florian Büttner [ctb] () Maintainer: Philipp Angerer destiny/NAMESPACE0000644000175200017520000001505714516010071014475 0ustar00biocbuildbiocbuild# Generated by roxygen2: do not edit by hand S3method(fortify,DPT) S3method(fortify,DiffusionMap) export("dataset<-") export("distance<-") export("eigenvalues<-") export("eigenvectors<-") export("sigmas<-") export(DPT) export(DiffusionMap) export(Sigmas) export(as.ExpressionSet) export(branch_divide) export(colorlegend) export(cube_helix) export(dataset) export(distance) export(dm_predict) export(eig_decomp) export(eigenvalues) export(eigenvectors) export(find_dm_k) export(find_knn) export(find_sigmas) export(find_tips) export(fortify.DPT) export(fortify.DiffusionMap) export(gene_relevance) export(l_which) export(optimal_sigma) export(plot.DPT) export(plot.DiffusionMap) export(plot_differential_map) export(plot_gene_relevance) export(plot_gene_relevance_rank) export(projection_dist) export(random_root) export(read.ExpressionSet) export(scale_color_cube_helix) export(scale_colour_cube_helix) export(scale_fill_cube_helix) export(sigmas) export(tips) exportClasses(DPT) exportClasses(DiffusionMap) exportClasses(GeneRelevance) exportClasses(Sigmas) exportMethods("$") exportMethods("[") exportMethods("[[") exportMethods("dataset<-") exportMethods("distance<-") exportMethods("eigenvalues<-") exportMethods("eigenvectors<-") exportMethods("featureNames<-") exportMethods("sigmas<-") exportMethods(as.ExpressionSet) exportMethods(as.data.frame) exportMethods(as.matrix) exportMethods(dataset) exportMethods(dim) exportMethods(distance) exportMethods(eigenvalues) exportMethods(eigenvectors) exportMethods(featureNames) exportMethods(gene_relevance) exportMethods(names) exportMethods(ncol) exportMethods(nrow) exportMethods(optimal_sigma) exportMethods(plot) exportMethods(plot_differential_map) exportMethods(plot_gene_relevance) exportMethods(plot_gene_relevance_rank) exportMethods(print) exportMethods(show) exportMethods(sigmas) exportMethods(updateObject) importClassesFrom(Matrix,BunchKaufman) importClassesFrom(Matrix,Cholesky) importClassesFrom(Matrix,corMatrix) importClassesFrom(Matrix,dMatrix) importClassesFrom(Matrix,ddenseMatrix) importClassesFrom(Matrix,ddiMatrix) importClassesFrom(Matrix,dgeMatrix) importClassesFrom(Matrix,dpoMatrix) importClassesFrom(Matrix,dppMatrix) importClassesFrom(Matrix,dspMatrix) importClassesFrom(Matrix,dsparseMatrix) importClassesFrom(Matrix,dsyMatrix) importClassesFrom(Matrix,dtpMatrix) importClassesFrom(Matrix,dtrMatrix) importClassesFrom(Matrix,pBunchKaufman) importClassesFrom(Matrix,pCholesky) importFrom(Biobase,"featureNames<-") importFrom(Biobase,AnnotatedDataFrame) importFrom(Biobase,ExpressionSet) importFrom(Biobase,as.data.frame.ExpressionSet) importFrom(Biobase,exprs) importFrom(Biobase,featureNames) importFrom(Biobase,pData) importFrom(Biobase,phenoData) importFrom(Biobase,rowMedians) importFrom(Biobase,sampleNames) importFrom(Biobase,updateObject) importFrom(Biobase,varLabels) importFrom(BiocGenerics,as.data.frame) importFrom(BiocGenerics,duplicated) importFrom(BiocGenerics,ncol) importFrom(BiocGenerics,nrow) importFrom(BiocGenerics,updateObject) importFrom(Matrix,"diag<-") importFrom(Matrix,Diagonal) importFrom(Matrix,Matrix) importFrom(Matrix,colSums) importFrom(Matrix,drop0) importFrom(Matrix,forceSymmetric) importFrom(Matrix,isSymmetric) importFrom(Matrix,nnzero) importFrom(Matrix,rowSums) importFrom(Matrix,skewpart) importFrom(Matrix,sparseMatrix) importFrom(Matrix,symmpart) importFrom(Matrix,t) importFrom(Matrix,tcrossprod) importFrom(Matrix,which) importFrom(RSpectra,eigs) importFrom(RSpectra,eigs_sym) importFrom(Rcpp,evalCpp) importFrom(RcppEigen,RcppEigen.package.skeleton) importFrom(RcppHNSW,hnsw_build) importFrom(RcppHNSW,hnsw_knn) importFrom(RcppHNSW,hnsw_search) importFrom(SingleCellExperiment,"reducedDim<-") importFrom(SingleCellExperiment,reducedDim) importFrom(SingleCellExperiment,reducedDimNames) importFrom(SummarizedExperiment,assay) importFrom(SummarizedExperiment,colData) importFrom(VIM,hotdeck) importFrom(ggplot.multistats,stat_summaries_hex) importFrom(ggplot2,aes) importFrom(ggplot2,aes_string) importFrom(ggplot2,element_blank) importFrom(ggplot2,element_line) importFrom(ggplot2,element_rect) importFrom(ggplot2,element_text) importFrom(ggplot2,facet_wrap) importFrom(ggplot2,fortify) importFrom(ggplot2,geom_path) importFrom(ggplot2,geom_point) importFrom(ggplot2,geom_spoke) importFrom(ggplot2,ggplot) importFrom(ggplot2,ggtitle) importFrom(ggplot2,guide_colourbar) importFrom(ggplot2,guide_legend) importFrom(ggplot2,scale_alpha_continuous) importFrom(ggplot2,scale_color_manual) importFrom(ggplot2,scale_colour_gradientn) importFrom(ggplot2,scale_colour_identity) importFrom(ggplot2,scale_fill_gradientn) importFrom(ggplot2,scale_fill_identity) importFrom(ggplot2,scale_fill_manual) importFrom(ggplot2,scale_x_continuous) importFrom(ggplot2,scale_y_continuous) importFrom(ggplot2,stat) importFrom(ggplot2,theme) importFrom(ggplot2,theme_minimal) importFrom(ggthemes,extended_range_breaks) importFrom(ggthemes,geom_rangeframe) importFrom(grDevices,colorRampPalette) importFrom(grDevices,hcl.colors) importFrom(grDevices,palette) importFrom(grDevices,rgb) importFrom(graphics,axis) importFrom(graphics,dotchart) importFrom(graphics,layout) importFrom(graphics,par) importFrom(graphics,plot) importFrom(graphics,plot.new) importFrom(graphics,plot.window) importFrom(graphics,points) importFrom(graphics,rect) importFrom(graphics,segments) importFrom(graphics,text) importFrom(grid,arrow) importFrom(grid,unit) importFrom(irlba,prcomp_irlba) importFrom(methods,"slot<-") importFrom(methods,.hasSlot) importFrom(methods,.valueClassTest) importFrom(methods,as) importFrom(methods,canCoerce) importFrom(methods,hasMethod) importFrom(methods,is) importFrom(methods,new) importFrom(methods,setAs) importFrom(methods,setClass) importFrom(methods,setClassUnion) importFrom(methods,setGeneric) importFrom(methods,setMethod) importFrom(methods,setOldClass) importFrom(methods,show) importFrom(methods,slot) importFrom(methods,validObject) importFrom(pcaMethods,pca) importFrom(pcaMethods,scores) importFrom(proxy,dist) importFrom(proxy,pr_DB) importFrom(scales,colour_ramp) importFrom(scales,percent) importFrom(scales,rescale) importFrom(scatterplot3d,scatterplot3d) importFrom(smoother,smth.gaussian) importFrom(stats,na.omit) importFrom(stats,runif) importFrom(stats,setNames) importFrom(tidyr,gather) importFrom(tidyselect,one_of) importFrom(utils,capture.output) importFrom(utils,combn) importFrom(utils,flush.console) importFrom(utils,getFromNamespace) importFrom(utils,getS3method) importFrom(utils,head) importFrom(utils,read.table) importFrom(utils,setTxtProgressBar) importFrom(utils,str) importFrom(utils,txtProgressBar) importMethodsFrom(Matrix,solve) useDynLib(destiny) destiny/NEWS0000644000175200017520000000040314516010071013742 0ustar00biocbuildbiocbuildChanges in version 1.1 (2015-11-27) =================================== * Implemented rank correlation distance and cosine distance * Added updateObject method Changes in version 1.0 (2015-07-27) =================================== * Initial release destiny/R/0000755000175200017520000000000014516010071013447 5ustar00biocbuildbiocbuilddestiny/R/RcppExports.R0000644000175200017520000000122114516010071016057 0ustar00biocbuildbiocbuild# Generated by using Rcpp::compileAttributes() -> do not edit by hand # Generator token: 10BE3573-1514-4C36-9D1C-5A225CD40393 censoring_impl <- function(data, sigmas, dists, thr_or_null, uncertain_or_null, missing_or_null, callback) { .Call('_destiny_censoring_impl', PACKAGE = 'destiny', data, sigmas, dists, thr_or_null, uncertain_or_null, missing_or_null, callback) } predict_censoring_impl <- function(data, data2, thr, uncertain, missing, sigma) { .Call('_destiny_predict_censoring_impl', PACKAGE = 'destiny', data, data2, thr, uncertain, missing, sigma) } rank_mat <- function(x) { .Call('_destiny_rank_mat', PACKAGE = 'destiny', x) } destiny/R/aaa.r0000644000175200017520000000164714516010071014364 0ustar00biocbuildbiocbuildbad_default_palette <- c('black', 'red', 'green3', 'blue', 'cyan', 'magenta', 'yellow', 'gray') #this is a reshuffled Set3, but RColorBrewer doesn’t work in .onLoad due to using rgb() unconditionally gud_default_palette <- c('#8DD3C7', '#FFED6F', '#BEBADA', '#FB8072', '#80B1D3', '#FDB462', '#B3DE69', '#BC80BD', '#FCCDE5', '#D9D9D9', '#CCEBC5', '#FFFFB3') # do not use .Call.graphics like grDevices::palette #' @importFrom utils getFromNamespace set_palette <- function(v) { cp <- getFromNamespace('C_palette', 'grDevices') do.call(.Call, list(cp, v)) # do.call is needed to get around static analysis } .onLoad <- function(libname, pkgname) { if (identical(palette(), gud_default_palette) || !identical(tryCatch(proxy::pr_DB$get_entry('rankcorrelation'), error = function(e) NULL), NULL)) { return() } if (identical(palette(), bad_default_palette)) { set_palette(gud_default_palette) } proxy_add_rankcor_simil() } destiny/R/accessor-generics.r0000644000175200017520000000475214516010071017241 0ustar00biocbuildbiocbuild#' destiny generics #' #' destiny provides several generic methods and implements them for the \code{\link{DiffusionMap}} and \code{\link{Sigmas}} classes. #' #' @param object Object from which to extract or to which to assign a value #' @param value Value to assign within an object #' #' @examples #' data(guo_norm) #' dm <- DiffusionMap(guo_norm) #' eigenvalues(dm) #' eigenvectors(dm) #' sigmas(dm) #' optimal_sigma(dm) #' dataset(dm) #' distance(dm) #' #' @seealso \link{DiffusionMap methods} and \link{Sigmas} class for implementations #' #' @importFrom methods setGeneric #' @name destiny generics #' @rdname destiny-generics NULL #' @return \code{eigenvalues} retrieves the numeric eigenvalues #' @rdname destiny-generics #' @export setGeneric('eigenvalues', function(object) standardGeneric('eigenvalues'), valueClass = 'numeric') #' @rdname destiny-generics #' @export setGeneric('eigenvalues<-', function(object, value) standardGeneric('eigenvalues<-')) #' @return \code{eigenvectors} retrieves the eigenvectors matrix #' @rdname destiny-generics #' @export setGeneric('eigenvectors', function(object) standardGeneric('eigenvectors'), valueClass = 'matrix') #' @rdname destiny-generics #' @export setGeneric('eigenvectors<-', function(object, value) standardGeneric('eigenvectors<-')) #' @return \code{sigmas} retrieves the \code{\link{Sigmas}} from an object utilizing it as kernel width #' @rdname destiny-generics #' @export setGeneric('sigmas', function(object) standardGeneric('sigmas'), valueClass = 'Sigmas') #' @rdname destiny-generics #' @export setGeneric('sigmas<-', function(object, value) standardGeneric('sigmas<-')) #' @return \code{dataset} retrieves the data the object was created from #' @rdname destiny-generics #' @export setGeneric('dataset', function(object) standardGeneric('dataset')) #' @rdname destiny-generics #' @export setGeneric('dataset<-', function(object, value) standardGeneric('dataset<-')) #' @return \code{distance} retrieves the distance metric used to create the object, e.g. \code{euclidean} #' @rdname destiny-generics #' @export setGeneric('distance', function(object) standardGeneric('distance'), valueClass = 'character') #' @rdname destiny-generics #' @export setGeneric('distance<-', function(object, value) standardGeneric('distance<-')) #' @return \code{optimal_sigma} retrieves the numeric value of the optimal sigma or local sigmas #' @rdname destiny-generics #' @export setGeneric('optimal_sigma', function(object) standardGeneric('optimal_sigma')) destiny/R/censoring.r0000644000175200017520000000612314516010071015623 0ustar00biocbuildbiocbuildcensoring <- function(data, sigma, dists, censor_val = NULL, censor_range = NULL, missing_range = NULL, callback = invisible) { if (!is.null(censor_range)) censor_range <- matrix(censor_range, ncol = 2) if (!is.null(missing_range)) missing_range <- matrix(missing_range, ncol = 2) validate_censoring(data, sigma, dists, censor_val, censor_range, missing_range) data <- as.matrix(data) # dists is a sparse symmetrix matrix, which eigen cannot handle # so we just pass its filled triangle as sparse matrix and convert it back afterwards uplo <- dists@uplo half <- censoring_impl(data, sigma, structure(dists, class = 'dgCMatrix'), censor_val, censor_range, missing_range, callback) structure(half, class = 'dsCMatrix', uplo = uplo) } predict_censoring <- function(data, data2, censor_val = NULL, censor_range = NULL, missing_range = NULL, sigma) { if (is.null(censor_val )) censor_val <- NA # this works since this will be NaN in C++ and comparison with NaN is always false if (is.null(censor_range )) censor_range <- c(NA, NA) if (is.null(missing_range)) missing_range <- c(NA, NA) predict_censoring_impl(data, data2, censor_val, censor_range, missing_range, sigma) } #' @importFrom Matrix sparseMatrix validate_censoring <- function(data, sigma, dists, censor_val, censor_range, missing_range) { G <- ncol(data) n <- nrow(data) if (any(is.na(data)) && is.null(missing_range)) stop('Your data contains missing values (NA). You have to provide a the `missing_range` parameter.') if (is.null(censor_val) != is.null(censor_range)) stop('You have to provide both a censoring value and a censor_range or none') if (!is.null(censor_range)) { if (!is.numeric(censor_val) || (length(censor_val) != 1L && length(censor_val) != G)) stop('censor_val has to be a single numeric value, or length(censor_val) == ncol(data) must be TRUE') if (!is.numeric(censor_range) || !(nrow(censor_range) %in% c(G, 1L)) || ncol(censor_range) != 2L || any(diff(t(censor_range)) <= 0L)) stop('censor_range has to be a numeric vector of length 2, the second of which being larger, or a matrix with nrow(censor_range) == ncol(data) where each row is such a vector') } if (!is.null(missing_range)) { if (!is.numeric(missing_range) || !(nrow(missing_range) %in% c(G, 1L)) || ncol(missing_range) != 2L || any(diff(t(missing_range)) <= 0L)) stop('missing_range has to be a numeric vector of length 2, the second of which being larger, or a matrix with nrow(missing_range) == ncol(data) where each row is such a vector') } if (!is.numeric(sigma) || !length(sigma) %in% c(n, 1L)) stop('sigma has to be a single numeric value or of length nrow(data)') if (!is(dists, 'dsCMatrix')) stop('dists has to be a dsCMatrix, not ', class(dists)) } test_censoring <- function(censor_val, censor_range, data, missing_range) { if (is.null(data)) return(FALSE) has_censor_range <- !(missing(censor_range) || is.null(censor_range)) has_missing_range <- !(missing(missing_range) || is.null(missing_range)) if (has_censor_range || has_missing_range) return(TRUE) any(is.na(data)) || any(data == censor_val) } destiny/R/colorlegend.r0000644000175200017520000001141314516010071016127 0ustar00biocbuildbiocbuild#' Color legend #' #' Creates a color legend for a vector used to color a plot. It will use the current \code{\link[grDevices]{palette}()} or the specified \code{pal} as reference. #' #' When passed a factor or integer vector, it will create a discrete legend, whereas a double vector will result in a continuous bar. #' #' @param col Vector of factor, integer, or double used to determine the ticks. #' @param pal If \code{col} is double, pal is used as a continuous palette, else as categorical one #' @param log Use logarithmic scale? #' @param posx Left and right borders of the color bar relative to plot area (Vector of length 2; 0-1) #' @param posy Bottom and top borders of color bar relative to plot area (Vector of length 2; 0-1) #' @param main Legend title #' @param cex_main Size of legend title font (default: subtitle font size \code{\link{par}('cex.sub')}) #' @param cex_axis Size of ticks/category labels (default: axis font size \code{\link{par}('cex.axis')}) #' @param col_main Color of legend title (default: subtitle color \code{\link{par}('col.sub')}) #' @param col_lab Color of tick or category labels (default: axis color \code{\link{par}('col.lab')}) #' @param steps Number of labels in case of a continuous axis. If 0 or FALSE, draw no ticks #' @param steps_color Number of gradient samples in case of continuous axis #' @param digit Number of digits for continuous axis labels #' @param left logical. If TRUE, invert posx #' @param ... Additional parameters for the \link[graphics]{text} call used for labels #' @param cex.main,cex.axis,col.main,col.lab For compatibility with \code{\link{par}} #' #' @return This function is called for the side effect of adding a colorbar to a plot and returns nothing/NULL. #' #' @examples #' color_data <- 1:6 #' par(mar = par('mar') + c(0, 0, 0, 3)) #' plot(sample(6), col = color_data) #' colorlegend(color_data) #' #' @importFrom graphics par rect segments text #' @importFrom grDevices colorRampPalette palette #' @export colorlegend <- function( col, pal = palette(), log = FALSE, posx = c(.9, .93), posy = c(.05, .9), main = NULL, cex_main = par('cex.sub'), cex_axis = par('cex.axis'), col_main = par('col.sub'), col_lab = par('col.lab'), steps = 5, steps_color = 100, digit = 2, left = FALSE, ..., cex.main = NULL, cex.axis = NULL, col.main = NULL, col.lab = NULL) { draw_ticks <- as.logical(steps) if (!draw_ticks) steps <- 2L if (!is.null(cex.main)) cex_main <- cex.main if (!is.null(cex.axis)) cex_axis <- cex.axis if (!is.null(col.main)) col_main <- col.main if (!is.null(col.lab)) col_lab <- col.lab zval <- if (is.double(col)) seq(min(col, na.rm = TRUE), max(col, na.rm = TRUE), length.out = steps) else if (is.factor(col)) factor(levels(col)) else sort(unique(col)) zval_num <- if (is.integer(zval)) seq_along(zval) else if (is.numeric(zval)) zval else if (is.factor(zval) || is.character(zval)) seq_along(zval) else as.integer(zval) zlim <- if (is.double(col)) range(zval_num) else c(min(zval_num) - .5, max(zval_num) + .5) par(new = TRUE) omar <- nmar <- par('mar') nmar[c(2, 4)] <- 0 par(mar = nmar) emptyplot() pars <- par('usr') dx <- pars[[2]] - pars[[1]] xmin <- pars[[1]] + posx[[1]] * dx xmax <- pars[[1]] + posx[[2]] * dx dy <- pars[[4]] - pars[[3]] ymin <- pars[[3]] + posy[[1]] * dy ymax <- pars[[3]] + posy[[2]] * dy if (log) { zlim <- log10(zlim) zval <- log10(zval) } zmin <- zlim[[1]] zmax <- zlim[[2]] if (is.double(col)) { pal_fun <- if (is.function(pal)) pal else colorRampPalette(pal) batches <- pal_fun(steps_color) Y <- seq(ymin, ymax, length.out = length(batches) + 1) } else { idx_c <- seq(min(zval_num), max(zval_num)) idx_c[!(idx_c %in% zval_num)] <- NA batches <- pal[idx_c] Y <- seq(ymin, ymax, length.out = length(idx_c) + 1) } rect(xmin, Y[-length(Y)], xmax, Y[-1], col = batches, border = NA) rect(xmin, ymin, xmax, ymax, border = col_lab) dx <- xmax - xmin dy <- ymax - ymin if (left) { Dx <- -dx pos <- 2 xpos <- xmin + Dx * .5 } else { Dx <- +dx pos <- 4 xpos <- xmax + Dx * .5 } zval_txt <- if (is.double(col)) formatC(zval, digits = digit, format = 'fg') else zval Ypos <- ymin + (zval_num - zmin)/(zmax - zmin) * dy if (draw_ticks) { if (is.double(col)) segments(xmax, Ypos, xpos + Dx * .25, Ypos, col = col_lab) text(xpos, Ypos, zval_txt, pos = pos, col = col_lab, cex = cex_axis, ...) } if (!is.null(main)) { for (i in length(main):1) text(x = mean(c(xmin, xmax)), y = ymax + .05 * (length(main) - i + 1), labels = main[i], adj = c(.5, .5), cex = cex_main, col = col_main) } par(new = FALSE) par(mar = omar) invisible() } destiny/R/cube_helix.r0000644000175200017520000000637714516010071015756 0ustar00biocbuildbiocbuild#' Sequential color palette using the cube helix system #' #' Creates a perceptually monotonously decreasing (or increasing) lightness color palette with different tones. #' This was necessary in pre-viridis times, by now you can probably just use \code{\link[grDevices]{hcl.colors}} #' #' @param n Number of colors to return (default: 6) #' @param start Hue to start helix at (\eqn{\textrm{start} \in [0,3]}, default: 0) #' @param r Number of rotations of the helix. Can be negative. (default: 0.4) #' @param hue Saturation. 0 means greyscale, 1 fully saturated colors (default: 0.8) #' @param gamma Emphasize darker (gamma < 1) or lighter (gamma > 1) colors (default: 1) #' @param light Lightest lightness (default: 0.85) #' @param dark Darkest lightness (default: 0.15) #' @param reverse logical. If TRUE, reverse lightness (default: FALSE) #' @param discrete If TRUE, return a discrete scale, if FALSE a continuous one (default: TRUE) #' @param guide Type of scale guide to use. See \code{\link[ggplot2]{guides}} #' @param ... parameters passed to \code{\link[ggplot2]{discrete_scale}} or \code{\link[ggplot2]{continuous_scale}} #' #' @return A \code{character} vector of hex colors with length \code{n} #' #' @examples #' palette(cube_helix()) #' image(matrix(1:6), col = 1:6, pch = 19, axes = FALSE) #' #' cr <- scales::colour_ramp(cube_helix(12, r = 3)) #' r <- runif(100) #' plot(1:100, r, col = cr(r), type = 'b', pch = 20) #' #' @importFrom grDevices rgb #' @export cube_helix <- function(n = 6, start = 0, r = .4, hue = .8, gamma = 1, light = .85, dark = .15, reverse = FALSE) { M <- matrix(c(-.14861, -.29227, 1.97294, 1.78277, -.90649, 0), ncol = 2) lambda <- seq(light, dark, length.out = n) if (reverse) lambda <- rev(lambda) l <- rep(lambda ^ gamma, each = 3) phi <- 2 * pi * (start/3 + r * lambda) t <- rbind(cos(phi), sin(phi)) out <- l + hue * l * (1 - l)/2 * (M %*% t) out <- pmin(pmax(out, 0), 1) out <- apply(out, 2, function(x) rgb(x[[1]], x[[2]], x[[3]])) out } scale_cube_helix <- function(aesthetics, start, r, hue, gamma, light, dark, reverse, discrete, guide, ...) { if (!requireNamespace('ggplot2', quietly = TRUE)) stop('scale_', aesthetics, '_cube_helix needs (and is only useful for) the ggplot2 package') f <- function(n) cube_helix(n, start, r, hue, gamma, light, dark, reverse) if (discrete) { ggplot2::discrete_scale(aesthetics, 'cube_helix', f, ..., guide = guide) } else { ggplot2::continuous_scale(aesthetics, 'cube_helix', scales::gradient_n_pal(f(100)), guide = guide, ...) } } #' @rdname cube_helix #' @export scale_colour_cube_helix <- function(..., start = 0, r = .4, hue = .8, gamma = 1, light = .85, dark = .15, reverse = FALSE, discrete = TRUE, guide = if (discrete) 'legend' else 'colourbar' ) { scale_cube_helix('colour', start, r, hue, gamma, light, dark, reverse, discrete, guide, ...) } #' @rdname cube_helix #' @export scale_color_cube_helix <- scale_colour_cube_helix #' @rdname cube_helix #' @export scale_fill_cube_helix <- function(..., start = 0, r = .4, hue = .8, gamma = 1, light = .85, dark = .15, reverse = FALSE, discrete = TRUE, guide = if (discrete) 'legend' else 'colourbar' ) { scale_cube_helix('fill', start, r, hue, gamma, light, dark, reverse, discrete, guide, ...) } destiny/R/dataset-helpers.r0000644000175200017520000000706114516010071016723 0ustar00biocbuildbiocbuild#' @importFrom methods is #' @importFrom Biobase exprs #' @importFrom SummarizedExperiment assay colData dataset_extract_doublematrix <- function(data, vars = NULL) { if (is.data.frame(data)) { if (is.null(vars)) { data <- data[, sapply(data, is.double)] } else { # If we have a data frame subset early, before matrix conversion data <- data[, vars] vars <- NULL } data <- as.matrix(data) } else if (is(data, 'ExpressionSet')) { data <- t(exprs(data)) } else if (is(data, 'SingleCellExperiment')) { #TODO: allow other name? data <- t(assay(data, 'logcounts')) } else if (!is.matrix(data)) { stop('Data needs to be matrix, data.frame, ExpressionSet, or SingleCellExperiment') } dupes <- duplicated(data) if (any(dupes)) { data <- data[!dupes, ] warning('Duplicate rows removed from data. Consider explicitly using `df[!duplicated(df), ]`') } if (!is.null(vars)) data <- data[, vars] data } #' @importFrom Biobase sampleNames dataset_n_observations <- function(data, distances) { if (is.null(data)) nrow(distances) else if (is(data, 'ExpressionSet')) length(sampleNames(data)) else if (is(data, 'SingleCellExperiment')) ncol(data) else nrow(data) } #' @importFrom Biobase featureNames dataset_n_features <- function(data, distances = NULL, vars = NULL) { if (is.null(data)) ncol(distances) else if (is(data, 'ExpressionSet')) length(featureNames(data)) else if (is(data, 'SingleCellExperiment')) nrow(data) else if (!is.null(vars)) ncol(data[, vars]) else if (is.data.frame(data)) ncol(data[, sapply(data, is.double)]) else ncol(data) } #' @importFrom methods canCoerce #' @importFrom utils getS3method dataset_to_df <- function(dta, row.names = NULL, optional = FALSE, ...) { # The ExpressionSet as.data.frame sucks if (is(dta, 'ExpressionSet')) { cbind(as.data.frame(t(exprs(dta)), row.names, optional, ...), pData(dta)) } else if (is(dta, 'SingleCellExperiment')) { smp_meta <- as.data.frame(colData(dta), row.names, optional, ...) #TODO: allow other name? mat <- assay(dta, 'logcounts') if (is(mat, 'sparseMatrix')) { n_genes_max <- getOption('destiny.genes.max', 5000L) if (nrow(mat) > n_genes_max) { warning( 'Data has too many genes to convert it to a data.frame (', nrow(mat), ' > ', n_genes_max, '). You can try setting options(destiny.genes.max = ...)') return(smp_meta) } else { mat <- as.matrix(mat) } } cbind(as.data.frame(t(mat), row.names, optional, ...), smp_meta) } else if (canCoerce(dta, 'data.frame')) { as(dta, 'data.frame') } else if (!is.null(getS3method('as.data.frame', class(dta)[[1L]], optional = TRUE))) { as.data.frame(dta, row.names, optional, ...) } else NULL } dataset_names <- function(dta) { if (is(dta, 'ExpressionSet')) { c(featureNames(dta), varLabels(dta)) } else if (is(dta, 'SingleCellExperiment')) { c(rownames(dta), colnames(colData(dta))) } else { colnames(dta) } } #' @importFrom Biobase featureNames exprs dataset_get_feature <- function(dta, f) { force(f) # else dta[, f] would be dta[, ] and valid tryCatch({ if (is(dta, 'ExpressionSet') && f %in% featureNames(dta)) { exprs(dta)[f, ] } else if (is(dta, 'SingleCellExperiment') && f %in% rownames(dta)) { #TODO: allow other name? assay(dta, 'logcounts')[f, ] } else if (is(dta, 'ExpressionSet') || is(dta, 'SingleCellExperiment') || is.data.frame(dta)) { # data.frame or phenoData/colData dta[[f]] } else { dta[, f] } }, error = function(e) stop(sprintf('Invalid `%s`: No column, annotation, or feature found with name %s', deparse(substitute(f)), dQuote(f)))) } destiny/R/destiny-package.r0000644000175200017520000000063314516010071016704 0ustar00biocbuildbiocbuild#' Create and plot diffusion maps #' #' The main function is \code{\link{DiffusionMap}}, which returns an object you can \code{\link{plot}} (\code{\link{plot.DiffusionMap}} is then called). #' #' @examples #' demo(destiny, ask = FALSE) #' #' @docType package #' @name destiny #' ## Make sure Rcpp and RcppEigen are loaded #' @importFrom Rcpp evalCpp #' @importFrom RcppEigen RcppEigen.package.skeleton NULL destiny/R/diffusionmap-methods-accession.r0000644000175200017520000000443614516010071021733 0ustar00biocbuildbiocbuild#' @include accessor-generics.r NULL #' DiffusionMap accession methods #' #' Get and set eigenvalues, eigenvectors, and sigma(s) of a \link{DiffusionMap} object. #' #' @param object A DiffusionMap #' @param value Vector of eigenvalues or matrix of eigenvectors to get/set #' #' @return The assigned or retrieved value #' #' @seealso \link{Extraction methods}, \link{DiffusionMap methods}, \link{Coercion methods} for more #' #' @examples #' data(guo) #' dm <- DiffusionMap(guo) #' eigenvalues(dm) #' eigenvectors(dm) #' sigmas(dm) #' dataset(dm) #' optimal_sigma(dm) #' #' @importFrom methods is setGeneric #' @name DiffusionMap accession methods #' @rdname DiffusionMap-accessors #' @include sigmas.r #' @include diffusionmap.r NULL #' @rdname DiffusionMap-accessors #' @export setMethod('eigenvalues', 'DiffusionMap', function(object) object@eigenvalues) #' @rdname DiffusionMap-accessors #' @export setMethod('eigenvalues<-', 'DiffusionMap', function(object, value) { object@eigenvalues <- value object }) #' @rdname DiffusionMap-accessors #' @export setMethod('eigenvectors', 'DiffusionMap', function(object) object@eigenvectors) #' @rdname DiffusionMap-accessors #' @export setMethod('eigenvectors<-', 'DiffusionMap', function(object, value) { object@eigenvectors <- value validObject(object) object }) #' @rdname DiffusionMap-accessors #' @export setMethod('sigmas', 'DiffusionMap', function(object) object@sigmas) #' @rdname DiffusionMap-accessors #' @export setMethod('sigmas<-', 'DiffusionMap', function(object, value) { object@sigmas <- value validObject(object) object }) #' @rdname DiffusionMap-accessors #' @export setMethod('dataset', 'DiffusionMap', function(object) object@data_env$data) #' @rdname DiffusionMap-accessors #' @export setMethod('dataset<-', 'DiffusionMap', function(object, value) { object@data_env$data <- value validObject(object) object }) #' @rdname DiffusionMap-accessors #' @export setMethod('distance', 'DiffusionMap', function(object) object@distance) #' @rdname DiffusionMap-accessors #' @export setMethod('distance<-', 'DiffusionMap', function(object, value) { object@distance <- value validObject(object) object }) #' @rdname DiffusionMap-accessors #' @export setMethod('optimal_sigma', 'DiffusionMap', function(object) optimal_sigma(sigmas(object))) destiny/R/diffusionmap-methods.r0000644000175200017520000000233714516010071017764 0ustar00biocbuildbiocbuild#' DiffusionMap methods #' #' Methods for external operations on diffusion maps #' #' @param x,object A \code{\link{DiffusionMap}} #' #' @return The \code{DiffusionMap} object (\code{print}), or NULL (\code{show}), invisibly #' #' @seealso \link{DiffusionMap accession methods}, \link{Extraction methods}, \link{Coercion methods} for more #' #' @examples #' data(guo) #' dm <- DiffusionMap(guo) #' print(dm) #' show(dm) #' #' @aliases print.DiffusionMap show.DiffusionMap #' @name DiffusionMap methods #' @rdname DiffusionMap-methods NULL #' @importFrom utils str #' #' @rdname DiffusionMap-methods #' @export setMethod('print', 'DiffusionMap', function(x) { cat(sprintf('DiffusionMap (%s Diffusion components and %s observations)\n', length(eigenvalues(x)), nrow(eigenvectors(x)))) cat('eigenvalues: '); str(eigenvalues(x)) cat('eigenvectors: '); str(structure(eigenvectors(x), dimnames = NULL)) cat(' ..colnames: '); str(colnames(eigenvectors(x)), vec.len = 4) cat('optimal_sigma: '); str(optimal_sigma(x)) cat('distance: '); str(distance(x)) invisible(x) }) #' @importFrom methods show #' #' @rdname DiffusionMap-methods #' @export setMethod('show', 'DiffusionMap', function(object) { print(object) invisible() }) destiny/R/diffusionmap-plotting.r0000644000175200017520000002653714516010071020171 0ustar00biocbuildbiocbuild#' @include diffusionmap.r #' @include plothelpers.r NULL #' 3D or 2D plot of diffusion map #' #' If you want to plot the eigenvalues, simply \code{plot(eigenvalues(dm)[start:end], ...)} #' #' If you specify negative numbers as diffusion components (e.g. \code{plot(dm, c(-1,2))}), then the corresponding components will be flipped. #' #' @param x A \link{DiffusionMap} #' @param dims,y Diffusion components (eigenvectors) to plot (default: first three components; 1:3) #' @param new_dcs An optional matrix also containing the rows specified with \code{y} and plotted. (default: no more points) #' @param new_data A data set in the same format as \code{x} that is used to create \code{new_dcs <- \link{dm_predict}(dif, new_data)} #' @param col Single color string or vector of discrete or categoric values to be mapped to colors. #' E.g. a column of the data matrix used for creation of the diffusion map. (default: \code{\link[igraph]{cluster_louvain}} if igraph is installed) #' @param col_by Specify a \code{dataset(x)} or \code{phenoData(dataset(x))} column to use as color #' @param col_limits If \code{col} is a continuous (=double) vector, this can be overridden to map the color range differently than from min to max (e.g. specify \code{c(0, 1)}) #' @param col_new If \code{new_dcs} is given, it will take on this color. A vector is also possible. (default: red) #' @param pal Palette used to map the \code{col} vector to colors. (default: use \code{\link{hcl.colors}} for continuous and \code{\link{palette}()} for discrete data) #' @param pal_new Palette used to map the \code{col_new} vector to colors. (default: see \code{pal} argument) #' @param ... Parameters passed to \link{plot}, \link[scatterplot3d]{scatterplot3d}, or \link[rgl]{plot3d} (if \code{interactive == TRUE}) #' @param ticks logical. If TRUE, show axis ticks (default: FALSE) #' @param axes logical. If TRUE, draw plot axes (default: Only if \code{ticks} is TRUE) #' @param box logical. If TRUE, draw plot frame (default: TRUE or the same as \code{axes} if specified) #' @param legend_main Title of legend. (default: nothing unless \code{col_by} is given) #' @param legend_opts Other \link{colorlegend} options (default: empty list) #' @param interactive Use \link[rgl]{plot3d} to plot instead of \link[scatterplot3d]{scatterplot3d}? #' @param draw_legend logical. If TRUE, draw color legend (default: TRUE if \code{col_by} is given or \code{col} is given and a vector to be mapped) #' @param consec_col If \code{col} or \code{col_by} refers to an integer column, with gaps (e.g. \code{c(5,0,0,3)}) use the palette color consecutively (e.g. \code{c(3,1,1,2)}) #' @param col_na Color for \code{NA} in the data. specify \code{NA} to hide. #' @param plot_more Function that will be called while the plot margins are temporarily changed #' (its \code{p} argument is the rgl or scatterplot3d instance or NULL, #' its \code{rescale} argument is \code{NULL}, a \code{list(from = c(a, b), to = c(c, d))}), #' or an array of shape \eqn{from|to \times dims \times min|max}, i.e. \eqn{2 \times length(dims) \times 2}. #' In case of 2d plotting, it should take and return a ggplot2 object. #' #' @return The return value of the underlying call is returned, i.e. a scatterplot3d or rgl object. #' #' @examples #' data(guo) #' plot(DiffusionMap(guo)) #' #' @aliases plot.DiffusionMap #' #' @importFrom graphics par axis plot plot.new #' @importFrom stats setNames #' @importFrom grDevices palette hcl.colors #' @importFrom scatterplot3d scatterplot3d #' @importFrom ggplot2 ggplot aes aes_string #' @importFrom ggplot2 geom_point #' @importFrom ggplot2 theme theme_minimal element_blank element_line element_text element_rect #' @importFrom ggplot2 scale_fill_identity scale_fill_manual scale_fill_gradientn scale_fill_identity #' @importFrom ggplot2 scale_x_continuous scale_y_continuous #' @importFrom ggplot2 guide_colourbar guide_legend #' @importFrom ggthemes geom_rangeframe extended_range_breaks #' #' @rdname plot.DiffusionMap #' @export plot.DiffusionMap <- function( x, dims = 1:3, new_dcs = if (!is.null(new_data)) dm_predict(x, new_data), new_data = NULL, col = NULL, col_by = NULL, col_limits = NULL, col_new = 'red', pal = NULL, pal_new = NULL, ..., ticks = FALSE, axes = TRUE, box = FALSE, legend_main = col_by, legend_opts = list(), interactive = FALSE, draw_legend = !is.null(col_by) || (length(col) > 1 && !is.character(col)), consec_col = TRUE, col_na = 'grey', plot_more = function(p, ..., rescale = NULL) p ) { dif <- x is_projection <- !is.null(new_dcs) && is.character(col_new) && length(col_new) == 1L if (interactive) { if (!requireNamespace('rgl', quietly = TRUE)) stop(sprintf('The package %s is required for interactive plots', sQuote('rgl'))) if (length(dims) != 3L) stop('Only 3d plots can be made interactive') } if (!is.null(col) && !is.null(col_by)) stop('Only specify one of col or col_by') if (!is.null(col_by)) { col <- dataset_get_feature(dataset(dif), col_by) } else if (is.null(col)) { if (requireNamespace('igraph', quietly = TRUE)) { col <- get_louvain_clusters(dif@transitions) col_by <- legend_main <- 'Louvain' } else { col <- par('col') } } continuous <- is.double(col) if (is_projection) { projection_guide <- setNames(c(col, col_new), c(paste(legend_main, col), rep_len('new', length(col_new)))) legend_main <- 'Projection' } col_legend <- if (continuous && !is.null(col_limits)) col_limits else col # use a fitting default palette if (is.null(pal)) { pal <- if (is.double(col)) hcl.colors else palette() } # make consecutive the colors for the color legend if (is.integer(col) && consec_col) { # c(5,0,0,3) -> c(3,1,1,2) col <- factor(col) } point_data <- cbind( as.data.frame(flipped_dcs(eigenvectors(dif), dims)), Colour = col, ColourExpl = get_explicit_col(col, pal, col_na, col_limits), Projection = factor(rep('old', nrow(eigenvectors(dif))), c('old', 'new'))) rm(col) if (!is.null(new_dcs)) { point_data <- rbind(point_data, cbind( as.data.frame(flipped_dcs(new_dcs, dims)), Colour = col_new, #TODO ColourExpl = get_explicit_col(col_new, pal_new, col_na, col_limits), Projection = 'new' )) col_legend } lvl_fn <- if (is.factor(point_data$Colour)) levels else unique col_lvls <- na.omit(as.character(lvl_fn(point_data$Colour))) col_breaks <- point_data$ColourExpl[match(col_lvls, point_data$Colour)] is_one_colour <- length(col_lvls) == 1L if (length(dims) == 2) { d1 <- names(point_data)[[1L]] d2 <- names(point_data)[[2L]] use_mapping <- continuous || is_projection || !is.null(col_by) p <- ggplot(point_data, aes_string(d1, d2)) + theme_really_minimal() + geom_point( aes_string(fill = if (use_mapping) 'Colour' else 'ColourExpl'), colour = I('#00000000'), shape = I(21)) nomap_guide <- if (is_one_colour) 'none' else 'legend' p <- p + if (is_projection) scale_fill_identity (name = legend_main, guide = 'legend', labels = names(projection_guide), breaks = projection_guide, na.value = col_na) else if (!use_mapping) scale_fill_identity (name = legend_main, guide = nomap_guide, labels = col_lvls, breaks = col_breaks, na.value = col_na) else if (continuous) scale_fill_gradientn(name = legend_main, colours = if (is.function(pal)) pal(100) else pal, na.value = col_na) else scale_fill_manual (name = legend_main, values = if (is.function(pal)) pal(length(col_lvls)) else pal[seq_along(col_lvls)], breaks = col_lvls, labels = col_lvls, na.value = col_na) if (box) p <- p + theme(panel.border = element_rect(fill = NA), axis.title.x = element_text(), axis.title.y = element_text()) if (ticks) p <- p + theme(axis.ticks = element_line(), axis.text.x = element_text(), axis.text.y = element_text()) if (axes) p <- p + geom_rangeframe(colour = par('col')) if (ticks && axes && !box) p <- p + scale_x_continuous(breaks = extended_range_breaks()(point_data[[1L]])) + scale_y_continuous(breaks = extended_range_breaks()(point_data[[2L]])) p <- plot_more(p, rescale = NULL) } else if (length(dims) == 3L) { if (interactive) { p <- rgl::plot3d(point_data, ..., col = point_data$ColourExpl, axes = FALSE, box = FALSE) if (axes || ticks) { axtype = if (axes) 'lines' else 'cull' nticks = if (ticks) 5 else 0 rgl::bbox3d(xlen = nticks, ylen = nticks, zlen = nticks, front = axtype, back = axtype) } if (box) rgl::box3d() plot_more(p, rescale = NULL) } else { rescale <- NULL if (!ticks) { rescale <- array(NA, c(2L, length(dims), 2L), list(c('from', 'to'), as.character(dims), c('min', 'max'))) for (d in seq_along(dims)) { # -> scatterplot3d's pretty() should not mess things up r <- range(point_data[, d]) point_data[, d] <- scales::rescale(point_data[, d], c(0, 1), r) rescale['from', d, ] <- r rescale['to', d, ] <- c(0, 1) } } mar <- list(...)$mar if (is.null(mar)) mar <- par('mar') old_mar <- mar; on.exit(par(mar = old_mar)) if (draw_legend) mar[[4]] <- mar[[4]] + 5 p <- scatterplot3d( point_data[, 1:3], ..., color = point_data$ColourExpl, mar = mar, axis = axes || box || ticks, lty.axis = if (axes || box) 'solid' else 'blank', box = box, tick.marks = ticks) rm(mar) plot_more(p, rescale = rescale) if (draw_legend) { args <- c(list(col_legend, pal = pal, main = legend_main), legend_opts) if (interactive) { rgl::bgplot3d({ plot.new() do.call(colorlegend, args) }) } else { do.call(colorlegend, args) } } } } else stop(sprintf('dims is of wrong length (%s): Can only handle 2 or 3 dimensions', dims)) if (length(dims) == 2) p else invisible(p) } get_explicit_col <- function(col, pal, col_na, col_limits) { # if nothing is given, return one colour if (is.null(col)) return(par('col')) # if we have continuous colour, we are done. if (is.double(col)) return(continuous_colors(col, pal, col_limits)) # get palette length and convert col to consecutive integers length_pal <- if (is.factor(col)) length(levels(col)) else if (is.integer(col)) length(unique(col)) else stopifnot(is.character(col)) if (is.factor(col)) col <- as.integer(col) # map integers to strings if necessary if (is.integer(col)) { if (is.function(pal)) { # pal is a colorRampPalette-type function pal <- pal(length_pal) } else { # pal is a vector length_pal <- min(length(pal), length_pal) pal <- pal[seq_len(length_pal)] } idx_wrapped <- ((col - 1L) %% length_pal) + 1L col <- pal[idx_wrapped] col[is.na(col)] <- col_na } # if the color wasn’t numeric, use as is col } theme_really_minimal <- function(...) theme_minimal() + theme(axis.text.x = element_blank(), axis.text.y = element_blank(), ...) # test: # layout(matrix(1:8, 2)) # mapply(function(t, a, b) plot(dif, ticks = t, axes = a, box = b, main = sprintf('t=%s a=%s b=%s', t, a, b)), # c(T,T,T,T,F,F,F,F), c(T,F,T,F,T,F,T,F), c(T,T,F,F,T,T,F,F)) #' @rdname plot.DiffusionMap #' @export setMethod('plot', c(x = 'DiffusionMap', y = 'numeric'), function(x, y, ...) plot.DiffusionMap(x, y, ...)) #' @rdname plot.DiffusionMap #' @export setMethod('plot', c(x = 'DiffusionMap', y = 'missing'), function(x, y, ...) plot(x, seq_len(min(3L, ncol(eigenvectors(x)))), ...)) destiny/R/diffusionmap.r0000644000175200017520000004503214516010071016322 0ustar00biocbuildbiocbuild#' @include sigmas.r #' @include s4-unions.r #' @useDynLib destiny NULL sigma_msg <- function(sigma) sprintf( "The sigma parameter needs to be NULL, 'local', 'global', numeric or a %s object, not a %s.", sQuote('Sigmas'), sQuote(class(sigma))) #' Create a diffusion map of cells #' #' The provided data can be a double \link[base]{matrix} of expression data or a \link[base]{data.frame} with all non-integer (double) columns #' being treated as expression data features (and the others ignored), an \link[Biobase:class.ExpressionSet]{ExpressionSet}, or a \link[SingleCellExperiment]{SingleCellExperiment}. #' #' @param data Expression data to be analyzed and covariates. Provide \code{vars} to select specific columns other than the default: all double value columns. #' If \code{distance} is a distance matrix, \code{data} has to be a \code{\link{data.frame}} with covariates only. #' @param sigma Diffusion scale parameter of the Gaussian kernel. One of \code{'local'}, \code{'global'}, a (\link[base]{numeric}) global sigma or a \link{Sigmas} object. #' When choosing \code{'global'}, a global sigma will be calculated using \code{\link{find_sigmas}}. (Optional. default: \code{'local'}) #' A larger sigma might be necessary if the eigenvalues can not be found because of a singularity in the matrix #' @param k Number of nearest neighbors to consider (default: a guess betweeen 100 and \eqn{n - 1}. See \code{\link{find_dm_k}}). #' @param n_eigs Number of eigenvectors/values to return (default: 20) #' @param density_norm logical. If TRUE, use density normalisation #' @param ... Unused. All parameters to the right of the \code{...} have to be specified by name (e.g. \code{DiffusionMap(data, distance = 'cosine')}) #' @param distance Distance measurement method applied to \code{data} or a distance matrix/\code{\link[stats]{dist}}. For the allowed values, see \code{\link{find_knn}}. #' If this is a \code{\link[Matrix]{sparseMatrix}}, zeros are interpreted as "not a close neighbors", #' which allows the use of kNN-sparsified matrices (see the return value of \code{\link{find_knn}}. #' @param n_pcs Number of principal components to compute to base calculations on. Using e.g. 50 DCs results in more regular looking diffusion maps. #' The default NULL will not compute principal components, but use \code{reducedDims(data, 'pca')} if present. Set to NA to suppress using PCs. #' @param n_local If \code{sigma == 'local'}, the \code{n_local}th nearest neighbor(s) determine(s) the local sigma #' @param rotate logical. If TRUE, rotate the eigenvalues to get a slimmer diffusion map #' @param censor_val Value regarded as uncertain. Either a single value or one for every dimension (Optional, default: censor_val) #' @param censor_range Uncertainity range for censoring (Optional, default: none). A length-2-vector of certainty range start and end. TODO: also allow \eqn{2\times G} matrix #' @param missing_range Whole data range for missing value model. Has to be specified if NAs are in the data #' @param vars Variables (columns) of the data to use. Specifying NULL will select all columns (default: All floating point value columns) #' @param knn_params Parameters passed to \code{\link{find_knn}} #' @param verbose Show a progressbar and other progress information (default: do it if censoring is enabled) #' @param suppress_dpt Specify TRUE to skip calculation of necessary (but spacious) information for \code{\link{DPT}} in the returned object (default: FALSE) #' #' @return A DiffusionMap object: #' #' @slot eigenvalues Eigenvalues ranking the eigenvectors #' @slot eigenvectors Eigenvectors mapping the datapoints to \code{n_eigs} dimensions #' @slot sigmas \link{Sigmas} object with either information about the \link{find_sigmas} heuristic run or just local or \link{optimal_sigma}. #' @slot data_env Environment referencing the data used to create the diffusion map #' @slot eigenvec0 First (constant) eigenvector not included as diffusion component. #' @slot transitions Transition probabilities. Can be NULL #' @slot d Density vector of transition probability matrix #' @slot d_norm Density vector of normalized transition probability matrix #' @slot k The k parameter for kNN #' @slot n_pcs Number of principal components used in kNN computation (NA if raw data was used) #' @slot n_local The \code{n_local}th nearest neighbor(s) is/are used to determine local kernel density #' @slot density_norm Was density normalization used? #' @slot rotate Were the eigenvectors rotated? #' @slot distance Distance measurement method used #' @slot censor_val Censoring value #' @slot censor_range Censoring range #' @slot missing_range Whole data range for missing value model #' @slot vars Vars parameter used to extract the part of the data used for diffusion map creation #' @slot knn_params Parameters passed to \code{\link{find_knn}} #' #' @seealso \link{DiffusionMap methods} to get and set the slots. \code{\link{find_sigmas}} to pre-calculate a fitting global \code{sigma} parameter #' #' @examples #' data(guo) #' DiffusionMap(guo) #' DiffusionMap(guo, 13, censor_val = 15, censor_range = c(15, 40), verbose = TRUE) #' #' covars <- data.frame(covar1 = letters[1:100]) #' dists <- dist(matrix(rnorm(100*10), 100)) #' DiffusionMap(covars, distance = dists) #' #' @importFrom methods setClass validObject #' @rdname DiffusionMap-class #' @export setClass( 'DiffusionMap', slots = c( eigenvalues = 'numeric', eigenvectors = 'matrix', sigmas = 'Sigmas', data_env = 'environment', eigenvec0 = 'numeric', transitions = 'dMatrixOrNULL', d = 'numeric', d_norm = 'numeric', k = 'integer', n_pcs = 'integer', n_local = 'integer', density_norm = 'logical', rotate = 'logical', distance = 'character', censor_val = 'numericOrNULL', censor_range = 'numericOrNULL', missing_range = 'numericOrNULL', vars = 'characterOrnumericOrNULL', knn_params = 'list'), validity = function(object) { # don't use getters as thisfunction is used in them! if (!is.vector(object@eigenvalues) || !is.numeric(object@eigenvalues)) 'eigenvalues(dm) has to be a numeric vector' else if (!is.matrix(object@eigenvectors) || !is.numeric(object@eigenvectors)) 'eigenvectors(dm) has to be a numeric matrix' else if (length(object@eigenvalues) != ncol(object@eigenvectors)) 'There must be exactly one eigenvalue per eigenvector: length(eigenvalues(dm)) == ncol(eigenvectors(dm))' else if (!isTRUE(validObject(object@sigmas, test = TRUE))) paste('sigmas invalid:', validObject(object@sigmas, test = TRUE)) #TODO: validate data_env (data, accumulated_transitions) and eigenvec0 else if (length(object@d) != nrow(object@eigenvectors)) 'd must be as long as each eigenvector' else if (length(object@k) != 1) 'k must be a number' else if (length(object@density_norm) != 1) 'density_norm must be TRUE or FALSE' else if (length(object@rotate) != 1) 'rotate must be TRUE or FALSE' else if (!(object@distance %in% c('euclidean', 'cosine', 'rankcor', 'l2', 'custom'))) 'distance must be "euclidean", "cosine", "rankcor", or "l2"' else if (is.null(object@censor_val) != is.null(object@censor_range)) 'Both censor_val and censor_range either need to be NULL or not' else if (!is.null(object@censor_val) && length(object@censor_val) != 1) 'censor_val must be a number' else if (!is.null(object@censor_range) && (length(object@censor_range) != 2 || diff(object@censor_range) <= 0)) 'censor_range must be a increasing range (two numbers, the left one being larger)' else if (!is.null(object@missing_range) && (length(object@missing_range) != 2 || diff(object@missing_range) <= 0)) 'missing_range must be a increasing range (two numbers, the left one being larger)' #TODO validate vars else TRUE }) #' @importFrom methods new as is #' @importFrom Matrix Diagonal colSums rowSums t #' @importFrom VIM hotdeck #' @importFrom SingleCellExperiment reducedDimNames reducedDim<- #' @rdname DiffusionMap-class #' @export DiffusionMap <- function( data = stopifnot_distmatrix(distance), sigma = 'local', k = find_dm_k(dataset_n_observations(data, distance) - 1L), n_eigs = min(20L, dataset_n_observations(data, distance) - 2L), density_norm = TRUE, ..., distance = c('euclidean', 'cosine', 'rankcor', 'l2'), n_pcs = NULL, n_local = seq(to = min(k, 7L), length.out = min(k, 3L)), rotate = FALSE, censor_val = NULL, censor_range = NULL, missing_range = NULL, vars = NULL, knn_params = list(), verbose = !is.null(censor_range), suppress_dpt = FALSE ) { # make sure those promises are resolved before we mess with `data` force(k) force(n_eigs) chkDots(...) if (is.null(sigma) || !is(sigma, 'Sigmas') && isTRUE(is.na(sigma))) sigma <- 'local' if (!is(sigma, 'Sigmas') && !(length(sigma) == 1L && sigma %in% c('local', 'global')) && !is.numeric(sigma)) stop(sigma_msg(sigma)) if (identical(sigma, 'local') && any(n_local > k)) stop('For local sigma, All entries of n_local (', paste(n_local, collapse = ','), ') have to be \u2264 k (', k, ')') # store away data and continue using imputed, unified version data_env <- new.env(parent = .GlobalEnv) if (is_distmatrix(distance)) { if (!(is.data.frame(data) || is.null(data))) stop('If you provide a matrix for `distance`, `data` has to be NULL or a covariate `data.frame` is of class', class(data)) if (!is.null(n_pcs)) stop('If you provide a matrix for `distance`, `n_pcs` has to be NULL') data_env$data <- if (is.null(data)) distance else data # put covariates or distance dists <- as(distance, 'symmetricMatrix') if (!is.null(rownames(data_env$data))) rownames(dists) <- colnames(dists) <- rownames(data) distance <- 'custom' imputed_data <- data_or_pca <- NULL n <- nrow(dists) } else { dists <- NULL distance <- match.arg(distance) data_env$data <- data data <- dataset_extract_doublematrix(data, vars) imputed_data <- data if (anyNA(imputed_data)) imputed_data <- as.matrix(hotdeck(data, imp_var = FALSE)) n <- nrow(imputed_data) # PCA pca <- get_pca(imputed_data, data_env$data, n_pcs, verbose) if (is.null(pca) && ncol(imputed_data) > 500L) { warning('You have ', ncol(imputed_data), ' genes. Consider passing e.g. n_pcs = 50 to speed up computation.') } if (is.null(pca)) { n_pcs <- NA_integer_ data_or_pca <- imputed_data } else { n_pcs <- ncol(pca) data_or_pca <- pca # Update PCA in SCE if there was none if (is(data_env$data, 'SingleCellExperiment') && !('pca' %in% reducedDimNames(data_env$data))) reducedDim(data_env$data, 'pca') <- pca } } # arg validation if (n <= n_eigs + 1L) stop('Eigen decomposition not possible if n \u2264 n_eigs+1 (And ', n,' \u2264 ', n_eigs + 1L, ')') if (is.null(k) || is.na(k)) k <- n - 1L #TODO: optimize case #dense <- k == n - 1L if (k >= n) stop(sprintf('k has to be < nrow(data) (And %s \u2265 nrow(data))', k)) censor <- test_censoring(censor_val, censor_range, imputed_data, missing_range) if (censor && !identical(distance, 'euclidean')) stop('censoring model only valid with euclidean distance') knn <- get_knn(data_or_pca, dists, k, distance, knn_params, verbose) # use dists if given, else compute from pca if available, else from data sigmas <- get_sigmas(imputed_data, knn$dist, sigma, n_local, distance, censor_val, censor_range, missing_range, vars, verbose) sigma <- optimal_sigma(sigmas) # single number = global, multiple = local trans_p <- transition_probabilities(imputed_data, sigma, knn$dist_mat, censor, censor_val, censor_range, missing_range, verbose) rm(knn) # free memory d <- rowSums(trans_p, na.rm = TRUE) + 1 # diagonal set to 1 # normalize by density if requested norm_p <- get_norm_p(trans_p, d, d, density_norm) rm(trans_p) # free memory d_norm <- rowSums(norm_p) # calculate the inverse of a diagonal matrix by inverting the diagonal d_rot <- Diagonal(x = d_norm ^ -.5) transitions <- as(d_rot %*% norm_p %*% d_rot, 'symmetricMatrix') rm(norm_p) # free memory eig_transitions <- decomp_transitions(transitions, n_eigs + 1L, verbose) eig_vec <- eig_transitions$vectors eig_val <- eig_transitions$values if (rotate) eig_vec <- as.matrix(t(t(eig_vec) %*% d_rot)) rownames(eig_vec) <- rownames(transitions) <- colnames(transitions) <- rownames(if (!is.null(rownames(dists))) dists else data) colnames(eig_vec) <- names(eig_val) <- paste0('DC', seq(0, n_eigs)) new( 'DiffusionMap', eigenvalues = eig_val[-1], eigenvectors = eig_vec[, -1, drop = FALSE], sigmas = sigmas, data_env = data_env, eigenvec0 = eig_vec[, 1], transitions = if (suppress_dpt) NULL else transitions, d = d, d_norm = d_norm, k = as.integer(k), n_pcs = as.integer(n_pcs), n_local = as.integer(n_local), rotate = rotate, density_norm = density_norm, distance = distance, censor_val = censor_val, censor_range = censor_range, missing_range = missing_range, knn_params = knn_params) } is_distmatrix <- function(distance) { if (is.character(distance)) FALSE else if ((is.matrix(distance) && diff(dim(distance)) == 0L) || is(distance, 'dist') || is(distance, 'symmetricMatrix')) TRUE else stop( '`distance` needs to be a distance measure or a square matrix, but is a ', class(dist), ' of dim ', nrow(distance), ' by ', ncol(distance)) } stopifnot_distmatrix <- function(distance) { if (is_distmatrix(distance)) NULL else stop('`data`` needs to be set if `distance` is a distance measure') } #' @importFrom methods new is get_sigmas <- function(imputed_data, nn_dists, sigma, n_local, distance = 'euclidean', censor_val = NULL, censor_range = NULL, missing_range = NULL, vars = NULL, verbose = FALSE) { unspecified_local <- identical(sigma, 'local') if (unspecified_local || is.numeric(sigma)) { if (unspecified_local) { sig_mat <- nn_dists[, n_local, drop = FALSE] sigma <- rowSums(sig_mat) / length(n_local) / 2 } new('Sigmas', log_sigmas = NULL, dim_norms = NULL, optimal_sigma = sigma, optimal_idx = NULL, avrd_norms = NULL) } else if (identical(sigma, 'global')) { if (!identical(distance, 'euclidean')) stop(sprintf('You have to use euclidean distances with sigma estimation, not %s.', sQuote(distance))) find_sigmas( imputed_data, distance = distance, censor_val = censor_val, censor_range = censor_range, missing_range = missing_range, vars = vars, verbose = verbose) } else if (is(sigma, 'Sigmas')) { sigma } else { stop(sigma_msg(sigma)) } } #' @importFrom methods hasMethod #' @importFrom SingleCellExperiment reducedDimNames reducedDim get_pca <- function(data_mat, data_raw, n_pcs, verbose = FALSE) { stopifnot(is.null(n_pcs) || length(n_pcs) == 1L) # If we suppress PCA computation, return NULL if (isTRUE(is.na(n_pcs))) return(NULL) # get PCs from SingleCellExperiment if possible existing_pca <- if (hasMethod('reducedDim', class(data_raw))) reducedDim(data_raw, 'pca') if (!is.null(existing_pca)) { if (is.null(n_pcs) || n_pcs == ncol(existing_pca)) { if (verbose) cat('Using reducedDim(data, "pca") to compute distances\n') return(existing_pca) } else if (n_pcs < ncol(existing_pca)) { warning('Specified n_pcs < ncol(reducedDim(data, "pca")), using subset') return(existing_pca[, seq_len(n_pcs), drop = FALSE]) } else {# n_pcs > ncol(pcs) warning('Specified n_pcs > ncol(reducedDim(data, "pca")), recalculating PCA') } } else if (is.null(n_pcs)) { # If n_pcs is NULL, data would need to have a PCA return(NULL) } # No PCA in data or requested more PCs if (ncol(data_mat) < n_pcs) stop('Cannot compute ', n_pcs, ' PCs from data with ', ncol(data_mat), ' columns.') pca_scores(data_mat, n_pcs) } get_knn <- function(imputed_data, dists, k, distance = 'euclidean', knn_params = list(), verbose = FALSE) { stopifnot(is.null(imputed_data) != is.null(dists)) if (!is.null(dists)) { nn_dist <- t(apply(dists, 1, function(row) sort(row)[2:k])) list(dist = nn_dist, dist_mat = dists) } else tryCatch({ verbose_timing(verbose, 'finding knns', do.call(find_knn, c(list(imputed_data, k, distance = distance), knn_params))) }, error = function(e) stop('Could not call find_knn. Consider specifying `knn_params = list(M = )`. Original error:\n', e$message, call. = FALSE)) } #' @importFrom Matrix sparseMatrix diag<- drop0 forceSymmetric skewpart symmpart #' @importFrom utils txtProgressBar setTxtProgressBar transition_probabilities <- function(imputed_data, sigma, dists, censor, censor_val, censor_range, missing_range, verbose) { n <- nrow(dists) # create markovian transition probability matrix (trans_p) cb <- if (verbose) { pb <- txtProgressBar(1, n, style = 3) function(i) setTxtProgressBar(pb, i) } else invisible # initialize trans_p trans_p <- verbose_timing(verbose, 'Calculating transition probabilities', { if (censor) censoring(imputed_data, sigma, dists, censor_val, censor_range, missing_range, cb) else no_censoring(dists, sigma, cb) }) if (verbose) close(pb) #nnzero # normalize trans_p and only retain intra-cell transitions diag(trans_p) <- 0 trans_p <- drop0(trans_p) stopifnot(is(trans_p, 'symmetricMatrix')) trans_p } #' @importFrom Matrix sparseMatrix which tcrossprod no_censoring <- function(dists, sigma, cb = invisible) { d2 <- dists ^ 2 stopifnot(isSymmetric(d2)) t_p <- if (length(sigma) == 1L) { exp(-d2@x / (2 * sigma ^ 2)) } else { stopifnot(d2@uplo == 'U') coords <- as(d2, 'dsTMatrix') i <- coords@i + 1L j <- coords@j + 1L sig2 <- sigma^2 S1 <- sigma[i] * sigma[j] S2 <- sig2[i] + sig2[j] sqrt(2 * S1 / S2) * exp(-d2@x / S2) } sparseMatrix(d2@i, p = d2@p, x = t_p, dims = dim(d2), symmetric = TRUE, index1 = FALSE) } #' @importFrom methods as #' @importFrom Matrix sparseMatrix get_norm_p <- function(trans_p, d, d_new, density_norm) { if (density_norm) { trans_p <- as(trans_p, 'dgTMatrix') # use non-symmetric triples to operate on all values stopifsmall(max(trans_p@x, na.rm = TRUE)) #creates a dgCMatrix sparseMatrix(trans_p@i, trans_p@j, x = trans_p@x / (d_new[trans_p@i + 1] * d[trans_p@j + 1]), dims = dim(trans_p), index1 = FALSE) } else { trans_p } } decomp_transitions <- function(transitions, n_eigs, verbose) verbose_timing(verbose, 'performing eigen decomposition', eig_decomp(transitions, n_eigs)) destiny/R/dist-matrix-coerce.r0000644000175200017520000000113314516010071017333 0ustar00biocbuildbiocbuild#'@importFrom methods setOldClass setOldClass('dist') #' @importFrom Matrix sparseMatrix as.Matrix.dist <- function(from) { s <- attr(from, 'Size') i <- rep.int(seq_len(s - 1L), rev(seq_len(s - 1L))) j <- rev(abs(sequence(seq.int(s - 1L)) - s) + 1L) sparseMatrix(i, j, x = unclass(from), dims = c(s, s), symmetric = TRUE) } #'@importFrom methods setAs setAs('dist', 'Matrix', as.Matrix.dist) setAs('dist', 'sparseMatrix', as.Matrix.dist) setAs('dist', 'CsparseMatrix', as.Matrix.dist) setAs('dist', 'dsCMatrix', as.Matrix.dist) setAs('dist', 'symmetricMatrix', as.Matrix.dist) destiny/R/dpt-branching.r0000644000175200017520000000775114516010071016364 0ustar00biocbuildbiocbuildauto_branch <- function(dpt, cells, stats, w_width, nmin = 10L, gmin = 1.1) { n <- length(cells) stopifnot(n >= nmin) stopifnot(stats$g >= gmin) # initialize one level (branch, tips) and three branches (dpt) branches <- cut_branches(dpt[cells, stats$tips], cells, w_width) # list of vectors of numeric indices branch <- matrix(idx_list_to_vec(branches, cells, n), n, 1L) tips <- matrix(logical(n), n, 1L) tips[match(stats$tips, cells), 1L] <- TRUE subs <- mapply(function(idx_sub, i) { if (length(idx_sub) < nmin || !i %in% idx_sub) # Tip cells can end up undecided! return(NULL) sub_stats <- tipstats(dpt, idx_sub, i) if (sub_stats$g < gmin) return(NULL) auto_branch(dpt, idx_sub, sub_stats, w_width, nmin, gmin) }, branches, stats$tips, SIMPLIFY = FALSE) # add dpt columns to dpt and a level column to branch/tips if any branch was subdivided nonnull_subs <- vapply(subs, Negate(is.null), logical(1L)) if (any(nonnull_subs)) { n_sublevels <- do.call(max, lapply(subs[nonnull_subs], function(s) ncol(s$branch))) branch <- cbind(branch, matrix(NA_integer_, n, n_sublevels)) tips <- cbind(tips, matrix(NA, n, n_sublevels)) for (s in which(nonnull_subs)) { sub <- subs[[s]] idx_sub <- branches[[s]] idx_newcol <- seq.int(ncol(branch) - n_sublevels + 1L, length.out = ncol(sub$branch)) stopifnot(ncol(sub$branch) == ncol(sub$tips)) branch_offset <- max(branch, na.rm = TRUE) branch[match(idx_sub, cells), idx_newcol] <- sub$branch + branch_offset tips[ match(idx_sub, cells), idx_newcol] <- sub$tips } } stopifnot(ncol(branch) == ncol(tips)) list(branch = branch, tips = tips) } idx_list_to_vec <- function(idx_list, cells, n) { v <- rep(NA_integer_, n) for (i in seq_along(idx_list)) v[match(idx_list[[i]], cells)] <- i v } cut_branches <- function(dpt_mat, cells, w_width) { bid <- apply(dpt_mat, 2, order) branches <- lapply(seq_len(3), function(b) branchcut(dpt_mat, bid, b, w_width)) lapply(organize_branches(branches), function(branch) cells[branch]) } #' @importFrom smoother smth.gaussian branchcut <- function(dpt_mat, bid, b, w_width) { n <- nrow(bid) all_branches <- seq_len(3L) # sanity checks stopifnot(b %in% all_branches) stopifnot(ncol(dpt_mat) == 3L, ncol(bid) == 3L) stopifnot(nrow(dpt_mat) == n) stopifnot(is.double(dpt_mat), is.integer(bid)) # find cell indexes per branch other <- all_branches[all_branches != b] b1 <- other[[1L]] b2 <- other[[2L]] # DPT for other branches, sorted by b3 b3_idxs <- bid[, b] dpt1 <- dpt_mat[b3_idxs, b1] dpt2 <- dpt_mat[b3_idxs, b2] kcor <- vapply(seq_len(n - 1L), function(s1) { s2 <- s1 + 1L l <- seq_len(s1) r <- seq(s2, n) k_l <- kendall_finite_cor(dpt1[l], dpt2[l], dpt1[[s2]], dpt2[[s2]]) k_r <- kendall_finite_cor(dpt1[r], dpt2[r], dpt1[[s1]], dpt2[[s1]]) k_l/s1 - k_r/(n - s1) }, double(1L)) kcor <- smth.gaussian(kcor, w_width) cut <- which.max(kcor) b3_idxs[seq_len(cut)] } # This function organizes the cell arrays branches[[i]] # to build Branch labels (length <- number of cells) indicating the branch each cell belongs to. # Cells which are assigned to more than one branch in dpt as well # as cells which are not assigned to any branch are defined as undeceided (label NA) #' @importFrom utils combn organize_branches <- function(branches) { intersect_branches <- function(bs) intersect(branches[[bs[[1L]]]], branches[[bs[[2L]]]]) branch_intersections <- lapply(combn(3L, 2L, simplify = FALSE), intersect_branches) inters <- Reduce(union, branch_intersections, integer()) lapply(branches, function(b) union(setdiff(b, inters), b[[1]])) } # given two orderings b1 and b2, compute the delta (e.i. finite) Kendall # correlation of adding a new cell with bnew1, bnew2 to the orderings. kendall_finite_cor <- function(b1, b2, new1, new2) { b11 <- numeric(length(b1)) b11[b1 >= new1] <- 1 b11[b1 < new1] <- -1 b22 <- numeric(length(b2)) b22[b2 >= new2] <- 1 b22[b2 < new2] <- -1 as.double(b11 %*% b22) # strip dims } destiny/R/dpt-helpers.r0000644000175200017520000000247114516010071016065 0ustar00biocbuildbiocbuild#' Find a random root cell index #' #' Finds a cell that has the maximum DPT distance from a randomly selected one. #' #' @param dm_or_dpt A \code{\link{DiffusionMap}} or \code{\link{DPT}} object #' #' @return A cell index #' #' @examples #' data(guo) #' dm <- DiffusionMap(guo) #' random_root(dm) #' #' @export random_root <- function(dm_or_dpt) { dpt <- dummy_dpt(dm_or_dpt) random_idx <- sample.int(nrow(dpt), 1L) which.max(dpt[random_idx, ]) } #' Find tips in a DiffusionMap object #' #' @param dm_or_dpt A \code{\link{DiffusionMap}} or \code{\link{DPT}} object #' @param root Root cell index from which to find tips. (default: random) #' #' @return An integer vector of length 3 #' #' @examples #' data(guo) #' dm <- DiffusionMap(guo) #' is_tip <- l_which(find_tips(dm), len = ncol(guo)) #' plot(dm, col = factor(is_tip)) #' #' @export find_tips <- function(dm_or_dpt, root = random_root(dm_or_dpt)) { dpt <- dummy_dpt(dm_or_dpt) tipstats(dpt, seq_len(nrow(dpt)), root)$tips } tipstats <- function(dpt, cells, tips) { x <- tips[[1L]] dx <- dpt[x, cells] y <- if (length(tips) >= 2L) tips[[2L]] else cells[[which.max(dx)]] dy <- dpt[y, cells] z <- if (length(tips) == 3L) tips[[3L]] else cells[[which.max(dx + dy)]] list( tips = c(x, y, z), dx = dx, dy = dy, g = max(dx + dy) / min(dx + dy)) } destiny/R/dpt-methods-matrix.r0000644000175200017520000000565214516010071017374 0ustar00biocbuildbiocbuild#' @include dpt.r s4-unions.r NULL #' DPT Matrix methods #' #' Treat DPT object as a matrix of cell-by-cell DPT distances. #' #' @param x \code{\link{DPT}} object. #' @param i,j \link[=numeric]{Numeric} or \link{logical} index. #' @param ... ignored #' @param drop If \code{\link{TRUE}}, coerce result to a vector if it would otherwise have \code{1 \%in\% dim(result)}. #' #' @examples #' data(guo_norm) #' dm <- DiffusionMap(guo_norm) #' dpt <- DPT(dm) #' set.seed(1) #' plot(dpt[random_root(dpt), ], Biobase::exprs(guo_norm)['DppaI', ]) #' #' @seealso \code{\link{as.matrix.DPT}} ## Not [[.DPT, that is in the extraction methods #' @aliases [.DPT nrow.DPT ncol.DPT dim.DPT #' @name DPT matrix methods #' @rdname DPT-matrix-methods NULL #' @return \code{[} returns a dense matrix or (if applicable and \code{isTRUE(drop)}) a vector. #' @rdname DPT-matrix-methods #' @export setMethod('[', c('DPT', 'index', 'index', 'logicalOrMissing'), function(x, i, j, ..., drop = TRUE) { stopifnot(length(list(...)) == 0L) evas <- eigenvalues(x@dm) eves <- eigenvectors(x@dm) # get numeric from negative or logical indices i <- seq_len(nrow(x))[i] j <- seq_len(nrow(x))[j] norm <- array(NA, c(length(i), length(j), length(evas))) ev_dist <- norm for (e in seq_along(evas)) norm[, , e] <- evas[[e]] norm <- norm / (1-norm) do.call(mapply, c(list(function(ii, jj) { ev_dist[ii, jj, ] <<- eves[i[[ii]], ] - eves[j[[jj]], ] }), expand.grid(ii = seq_along(i), jj = seq_along(j)))) r <- sqrt(apply(norm^2 * ev_dist^2, 1:2, sum)) if (drop && 1L %in% dim(r)) dim(r) <- NULL r }) #' @rdname DPT-matrix-methods #' @export setMethod('[', c('DPT', 'index', 'missing', 'logicalOrMissing'), function(x, i, j, ..., drop = TRUE) { x[i, seq_len(nrow(x)), ..., drop = drop] }) #' @rdname DPT-matrix-methods #' @export setMethod('[', c('DPT', 'missing', 'index', 'logicalOrMissing'), function(x, i, j, ..., drop = TRUE) { x[seq_len(nrow(x)), j, ..., drop = drop] }) #' @rdname DPT-matrix-methods #' @export setMethod('[', c('DPT', 'missing', 'missing', 'logicalOrMissing'), function(x, i, j, ..., drop = TRUE) { x[seq_len(nrow(x)), seq_len(nrow(x)), ..., drop = drop] }) #' @return \code{[[} returns single distance value #' @rdname DPT-matrix-methods #' @export setMethod('[[', c('DPT', 'index', 'index'), function(x, i, j, ...) { if (length(i) != 1L || length(j) == 1L) stop('Can only extract one element, but i and j were of lengths ', length(i), ' and ', length(j)) x[i, j, ...] }) #' @return \code{nrow} and \code{ncol} return the number of cells #' @importFrom BiocGenerics nrow #' @rdname DPT-matrix-methods #' @export setMethod('nrow', 'DPT', function(x) length(x@dm@d)) #' @importFrom BiocGenerics ncol #' @rdname DPT-matrix-methods #' @export setMethod('ncol', 'DPT', function(x) length(x@dm@d)) #' @return \code{dim} returns \code{c(n_cells, n_cells)} #' @rdname DPT-matrix-methods #' @export setMethod('dim', 'DPT', function(x) c(nrow(x), ncol(x))) destiny/R/dpt-methods.r0000644000175200017520000000412114516010071016060 0ustar00biocbuildbiocbuild#' @include dpt.r NULL #' DPT methods #' #' Methods for the \link{DPT} class. \code{branch_divide} subdivides branches for plotting (see the examples). #' #' @param dpt,object DPT object #' @param divide Vector of branch numbers to use for division #' @param value Value of slot to set #' #' @return \code{branch_divide} and \code{dataset<-} return the changed object, \code{dataset} the extracted data, and \code{tips} the tip indices. #' #' @examples #' data(guo_norm) #' dpt <- DPT(DiffusionMap(guo_norm)) #' dpt_9_branches <- branch_divide(dpt, 1:3) #' plot(dpt_9_branches, col_by = 'branch') #' #' @seealso \link{plot.DPT} uses \code{branch_divide} for its \code{divide} argument. #' #' @aliases dataset.DPT #' @name DPT methods #' @rdname DPT-methods NULL #' @importFrom stats na.omit #' @rdname DPT-methods #' @export branch_divide <- function(dpt, divide = integer(0L)) { check_dpt(dpt) if (length(divide) == 0L) return(dpt) for (b in divide) { super_rows <- dpt@branch[, 1] == b & !is.na(dpt@branch[, 1]) if (!any(super_rows)) { available <- na.omit(unique(dpt@branch[, 1])) stop('invalid branch to divide ', b, ' not in ', available) } # shift sub branches/tips to the left dpt@branch[super_rows, ] <- cbind(dpt@branch[super_rows, -1], NA) dpt@tips [super_rows, ] <- cbind(dpt@tips [super_rows, -1], NA) # TODO: maybe also modify DPT? } vacant_levels <- apply(dpt@branch, 2L, function(col) all(is.na(col))) dpt@branch <- dpt@branch[, !vacant_levels] dpt@tips <- dpt@tips [, !vacant_levels] dpt } #' @rdname DPT-methods #' @export tips <- function(dpt) { check_dpt(dpt) tip_idx <- dpt@tips[, 1] branch_order <- order(dpt@branch[tip_idx, 1]) which(tip_idx)[branch_order] } #' @rdname DPT-methods #' @export setMethod('dataset', 'DPT', function(object) dataset(object@dm)) #' @rdname DPT-methods #' @export setMethod('dataset<-', 'DPT', function(object, value) { dataset(object@dm) <- value validObject(object) object }) check_dpt <- function(dpt) if (!is(dpt, 'DPT')) stop('branch_divide needs to be called on a DPT object, not a ', class(dpt)) destiny/R/dpt-plotting.r0000644000175200017520000001213614516010071016262 0ustar00biocbuildbiocbuild#' @include dpt.r utils.r NULL #' Plot DPT #' #' Plots diffusion components from a Diffusion Map and the accompanying Diffusion Pseudo Time (\code{\link{DPT}}) #' #' @param x A \code{\link{DPT}} object. #' @param y,root Root branch ID. Will be used as the start of the DPT. (default: lowest branch ID) #' (If longer than size 1, will be interpreted as \code{c(root, branches)}) #' @param paths_to Numeric Branch IDs. Are used as target(s) for the path(s) to draw. #' @param dcs The dimensions to use from the DiffusionMap #' @param divide If \code{col_by = 'branch'}, this specifies which branches to divide. (see \code{\link{branch_divide}}) #' @param w_width Window width for smoothing the path (see \code{\link[smoother]{smth.gaussian}}) #' @param col_by Color by 'dpt' (DPT starting at \code{branches[[1]]}), 'branch', or a veriable of the data. #' @param col_path Colors for the path or a function creating n colors #' @param col_tip Color for branch tips #' @param ... Graphical parameters supplied to \code{\link{plot.DiffusionMap}} #' @param col See \code{\link{plot.DiffusionMap}}. This overrides \code{col_by} #' @param legend_main See \code{\link{plot.DiffusionMap}}. #' #' @return The return value of the underlying call is returned, i.e. a scatterplot3d or rgl object for 3D plots. #' #' @aliases plot.DPT #' #' @examples #' data(guo_norm) #' dm <- DiffusionMap(guo_norm) #' dpt <- DPT(dm) #' plot(dpt) #' plot(dpt, 2L, col_by = 'branch') #' plot(dpt, 1L, 2:3, col_by = 'num_cells') #' plot(dpt, col_by = 'DPT3') #' #' @importFrom graphics plot points #' @importFrom methods is setMethod #' @importFrom scales colour_ramp rescale #' @importFrom utils capture.output #' @importFrom ggplot2 aes_string geom_path geom_point scale_colour_identity #' @export plot.DPT <- function( x, root = NULL, paths_to = integer(0L), dcs = 1:2, divide = integer(0L), w_width = .1, col_by = 'dpt', col_path = rev(palette()), col_tip = 'red', ..., col = NULL, legend_main = col_by ) { dpt <- x dpt_flat <- branch_divide(dpt, divide) if (!is.null(root) && length(root) < 1L) stop('root needs to be specified') root <- if (is.null(root)) min(dpt_flat@branch[, 1], na.rm = TRUE) else as.integer(root) paths_to <- as.integer(paths_to) if (length(root) > 1L && length(paths_to) > 0L) stop('(length(root), length(paths_to)) needs to be (1, 0-n) or (2-n, 0), but is (', length(root), ', ', length(paths_to), ')') stopifnot(length(dcs) %in% 2:3) if (length(root) > 1L && length(paths_to) == 0L) { paths_to <- root[-1] root <- root[[1]] } pt_vec <- dpt_for_branch(dpt_flat, root) evs <- flipped_dcs(dpt@dm, dcs) plot_paths <- function(p, ..., rescale) { plot_points <- get_plot_fn(p) rescale_fun <- if (is.null(rescale)) identity else function(x) rescale_mat(x, rescale) for (b in seq_along(paths_to)) { idx <- dpt@branch[, 1] %in% c(root, paths_to[[b]]) path <- average_path(pt_vec[idx], evs[idx, ], w_width) p <- plot_points(p, rescale_fun(path), type = 'l', col = col_path[[b]], ...) } tips <- evs[dpt_flat@tips[, 1], ] p <- plot_points(p, rescale_fun(tips), col = col_tip, ...) if (!is(p, 'ggplot')) p else p + scale_colour_identity( name = 'Path and Tips', guide = 'legend', breaks = c(col_path[seq_along(paths_to)], col_tip), labels = c(sprintf('Path to %s', paths_to), 'Tips')) } col <- if (!is.null(col)) col else switch(col_by, dpt = pt_vec, branch = , Branch = dpt_flat@branch[, 1], dpt[[col_by]]) legend_main <- switch(legend_main, dpt = 'DPT', branch = 'Branch', legend_main) args <- list( dpt@dm, dcs, plot_more = plot_paths, legend_main = legend_main, col = col, ...) if (!identical(Sys.getenv('LOG_LEVEL'), '')) message('Args:\n', paste(capture.output(print(args)), collapse = '\n')) do.call(plot, args) } #' @rdname plot.DPT #' @export setMethod('plot', c('DPT', 'numeric'), function(x, y, ...) plot.DPT(x, y, ...)) #' @rdname plot.DPT #' @export setMethod('plot', c('DPT', 'missing'), function(x, y, ...) { args <- list(...) root <- args$root # may be NULL args$root <- NULL do.call(plot.DPT, c(list(x, root), args)) }) #' @importFrom graphics plot #' @importFrom smoother smth.gaussian average_path <- function(pt, x, w_width = .1) { stopifnot(identical(nrow(x), length(pt))) as.data.frame(apply(x[order(pt), ], 2, function(col) smth.gaussian(col, w_width, tails = TRUE))) } get_plot_fn <- function(p) { if (is(p, 'ggplot')) { # ggplot function(p2, dat, type = 'p', col, ...) { xy <- colnames(dat) geom <- switch(type, p = geom_point, l = geom_path, stop) p2 + geom(aes_string(xy[[1L]], xy[[2L]], colour = 'Path'), data.frame(dat, Path = col)) } } else if (is.list(p) && 'points3d' %in% names(p)) {# scatterplot3d function(p2, ...) { p2$points3d(...) p2 } } else if (is(p, 'rglHighlevel')) { # rgl function(p2, x, y = NULL, z = NULL, type = 'p', ...) { switch(type, p = rgl::points3d, l = rgl::lines3d, stop)(x, y, z, ...) p2 } } else stop('unknown p passed to plot_more (class(es): ', paste(class(p), collapse = ', '), ')') } destiny/R/dpt.r0000644000175200017520000000550014516010071014421 0ustar00biocbuildbiocbuild#' Diffusion Pseudo Time #' #' Create pseudotime ordering and assigns cell to one of three branches #' #' Treat it as a matrix of pseudotime by subsetting (\code{\link[=dim.DPT]{[ dim nrow ncol}} \code{\link[=as.matrix.DPT]{as.matrix}}), and as a list of pseudodime, and expression vectors (\code{\link[=names.DPT]{$ [[ names}} \code{\link[=as.data.frame.DPT]{as.data.frame}}). #' #' @param dm A \code{\link{DiffusionMap}} object. Its transition probabilities will be used to calculate the DPT #' @param tips The cell index/indices from which to calculate the DPT(s) (integer of length 1-3) #' @param ... Unused. All parameters to the right of the \code{...} have to be specified by name (e.g. \code{DPT(dm, w_width = 0.2)}) #' @param w_width Window width to use for deciding the branch cutoff #' #' @return A \code{DPT} object: #' #' @slot branch \code{\link[base]{matrix}} (of \code{\link[base]{integer}}) recursive branch labels for each cell (row); \code{NA} for undeceided. Use \code{\link{branch_divide}} to modify this. #' @slot tips \code{\link[base]{matrix}} (of \code{\link[base]{logical}}) indicating if a cell (row) is a tip of the corresponding banch level (col) #' @slot dm \code{\link{DiffusionMap}} used to create this DPT object #' #' @examples #' data(guo_norm) #' dm <- DiffusionMap(guo_norm) #' dpt <- DPT(dm) #' str(dpt) #' #' @importFrom methods setClass #' @rdname DPT #' @export setClass( 'DPT', slots = c( branch = 'matrix', # 'integer' tips = 'matrix', # 'logical' dm = 'DiffusionMap'), validity = function(object) { TRUE # TODO }) #' @rdname DPT #' @export DPT <- function(dm, tips = random_root(dm), ..., w_width = .1) { chkDots(...) if (!is(dm, 'DiffusionMap')) stop('dm needs to be of class DiffusionMap, not ', class(dm)) if (!length(tips) %in% 1:3) stop('you need to specify 1-3 tips, got ', length(tips)) dpt <- dummy_dpt(dm) all_cells <- seq_len(nrow(dpt)) stats <- tipstats(dpt, all_cells, tips) branches <- auto_branch(dpt, all_cells, stats, w_width) colnames(branches$branch) <- paste0('Branch', seq_len(ncol(branches$branch))) colnames(branches$tips) <- paste0('Tips', seq_len(ncol(branches$tips))) rownames(branches$branch) <- rownames(branches$tips) <- rownames(dm@eigenvectors) dpt@branch <- branches$branch dpt@tips <- branches$tips dpt } dummy_dpt <- function(dm_or_dpt) { if (is(dm_or_dpt, 'DPT')) dm_or_dpt else if (is(dm_or_dpt, 'DiffusionMap')) new('DPT', branch = matrix(), tips = matrix(), dm = dm_or_dpt) else stop('dm_or_dpt needs to be DPT or DiffusionMap object, not ', class(dm_or_dpt)) } dpt_for_branch <- function(dpt, branch_id) { branch_idx <- dpt@branch[, 1L] == branch_id stopifnot(any(branch_idx)) tip_cells <- which(branch_idx & dpt@tips[, 1L]) if (length(tip_cells) == 0L) tip_cells <- which(branch_idx) dpt[tip_cells[[1L]], ] } destiny/R/eig_decomp.r0000644000175200017520000000231514516010071015726 0ustar00biocbuildbiocbuild#' Fast eigen decomposition using \code{\link[RSpectra]{eigs}} #' #' By default uses a random initialization vector that you can make deterministic using #' \code{\link[base]{set.seed}} or override by specifying \code{opts = list(initvec = ...)}. #' #' @param M A matrix (e.g. from the Matrix package) or #' a function (see \code{\link[RSpectra]{eigs}}). #' @param n_eigs Number of eigenvectors to return. #' @param sym defunct and ignored. #' @param ... Passed to \code{\link[RSpectra]{eigs}}. #' @param opts Passed to \code{\link[RSpectra]{eigs}}. #' #' @return see \code{\link[RSpectra]{eigs}}. #' #' @examples #' eig_decomp(cbind(c(1,0,-1), c(0,1,0), c(-1,0,1)), 2) #' #' @importFrom Matrix isSymmetric #' @importFrom RSpectra eigs eigs_sym #' @importFrom stats runif #' @export eig_decomp <- function(M, n_eigs, sym, ..., opts = list()) { if (!('initvec' %in% names(opts))) opts$initvec <- runif(nrow(M)) - .5 # eigs cannot handle symmetricMatrix & sparseMatrix yet # TODO: low-effort. We can copy the memory and use the `lower = T/F` arg instead if (is(M, 'dsCMatrix')) M <- as(M, 'dgCMatrix') if (is(M, 'dsRMatrix')) M <- as(M, 'dgRMatrix') eigs(M, n_eigs, ..., opts = opts) } destiny/R/expressionset-helpers.r0000644000175200017520000000427014516010071020210 0ustar00biocbuildbiocbuild#' @include utils.r NULL #' Convert object to \link[Biobase:class.ExpressionSet]{ExpressionSet} or read it from a file #' #' These functions present quick way to create \link[Biobase:class.ExpressionSet]{ExpressionSet} objects. #' #' They work by using all continuous (double) columns as expression data, and all others as observation annotations. #' #' @param x \link[base]{data.frame} to convert to an \link[Biobase:class.ExpressionSet]{ExpressionSet}. #' #' @return an \link[Biobase:class.ExpressionSet]{ExpressionSet} object #' #' @examples #' library(Biobase) #' df <- data.frame(Time = seq_len(3), #integer column #' Actb = c(0.05, 0.3, 0.8), #' Gapdh = c(0.2, 0.03, 0.1)) #' set <- as.ExpressionSet(df) #' rownames(exprs(set)) == c('Actb', 'Gapdh') #' phenoData(set)$Time == 1:3 #' #' @seealso \link[utils]{read.table} on which \code{read.ExpressionSet} is based, and \link[Biobase:class.ExpressionSet]{ExpressionSet}. #' #' @name ExpressionSet helper methods #' @rdname ExpressionSet-helpers NULL #' @importFrom methods setGeneric .valueClassTest #' @rdname ExpressionSet-helpers #' @export setGeneric('as.ExpressionSet', function(x, ...) standardGeneric('as.ExpressionSet'), valueClass = 'ExpressionSet') #' @param annotation_cols The data.frame columns used as annotations. All others are used as expressions. (Logical, character or numerical index array) #' #' @importFrom Biobase ExpressionSet AnnotatedDataFrame phenoData #' @rdname ExpressionSet-helpers #' @export setMethod('as.ExpressionSet', 'data.frame', function(x, annotation_cols = !sapply(x, is.double)) { if (!is.logical(annotation_cols)) annotation_cols <- l_which(annotation_cols, names(x)) assayData <- t(as.matrix(x[!annotation_cols])) phenoData <- AnnotatedDataFrame(x[annotation_cols]) ExpressionSet(assayData, phenoData) }) #' @param file File path to read ASCII data from #' @param header Specifies if the file has a header row. #' @param ... Additional parameters to \link[utils]{read.table} #' #' @importFrom utils read.table #' @rdname ExpressionSet-helpers #' @export read.ExpressionSet <- function(file, header = TRUE, ...) { as.ExpressionSet(read.table(file, header, ...)) } destiny/R/find_dm_k.r0000644000175200017520000000265514516010071015554 0ustar00biocbuildbiocbuild#' Find a suitable k #' #' The \code{k} parameter for the k nearest neighbors used in \link{DiffusionMap} should be as big as possible while #' still being computationally feasible. This function approximates it depending on the size of the dataset \code{n}. #' #' @param n Number of possible neighbors (nrow(dataset) - 1) #' @param min_k Minimum number of neighbors. Will be chosen for \eqn{n \ge big} #' @param small Number of neighbors considered small. If/where \eqn{n \le small}, n itself will be returned. #' @param big Number of neighbors considered big. If/where \eqn{n \ge big}, \code{min_k} will be returned. #' #' @return A vector of the same length as \code{n} that contains suitable \code{k} values for the respective \code{n} #' #' @examples #' curve(find_dm_k(n), 0, 13000, xname = 'n') #' curve(find_dm_k(n) / n, 0, 13000, xname = 'n') #' @export find_dm_k <- function(n, min_k = 100L, small = 1000L, big = 10000L) { stopifnot(small < big) if (is.null(n)) return(NULL) k <- rep(NA_integer_, length(n)) k[small >= n] <- n[small >= n] k[n >= big] <- min_k rest <- !is.na(n) & small < n & n < big n_shifted <- (n[rest] - small) / (big - small) # linear transf [small, big] -> [0, 1] k_shifted <- (cos(n_shifted * pi) + 1) / 2 # ease function [0, 1] -> [1, 0] k_rest <- min_k + k_shifted * (n[rest] - min_k) # linear transf [0, 1] -> [min_k, n] k[rest] <- as.integer(round(k_rest)) k }destiny/R/gene-relevance-methods.r0000644000175200017520000000560414516010071020160 0ustar00biocbuildbiocbuild#' @include gene-relevance.r #' @importFrom Biobase featureNames featureNames<- NULL #' Gene Relevance methods #' #' \code{featureNames <- ...} can be used to set the gene names used for plotting #' (e.g. if the data contains hardly readably gene or transcript IDs). #' \code{dataset} gets the expressions used for the gene relevance calculations, #' and \code{distance} the distance measure. #' #' @param x,object \code{GeneRelevance} object #' @param value A text vector (\code{\link{character}} or \code{\link{factor}}) #' #' @return #' \code{dataset}, \code{distance}, and \code{featureNames} return the stored properties. #' The other methods return a \code{GeneRelevance} object (\code{print}, \code{... <- ...}), #' or NULL (\code{show}), invisibly #' #' @seealso \code{\link{gene_relevance}}, \link{Gene Relevance plotting} #' #' @examples #' data(guo_norm) #' dm <- DiffusionMap(guo_norm) #' gr <- gene_relevance(dm) #' stopifnot(distance(gr) == distance(dm)) #' featureNames(gr)[[37]] <- 'Id2 (suppresses differentiation)' #' # now plot it with the changed gene name(s) #' #' @aliases featureNames.GeneRelevance dataset.GeneRelevance #' @name Gene Relevance methods #' @rdname Gene-Relevance-methods NULL #' @importFrom methods is #' @importFrom utils str #' #' @rdname Gene-Relevance-methods #' @export setMethod('print', 'GeneRelevance', function(x) { d <- dataset(x) cat(sprintf('GeneRelevance (%s genes, %s reduced dimensions, and %s observations)\n', ncol(x@exprs), ncol(x@coords), nrow(x@exprs))) cat('is: ') if (is(d, 'Matrix')) cat(sprintf('%s%s%s %s (%s)\n', nrow(d), sym_times, ncol(d), class(d)[[1L]], mode(d@x))) else str(structure(d, dimnames = NULL)) cat('featureNames: '); str(featureNames(x)) invisible(x) }) #' @importFrom methods show #' #' @rdname Gene-Relevance-methods #' @export setMethod('show', 'GeneRelevance', function(object) { print(object) invisible() }) #' @rdname Gene-Relevance-methods #' @export setMethod('featureNames', 'GeneRelevance', function(object) colnames(object@exprs)) #' @rdname Gene-Relevance-methods #' @export setMethod('featureNames<-', c('GeneRelevance', 'characterOrFactor'), function(object, value) { object <- updateObject(object) colnames(object@exprs) <- colnames(object@partials_norm) <- colnames(object@partials) <- value object }) #' @rdname Gene-Relevance-methods #' @export setMethod('dataset', 'GeneRelevance', function(object) object@exprs) #' @rdname Gene-Relevance-methods #' @export setMethod('dataset<-', 'GeneRelevance', function(object, value) { object <- updateObject(object) object@exprs <- value validObject(object) object }) #' @rdname Gene-Relevance-methods #' @export setMethod('distance', 'GeneRelevance', function(object) object@distance) #' @rdname Gene-Relevance-methods #' @export setMethod('distance<-', 'GeneRelevance', function(object, value) { object@distance <- value validObject(object) object }) destiny/R/gene-relevance-plotting-differential-map.r0000644000175200017520000000742114516010071023561 0ustar00biocbuildbiocbuild#' @importFrom grDevices palette hcl.colors #' @rdname Gene-Relevance-plotting #' @export setGeneric('plot_differential_map', function(coords, exprs, ..., genes, dims = 1:2, pal = hcl.colors, faceter = facet_wrap(~ Gene)) { standardGeneric('plot_differential_map') }) #' @rdname Gene-Relevance-plotting #' @export setMethod('plot_differential_map', c('matrix', 'matrix'), function(coords, exprs, ..., genes, dims, pal, faceter) { plot_differential_map_impl(gene_relevance(coords, exprs, dims = seq_len(max(dims))), genes = genes, dims = dims, pal = pal, faceter = faceter, ...) }) #' @rdname Gene-Relevance-plotting #' @export setMethod('plot_differential_map', c('DiffusionMap', 'missing'), function(coords, exprs, ..., genes, dims, pal, faceter) { plot_differential_map_impl(gene_relevance(coords, dims = seq_len(max(dims))), genes = genes, dims = dims, pal = pal, faceter = faceter, ...) }) #' @rdname Gene-Relevance-plotting #' @export setMethod('plot_differential_map', c('GeneRelevance', 'missing'), function(coords, exprs, ..., genes, dims, pal, faceter) { plot_differential_map_impl(coords, genes = genes, dims = dims, pal = pal, faceter = faceter, ...) }) differential_map <- function(relevance_map, genes = NULL, dims = 1:2, all = FALSE) { relevance_map <- updateObject(relevance_map) all_dims <- get_dim_range(relevance_map@partials, 3L, dims) if (!all(dims %in% all_dims)) stop( 'The relevance map contains only the dimensions ', paste(all_dims, collapse = ', '), ', not ', paste(setdiff(dims, all_dims), collapse = ', ')) genes_existing <- colnames(relevance_map@partials_norm) if (is.null(genes)) genes <- genes_existing else { genes_missing <- is.na(match(genes, genes_existing)) if (any(genes_missing)) stop( 'The dataset used for the relevance map does not contain gene(s) ', paste(genes[genes_missing], collapse = ', '), '. Did you mean ', paste(agrep(genes[genes_missing], genes_existing, value = TRUE), collapse = ', '), '?') } exprs <- relevance_map@exprs coords <- get_coords(relevance_map, dims) partials_norms <- relevance_map@partials_norm[, genes, drop = FALSE] do.call(rbind, lapply(genes, function(g) { d_var <- .05 # Fraction of overall dimension variability partials <- lapply(seq_len(length(dims)), function(d) { dc <- coords[, d] partials <- relevance_map@partials[, g, d] # Scale magnitude of partial derivates delta <- diff(rev(range(dc, na.rm = TRUE))) partials / max(abs(partials), na.rm = TRUE) * d_var * delta }) cbind( as.data.frame(coords), Expression = exprs[, g], PartialsNorm = partials_norms[, g], Cell = if (!is.null(rownames(exprs))) rownames(exprs) else seq_len(nrow(exprs)), Gene = factor(g, levels = genes), Angle = atan(partials[[2]] / partials[[1]] ), Magnitude = sqrt(partials[[1]]^2 + partials[[2]]^2)) })) } #' @importFrom ggplot2 ggplot aes aes_string #' @importFrom ggplot2 geom_point geom_spoke #' @importFrom ggplot2 scale_colour_gradientn #' @importFrom ggplot2 ggtitle facet_wrap #' @importFrom grid arrow unit plot_differential_map_impl <- function(relevance_map, ..., genes, dims, pal, faceter) { chkDots(...) if (is.function(pal)) pal <- pal(12) dtm <- differential_map(relevance_map, genes, dims) coords <- get_coords(relevance_map, dims) gene_names <- if (is.character(genes)) genes else colnames(relevance_map@exprs)[genes] d1 <- colnames(coords)[[1]] d2 <- colnames(coords)[[2]] gg <- ggplot(dtm, aes_string(d1, d2)) + geom_spoke( aes_string( angle = 'Angle', radius = 'Magnitude', alpha = 'PartialsNorm', colour = 'Expression' ), arrow = arrow(length = unit(.01, 'npc')) ) + scale_colour_gradientn(colours = pal) + geom_rangeframe(colour = par('col')) + theme_really_minimal() if (length(genes) > 1) gg + faceter else gg + ggtitle(gene_names) } destiny/R/gene-relevance-plotting-gr-map.r0000644000175200017520000001303414516010071021532 0ustar00biocbuildbiocbuild#' @rdname Gene-Relevance-plotting #' @export setGeneric('plot_gene_relevance', function(coords, exprs, ..., iter_smooth = 2L, n_top = 10L, genes = NULL, dims = 1:2, pal = palette(), col_na = 'grey', limit = TRUE) { standardGeneric('plot_gene_relevance') }) #' @rdname Gene-Relevance-plotting #' @export setMethod('plot_gene_relevance', c('matrix', 'matrix'), function(coords, exprs, ..., iter_smooth, n_top, genes, dims, pal, col_na, limit) { plot_gene_relevance_impl(gene_relevance(coords, exprs, dims = seq_len(max(dims))), iter_smooth = iter_smooth, n_top = n_top, genes = genes, dims = dims, pal = pal, col_na = col_na, limit = limit, ...) }) #' @rdname Gene-Relevance-plotting #' @export setMethod('plot_gene_relevance', c('DiffusionMap', 'missing'), function(coords, exprs, ..., iter_smooth, n_top, genes, dims, pal, col_na, limit) { plot_gene_relevance_impl(gene_relevance(coords, dims = seq_len(max(dims))), iter_smooth = iter_smooth, n_top = n_top, genes = genes, dims = dims, pal = pal, col_na = col_na, limit = limit, ...) }) #' @rdname Gene-Relevance-plotting #' @export setMethod('plot_gene_relevance', c('GeneRelevance', 'missing'), function(coords, exprs, ..., iter_smooth, n_top, genes, dims, pal, col_na, limit) { plot_gene_relevance_impl(coords, iter_smooth = iter_smooth, n_top = n_top, genes = genes, dims = dims, pal = pal, col_na = col_na, limit = limit, ...) }) #' @importFrom ggplot2 ggplot aes_string #' @importFrom ggplot2 geom_point #' @importFrom ggplot2 scale_color_manual #' @importFrom ggplot2 ggtitle #' @importFrom Biobase featureNames #' @importFrom utils head plot_gene_relevance_impl <- function(relevance_map, ..., iter_smooth, n_top, genes, dims, pal, col_na, limit) { chkDots(...) relevance_map <- updateObject(relevance_map) partials_norm <- relevance_map@partials_norm coords <- get_coords(relevance_map, dims) if (!is.numeric(iter_smooth) || length(iter_smooth) != 1L) stop('iter_smooth needs to be an integer(1)') if (!is.numeric(n_top) || length(n_top) != 1L ) stop( 'n_top needs to be an integer(1)') all_genes <- featureNames(relevance_map) if (is.null(genes)) { genes <- all_genes } else if (is.character(genes)) { found <- sapply(genes, function(id) length(grep(id, all_genes)) > 0) genes <- genes[found] } else { genes <- all_genes[genes] } # gene with top n norm for each cell genes_max <- if (n_top == 1L) { all_genes[apply(partials_norm, 1L, function(cell) which.max(cell))] } else { genes_ord <- t(apply(partials_norm, 1L, function(cell) { cell <- setNames(cell, all_genes) names(cell[order(cell, decreasing = TRUE)[seq_len(n_top)]]) })) as.vector(genes_ord) } counts <- as.data.frame(table(genes_max), stringsAsFactors = FALSE) counts <- counts[order(counts$Freq, decreasing = TRUE), ] counts_valid <- counts[counts$genes_max %in% genes, ] gene_ids <- counts_valid$genes_max scores <- counts_valid$Freq / sum(counts_valid$Freq) names(scores) <- gene_ids num_top <- min(5L, length(gene_ids)) top_n_cell_text <- apply(partials_norm, 1L, function(cell) { idxs <- head(order(cell, decreasing = TRUE), num_top) names <- all_genes[idxs] txt <- sprintf('%s. %s (%.3f)', seq_len(num_top), names, cell[idxs]) paste(txt, collapse = '\n') }) # Plot a single map with cells coloured by gene which has # the highest differential norm of all genes considered. # matrix cells by n_top. might contain NAs later max_genes <- if (n_top > 1L) genes_ord else matrix(gene_ids[apply(partials_norm, 1L, which.max)], ncol = 1) # Label smoothing through graph structure for (i in seq_len(iter_smooth)) { max_genes <- apply(relevance_map@nn_index, 1, function(idx_neighbors) { # treating the matrix as vector yields the first column first, i.e. the closest neighbors ... max_genes_nn <- unique(as.vector(max_genes[idx_neighbors, ])) max_genes_nn_hist <- vapply(max_genes_nn, function(gene) sum(gene == max_genes[idx_neighbors, ], na.rm = TRUE), integer(1L)) # ... therefore if e.g. all genes only appear once, the first neighbors stay first sorted <- sort(max_genes_nn_hist, decreasing = TRUE) names(sorted)[seq_len(n_top)] }) # Make inconsistent `apply` result into a cells by n_top matrix max_genes <- if (n_top > 1) t(max_genes) else matrix(max_genes, ncol = 1) } # use [1] so in case of an empty row we just get an NA. gene_labels <- droplevels(structure( apply(max_genes, 1, function(cell) na.omit(match(cell, gene_ids))[1]), levels = gene_ids, class = 'factor' )) # Try creating a palette of the required length if (is.function(pal)) pal <- pal(length(unique(gene_labels))) if (limit) gene_labels[as.integer(gene_labels) > length(pal)] <- NA # Add more than two DC and return data frame so that user # can easily rebuild relevance map on other DC combination than 1 and 2. rel_map_data <- cbind(as.data.frame(coords), Gene = gene_labels, TopN = top_n_cell_text) d1 <- colnames(coords)[[1]] d2 <- colnames(coords)[[2]] rel_map <- ggplot(rel_map_data, aes_string(x = d1, y = d2, colour = 'Gene', text = 'TopN')) + geom_point(alpha = .8) + geom_rangeframe(colour = par('col')) + scale_color_manual(values = pal, na.value = col_na) + ggtitle(sprintf('Gene relevance map')) + theme_really_minimal() rel_map$ids <- gene_ids rel_map$scores <- scores rel_map } get_coords <- function(relevance_map, dims) { coords <- relevance_map@coords[, dims, drop = FALSE] if (is.null(colnames(coords))) colnames(coords) <- paste0('Dim', dims) coords } get_dim_range <- function(arr, d, dims) { if (is.character(dims)) dimnames(arr)[[d]] else seq_len(dim(arr)[[d]]) } destiny/R/gene-relevance-plotting-rank.r0000644000175200017520000000574314516010071021312 0ustar00biocbuildbiocbuild#' @rdname Gene-Relevance-plotting #' @export setGeneric('plot_gene_relevance_rank', function(coords, exprs, ..., genes, dims = 1:2, n_top = 10L, pal = c("#3B99B1", "#F5191C"), bins = 10L, faceter = facet_wrap(~ Gene)) { standardGeneric('plot_gene_relevance_rank') }) #' @rdname Gene-Relevance-plotting #' @export setMethod('plot_gene_relevance_rank', c('matrix', 'matrix'), function(coords, exprs, ..., genes, dims, n_top, pal, bins, faceter) { plot_gene_relevance_rank_impl(gene_relevance(coords, exprs, dims = seq_len(max(dims))), genes = genes, dims = dims, n_top = n_top, pal = pal, bins = bins, faceter = faceter, ...) }) #' @rdname Gene-Relevance-plotting #' @export setMethod('plot_gene_relevance_rank', c('DiffusionMap', 'missing'), function(coords, exprs, ..., genes, dims, n_top, pal, bins, faceter) { plot_gene_relevance_rank_impl(gene_relevance(coords, dims = seq_len(max(dims))), genes = genes, dims = dims, n_top = n_top, pal = pal, bins = bins, faceter = faceter, ...) }) #' @rdname Gene-Relevance-plotting #' @export setMethod('plot_gene_relevance_rank', c('GeneRelevance', 'missing'), function(coords, exprs, ..., genes, dims, n_top, pal, bins, faceter) { plot_gene_relevance_rank_impl(coords, genes = genes, dims = dims, n_top = n_top, pal = pal, bins = bins, faceter = faceter, ...) }) #' @importFrom tidyr gather #' @importFrom tidyselect one_of #' @importFrom scales percent #' @importFrom ggplot2 ggplot aes_string stat #' @importFrom ggplot2 scale_fill_gradientn scale_alpha_continuous #' @importFrom ggplot.multistats stat_summaries_hex plot_gene_relevance_rank_impl <- function(relevance_map, ..., genes, dims, n_top, pal, bins, faceter) { chkDots(...) if (is.function(pal)) pal <- pal(12) coords <- get_coords(relevance_map, dims) gene_names <- if (is.character(genes)) genes else colnames(relevance_map@exprs)[genes] genes_missing <- setdiff(genes, colnames(relevance_map@partials_norm)) if (length(genes_missing) > 0) { genes_close <- lapply(genes_missing, agrep, colnames(relevance_map@partials_norm), value = TRUE) stop('Missing genes: ', paste(genes_missing, collapse = ', '), '. ', 'Closest available: ', paste(unlist(genes_close), collapse = ', ')) } top10 <- function(x) sum(x <= 10) / length(x) partials <- as.data.frame(t(apply(-relevance_map@partials_norm, 1, rank)[genes, , drop = FALSE])) d <- gather(cbind(partials, as.data.frame(coords)), 'Gene', 'Rank', one_of(gene_names)) d$Gene <- factor(d$Gene, gene_names) d1 <- colnames(coords)[[1]] d2 <- colnames(coords)[[2]] gg <- ggplot(d, aes_string(d1, d2, z = 'Rank')) + stat_summaries_hex( aes_string(fill = 'stat(top10)', alpha = 'stat(size)'), funs = list(top10 = top10, size = 'length', 'median'), bins = bins ) + scale_fill_gradientn( name = substitute(Rank <= n_top, list(n_top = n_top)), labels = percent, colours = pal ) + scale_alpha_continuous(name = '#Cells', trans = 'log10') + theme_really_minimal() if (length(genes) > 1) gg + faceter else gg + ggtitle(gene_names) } destiny/R/gene-relevance-plotting.r0000644000175200017520000000644214516010071020356 0ustar00biocbuildbiocbuild#' @include gene-relevance.r NULL #' Plot gene relevance or differential map #' #' \code{plot(gene_relevance, 'Gene')} plots the differential map of this/these gene(s), #' \code{plot(gene_relevance)} a relevance map of a selection of genes. #' Alternatively, you can use \code{plot_differential_map} or \code{plot_gene_relevance} on a \code{\link[=gene_relevance]{GeneRelevance}} or \code{\link{DiffusionMap}} object, or with two matrices. #' #' @param x \code{\link[=gene_relevance]{GeneRelevance}} object. #' @param y Gene name(s) or index/indices to create differential map for. (integer or character) #' @param coords A \code{\link{DiffusionMap}}/\code{\link[=gene_relevance]{GeneRelevance}} object or a cells \eqn{\times} dims \code{\link{matrix}}. #' @param exprs An cells \eqn{\times} genes \code{\link{matrix}}. Only provide if \code{coords} is a matrix. #' @param ... Passed to \code{plot_differential_map}/\code{plot_gene_relevance}. #' @param iter_smooth Number of label smoothing iterations to perform on relevance map. #' The higher the more homogenous and the less local structure. #' @param n_top Number the top n genes per cell count towards the score defining which genes to return and plot in the relevance map. #' @param genes Genes to base relevance map on (vector of strings). #' You can also pass an index into the gene names (vector of numbers or logicals with length > 1). #' The default NULL means all genes. #' @param dims Names or indices of dimensions to plot. When not plotting a \code{\link[=gene_relevance]{GeneRelevance}} object, the relevance for the dimensions \code{1:max(dims)} will be calculated. #' @param pal Palette. Either A colormap function or a list of colors. #' @param col_na Color for cells that end up with no most relevant gene. #' @param bins Number of hexagonal bins for \code{plot_gene_relevance_rank}. #' @param limit Limit the amount of displayed gene labels to the amount of available colors in \code{pal}? #' @param faceter A ggplot faceter like \code{\link[ggplot2]{facet_wrap}(~ Gene)}. #' #' @return ggplot2 plot, when plotting a relevance map with a list member \code{$ids} containing the gene IDs used. #' #' @seealso \code{\link{gene_relevance}}, \link{Gene Relevance methods} #' #' @examples #' data(guo_norm) #' dm <- DiffusionMap(guo_norm) #' gr <- gene_relevance(dm) #' plot(gr) # or plot_gene_relevance(dm) #' plot(gr, 'Fgf4') # or plot_differential_map(dm, 'Fgf4') #' #' guo_norm_mat <- t(Biobase::exprs(guo_norm)) #' pca <- prcomp(guo_norm_mat)$x #' plot_gene_relevance(pca, guo_norm_mat, dims = 2:3) #' plot_differential_map(pca, guo_norm_mat, genes = c('Fgf4', 'Nanog')) #' #' @name Gene Relevance plotting #' @rdname Gene-Relevance-plotting NULL #' @rdname Gene-Relevance-plotting #' @export setMethod('plot', c('GeneRelevance', 'character'), function(x, y, ...) plot_differential_map(x, genes = y, ...)) #' @rdname Gene-Relevance-plotting #' @export setMethod('plot', c('GeneRelevance', 'numeric'), function(x, y, ...) plot_differential_map(x, genes = y, ...)) #' @rdname Gene-Relevance-plotting #' @export setMethod('plot', c('GeneRelevance', 'missing'), function(x, y, ...) plot_gene_relevance(x, ...)) destiny/R/gene-relevance.r0000644000175200017520000002320214516010071016511 0ustar00biocbuildbiocbuild#' @include diffusionmap.r s4-unions.r NULL #' Gene relevances for entire data set #' #' The relevance map is cached insided of the \code{\link{DiffusionMap}}. #' #' @param coords A \code{\link{DiffusionMap}} object or a cells \eqn{\times} dims \code{\link{matrix}}. #' @param exprs An cells \eqn{\times} genes \code{\link{matrix}}. Only provide if \code{coords} is no \code{\link{DiffusionMap}}. #' @param ... Unused. All parameters to the right of the \code{...} have to be specified by name. #' @param k Number of nearest neighbors to use #' @param dims Index into columns of \code{coord} #' @param distance Distance measure to use for the nearest neighbor search. #' @param smooth Smoothing parameters \code{c(window, alpha)} (see \code{\link[smoother]{smth.gaussian}}). #' Alternatively \code{\link{TRUE}} to use the \link[smoother]{smoother} \link[smoother:smth.options]{defaults} #' or \code{\link{FALSE}} to skip smoothing, #' @param remove_outliers Remove cells that are only within one other cell's nearest neighbor, as they tend to get large norms. #' @param pcs A cell \eqn{\times} \code{n_pcs} matrix of principal components to use for the distances. #' @param knn_params A \code{\link{list}} of parameters for \code{\link{find_knn}}. #' @param weights Weights for the partial derivatives. A vector of the same length as \code{dims}. #' @param verbose If TRUE, log additional info to the console #' #' @return A \code{GeneRelevance} object: #' #' @slot coords A cells \eqn{\times} dims \code{\link{matrix}} or \code{\link[Matrix:sparseMatrix-class]{sparseMatrix}} #' of coordinates (e.g. diffusion components), reduced to the dimensions passed as \code{dims} #' @slot exprs A cells \eqn{\times} genes matrix of expressions #' @slot partials Array of partial derivatives wrt to considered dimensions in reduced space #' (genes \eqn{\times} cells \eqn{\times} dimensions) #' @slot partials_norm Matrix with norm of aforementioned derivatives. (n\_genes \eqn{\times} cells) #' @slot nn_index Matrix of k nearest neighbor indices. (cells \eqn{\times} k) #' @slot dims Column index for plotted dimensions. Can \code{\link{character}}, \code{\link{numeric}} or \code{\link{logical}} #' @slot distance Distance measure used in the nearest neighbor search. See \code{\link{find_knn}} #' @slot smooth_window Smoothing window used (see \code{\link[smoother]{smth.gaussian}}) #' @slot smooth_alpha Smoothing kernel width used (see \code{\link[smoother]{smth.gaussian}}) #' #' @seealso \link{Gene Relevance methods}, \link{Gene Relevance plotting}: \code{plot_differential_map}/\code{plot_gene_relevance} #' #' @examples #' data(guo_norm) #' dm <- DiffusionMap(guo_norm) #' gr <- gene_relevance(dm) #' #' m <- t(Biobase::exprs(guo_norm)) #' gr_pca <- gene_relevance(prcomp(m)$x, m) #' # now plot them! #' #' @rdname Gene-Relevance #' @export setClass('GeneRelevance', slots = c( coords = 'matrix', exprs = 'dMatrixOrMatrix', partials = 'array', partials_norm = 'matrix', nn_index = 'matrix', # k = ncol(nn_index) dims = 'ColIndex', distance = 'character', smooth_window = 'numeric', smooth_alpha = 'numeric')) #' @rdname Gene-Relevance #' @export setGeneric('gene_relevance', function( coords, exprs, ..., k = 20L, dims = 1:2, distance = NULL, smooth = TRUE, remove_outliers = FALSE, verbose = FALSE ) standardGeneric('gene_relevance')) #' @importFrom Biobase updateObject #' @rdname Gene-Relevance #' @export setMethod('gene_relevance', c('DiffusionMap', 'missing'), function( coords, exprs, ..., k, dims, distance, smooth, remove_outliers, verbose ) { dm <- updateObject(coords) relevance_map <- updateObject(dm@data_env$relevance_map) smooth <- get_smoothing(smooth) if (is.null(relevance_map) || ncol(relevance_map@nn_index) != k || !identical(relevance_map@dims, dims) || !identical(relevance_map@smooth_window, smooth[[1L]]) || !identical(relevance_map@smooth_alpha, smooth[[2L]]) ) { coords <- eigenvectors(dm) if (dm@distance == 'custom') stop('Gene relevance cannot be computed from a diffusion map with a custom distance matrix.') exprs <- dataset_extract_doublematrix(dataset(dm)) pcs <- get_pca(exprs, dataset(dm), dm@n_pcs, verbose) weights <- eigenvalues(dm)[dims] if (is.null(distance)) distance <- dm@distance else if (!identical(distance, dm@distance)) stop('the specified distance ', distance,' is not the same as the one used for the diffusion map: ', dm@distance) relevance_map <- gene_relevance( coords, exprs, ..., k = k, dims = dims, distance = distance, smooth = smooth, remove_outliers = remove_outliers, verbose = verbose, pcs = pcs, knn_params = dm@knn_params, weights = weights ) dm@data_env$relevance_map <- relevance_map } else chkDots(...) relevance_map }) #' @importFrom methods is #' @importFrom Biobase rowMedians #' @importFrom Matrix nnzero #' @rdname Gene-Relevance #' @export setMethod('gene_relevance', c('matrix', 'dMatrixOrMatrix'), function( coords, exprs, ..., pcs = NULL, knn_params = list(), weights = 1, k, dims, distance, smooth, remove_outliers, verbose ) { chkDots(...) distance <- match.arg(distance, c('euclidean', 'cosine', 'rankcor', 'l2')) coords_used <- coords[, dims, drop = FALSE] n_dims <- ncol(coords_used) if (length(weights) == 1L) weights <- rep(weights, n_dims) smooth <- get_smoothing(smooth) if (is.null(colnames(exprs))) stop('The expression matrix columns need to be named but are NULL') if (n_dims != length(weights)) stop(n_dims, ' dimensions, but ', length(weights), ' weights were provided') nn_index <- do.call(find_knn, c(list(if (is.null(pcs)) exprs else pcs, k, distance = distance), knn_params))$index k <- ncol(nn_index) n_cells <- nrow(coords_used) n_genes <- ncol(exprs) partials <- array( NA, dim = c(n_cells, n_genes, n_dims), dimnames = list(rownames(exprs), colnames(exprs), if (is.character(dims)) dims else colnames(coords_used))) # a very small value to subtract from the differential values <- if (is(exprs, 'Matrix')) exprs@x else exprs small <- min(values[values != 0]) / (length(exprs) - nnzero(exprs)) if (verbose) cat('Calculating expression differential\n') gene_differential <- function(expr_gene) { # Compute change in expression # Do not compute if reference is zero, could be drop-out expr_masked <- expr_gene expr_masked[expr_masked == 0] <- small differential_expr <- apply(nn_index, 2, function(nn) expr_gene[nn] - expr_masked) differential_expr[differential_expr == 0] <- NA # Cannot evaluate partial #stopifnot(identical(dim(differential_expr), c(n_cells, k))) differential_expr } differential_exprs <- apply(exprs, 2L, gene_differential) #stopifnot(identical(dim(differential_exprs), c(n_cells * k, n_genes))) # apply only handles returning vectors, so we have to reshape the return value dim(differential_exprs) <- c(n_cells, k, n_genes) dimnames(differential_exprs)[[3L]] <- if (length(colnames(exprs)) > 1L) colnames(exprs) else list(colnames(exprs)) #stopifnot(identical(gene_differential(exprs[, 1L]), differential_exprs[, , 1L])) for (d in seq_len(n_dims)) { # Compute partial derivatives in direction of current dimension if (verbose) cat('Calculating partial derivatives of dimension ', d, '/', n_dims, '\n') # We could optionaly add normalization by max(coords_used[, d]) - min(coords_used[, d]) differential_coord <- apply(nn_index, 2L, function(nn) coords_used[nn, d] - coords_used[, d]) partials_unweighted <- apply(differential_exprs, 3L, function(grad_gene_exprs) { # Compute median of difference quotients to NN difference_quotients <- grad_gene_exprs / differential_coord # Only compute differential if at least two observations are present! stable_cells <- rowSums(!is.na(difference_quotients)) >= 2L ifelse(stable_cells, rowMedians(difference_quotients, na.rm = TRUE), NA) }) colnames(partials_unweighted) <- colnames(exprs) if (!any(is.na(smooth))) { order_coor <- order(coords_used[, d]) order_orig <- order(order_coor) # Smooth the partials for each gene across all cells partials_unweighted <- apply(partials_unweighted, 2L, function(partials_gene) { ordered <- partials_gene[order_coor] smoothed <- smth.gaussian(ordered, smooth[[1L]], smooth[[2L]], tails = TRUE) smoothed[order_orig] }) colnames(partials_unweighted) <- colnames(exprs) } partials[, , d] <- weights[[d]] * partials_unweighted } # Compute norm over partial derivates: Frobenius partials_norm <- apply(partials, c(1, 2), function(z) sqrt(sum(z^2, na.rm = TRUE))) colnames(partials_norm) <- colnames(partials) # Find outlier cells: Not in NN of more than 1 other cell # Remove these as they tend to receive very large norms if (remove_outliers) { outliers <- sapply(seq_len(n_cells), function(cell) sum(nn_index == cell) > 1) partials_norm[, outliers] <- NA } # Prepare output rownames(partials_norm) <- rownames(partials) colnames(partials_norm) <- colnames(partials) new('GeneRelevance', coords = coords, exprs = exprs, partials = partials, partials_norm = partials_norm, nn_index = nn_index, dims = dims, smooth_window = smooth[[1L]], smooth_alpha = smooth[[2L]], distance = distance) }) get_smoothing <- function(smooth) { if (isTRUE(smooth)) c(getOption('smoother.window'), getOption('smoother.gaussianwindow.alpha')) else if (identical(smooth, FALSE)) c(NA_real_, NA_real_) else if (!is.numeric(smooth) || length(smooth) != 2L) stop('`smooth` needs to be TRUE, FALSE or a numeric c(window, alpha), not', capture.output(str(smooth))) else smooth } destiny/R/guo-data.r0000644000175200017520000000216014516010071015332 0ustar00biocbuildbiocbuild#' Guo at al. mouse embryonic stem cell qPCR data #' #' Gene expression data of 48 genes and an annotation column \code{$num_cells} containing the cell stage at which the embryos were harvested. #' #' The data is normalized using the mean of two housekeeping genes. #' The difference between \code{guo} and \code{guo_norm} is the LoD being set to 10 in the former, making it usable with the \code{censor_val} parameter of \link{DiffusionMap}. #' #' @return an \link[Biobase:class.ExpressionSet]{ExpressionSet} with 48 features and 428 observations containing qPCR Ct values and a "num.cells" observation annotation. #' #' @aliases data:guo data:guo_norm guo guo_norm #' @name guo #' @docType data #' @author Guoji Guo, Mikael Huss, Guo Qing Tong, Chaoyang Wang, Li Li Sun, Neil D. Clarke, Paul Robson \email{robsonp@@gis.a-star.edu.sg} #' @references \url{http://www.sciencedirect.com/science/article/pii/S1534580710001103} #' @keywords data #' @usage #' data(guo) #' data(guo_norm) #' @format An \link[Biobase:class.ExpressionSet]{ExpressionSet} with 48 features, 428 observations and 2 \link[Biobase]{phenoData} annotations. NULL destiny/R/knn.r0000644000175200017520000000716114516010071014425 0ustar00biocbuildbiocbuild#' kNN search #' #' Approximate k nearest neighbor search with flexible distance function. #' #' @param data Data matrix #' @param query Query matrix. Leave it out to use \code{data} as query #' @param k Number of nearest neighbors #' @param ... Parameters passed to \code{\link[RcppHNSW]{hnsw_knn}} #' @param distance Distance metric to use. Allowed measures: Euclidean distance (default), cosine distance (\eqn{1-corr(c_1, c_2)}) or rank correlation distance (\eqn{1-corr(rank(c_1), rank(c_2))}) #' @param method Method to use. \code{'hnsw'} is tunable with \code{...} but generally less exact than \code{'covertree'} (default: 'covertree') #' @param sym Return a symmetric matrix (as long as query is NULL)? #' @param verbose Show a progressbar? (default: FALSE) #' #' @return A \code{\link{list}} with the entries: #' \describe{ #' \item{\code{index}}{A \eqn{nrow(data) \times k} \link{integer} \link{matrix} containing the indices of the k nearest neighbors for each cell.} #' \item{\code{dist}}{A \eqn{nrow(data) \times k} \link{double} \link{matrix} containing the distances to the k nearest neighbors for each cell.} #' \item{\code{dist_mat}}{ #' A \code{\link[Matrix:dgCMatrix-class]{dgCMatrix}} if \code{sym == TRUE}, #' else a \code{\link[Matrix:dsCMatrix-class]{dsCMatrix}} (\eqn{nrow(query) \times nrow(data)}). #' Any zero in the matrix (except for the diagonal) indicates that the cells in the corresponding pair are close neighbors. #' } #' } #' #' @rdname knn #' @importFrom RcppHNSW hnsw_build hnsw_knn hnsw_search #' @export find_knn <- function( data, k, ..., query = NULL, distance = c('euclidean', 'cosine', 'rankcor', 'l2'), method = c('covertree', 'hnsw'), sym = TRUE, verbose = FALSE ) { p <- utils::modifyList(formals(RcppHNSW::hnsw_knn), list(...)) method <- match.arg(method) distance <- match.arg(distance) if (!is.double(data)) { warning('find_knn does not yet support sparse matrices, converting data to a dense matrix.') data <- as.matrix(data) } if (method == 'covertree') { return(knn.covertree::find_knn(data, k, query = query, distance = distance, sym = sym)) } if (distance == 'rankcor') { # TODO: rank_mat only works on dense matrices distance <- 'cosine' data <- rank_mat(data) if (!is.null(query)) query <- rank_mat(query) } if (is.null(query)) { knn <- hnsw_knn(data, k + 1L, distance, M = p$M, ef_construction = p$ef_construction, ef = p$ef, verbose = verbose) knn$idx <- knn$idx[ , -1, drop = FALSE] knn$dist <- knn$dist[, -1, drop = FALSE] } else { index <- hnsw_build(data, distance, M = p$M, ef = p$ef_construction, verbose = verbose) knn <- hnsw_search(query, index, k, ef = p$ef, verbose = verbose) } names(knn)[[1L]] <- 'index' # idx -> index # R matrices are column-major, so as.vector(m) == c(m[, 1], m[, 2], ...) knn$dist_mat <- sparseMatrix( rep(seq_len(nrow(knn$index)), k), as.vector(knn$index), x = as.vector(knn$dist), dims = c(nrow(if (is.null(query)) data else query), nrow(data)) ) if (is.null(query)) { if (sym) knn$dist_mat <- symmetricise(knn$dist_mat) nms <- rownames(data) } else { nms <- rownames(query) } rownames(knn$dist_mat) <- rownames(knn$index) <- rownames(knn$dist) <- nms colnames(knn$dist_mat) <- rownames(data) knn } # (double generic columnsparse to ... symmetric ...: dgCMatrix -> dsCMatrix) # retain all differences fully. symmpart halves them in the case of trans_p[i,j] == 0 && trans_p[j,i] > 0 # TODO: could be more efficient symmetricise <- function(dist_asym) { dist_sym <- symmpart(dist_asym) + abs(forceSymmetric(skewpart(dist_asym), 'U')) as(dist_sym, 'symmetricMatrix') } destiny/R/l_which.r0000644000175200017520000000232014516010071015244 0ustar00biocbuildbiocbuild#' Logical which #' #' Inverse of \link[base]{which}. Converts an array of numeric or character indices to a logical index array. #' This function is useful if you need to perform logical operation on an index array but are only given numeric indices. #' #' Either \code{nms} or \code{len} has to be specified. #' #' @param idx Numeric or character indices. #' @param nms Array of names or a sequence. Required if \code{idx} is a character array #' @param len Length of output array. Alternative to \code{nms} if \code{idx} is numeric #' @param useNames Use the names of nms or idx #' #' @return Logical vector of length \code{len} or the same length as \code{nms} #' #' @examples #' all(l_which(2, len = 3L) == c(FALSE, TRUE, FALSE)) #' all(l_which(c('a', 'c'), letters[1:3]) == c(TRUE, FALSE, TRUE)) #' #' @export l_which <- function(idx, nms = seq_len(len), len = length(nms), useNames = TRUE) { rv <- logical(len) if (is.character(nms)) # we need names here so that rv[idx] works names(rv) <- nms if (useNames && !is.null(names(idx))) names(rv)[idx] <- names(idx) rv[idx] <- TRUE if (!useNames) # if we don't want names, we'll remove them if we added them before names(rv) <- NULL rv }destiny/R/methods-coercion.r0000644000175200017520000000611414516010071017076 0ustar00biocbuildbiocbuild#' @include diffusionmap.r dpt.r NULL #' Coercion methods #' #' Convert a \code{\link{DiffusionMap}} or \code{\link{DPT}} object to other classes #' #' \link[ggplot2]{fortify} is a ggplot2 generic allowing a diffusion map to be used as \code{data} parameter in \link[ggplot2]{ggplot} or \link[ggplot2]{qplot}. #' #' @param x,model A \code{\link{DiffusionMap}} or \code{\link{DPT}} object #' @param row.names NULL or a character vector giving the row names for the data frame. Missing values are not allowed. #' @param optional logical. If TRUE, setting row names and converting column names (to syntactic names: see make.names) is optional. #' @param ... Passed to \code{\link[base]{as.data.frame}} #' @param data ignored #' #' @return An object of the desired class #' #' @seealso \link{DiffusionMap accession methods}, \link{Extraction methods}, \link{DiffusionMap methods} for more #' #' @examples #' library(Biobase) #' data(guo) #' dm <- DiffusionMap(guo) #' classes <- vapply(as.data.frame(dm), class, character(1L)) #' stopifnot(all(classes[paste0('DC', 1:20)] == 'numeric')) #' stopifnot(all(classes[featureNames(guo) ] == 'numeric')) #' stopifnot(all(classes[ varLabels(guo) ] == c('factor', 'integer'))) #' #' @aliases #' as.data.frame.DiffusionMap fortify.DiffusionMap #' as.data.frame.DPT fortify.DPT #' as.matrix.DPT #' #' @importFrom methods setAs #' @importFrom BiocGenerics as.data.frame #' @name Coercion methods #' @rdname coercions #' @include diffusionmap.r NULL #' @importFrom Biobase pData #' @rdname coercions #' @export setMethod('as.data.frame', 'DiffusionMap', function(x, row.names = NULL, optional = FALSE, ...) { df_evec <- as.data.frame(eigenvectors(x), row.names, optional, ...) df_data <- dataset_to_df( dataset(x), row.names, optional, ...) if (is.null(df_data)) df_evec else cbind(df_evec, df_data) }) #' @usage fortify.DiffusionMap(model, data, ...) #' #' @importFrom BiocGenerics as.data.frame #' @importFrom Biobase as.data.frame.ExpressionSet #' @importFrom ggplot2 fortify #' @rdname coercions #' @exportS3Method fortify #' @export fortify.DiffusionMap fortify.DiffusionMap <- function(model, data, ...) as.data.frame(model, ...) setAs('DiffusionMap', 'data.frame', function(from) as.data.frame(from)) #' @rdname coercions #' @export setMethod('as.data.frame', 'DPT', function(x, row.names = NULL, optional = FALSE, ...) { dpt <- as.matrix(x) colnames(dpt) <- paste0('DPT', seq_len(ncol(dpt))) cbind( as.data.frame(cbind(dpt, x@branch, x@tips), row.names = row.names, optional = optional, ...), as.data.frame(x@dm, row.names = row.names, optional = optional, ...)) }) #' @usage fortify.DPT(model, data, ...) #' #' @importFrom BiocGenerics as.data.frame #' @importFrom Biobase as.data.frame.ExpressionSet #' @importFrom ggplot2 fortify #' @rdname coercions #' @exportS3Method fortify #' @export fortify.DPT fortify.DPT <- function(model, data, ...) as.data.frame(model, ...) setAs('DPT', 'data.frame', function(from) as.data.frame(from)) #' @rdname coercions #' @export setMethod('as.matrix', 'DPT', function(x, ...) x[]) destiny/R/methods-extraction.r0000644000175200017520000000464214516010071017461 0ustar00biocbuildbiocbuild#' Extraction methods #' #' Extract common information from objects. #' Apart from the input data's branches, #' you can extract diffusion components via \code{$DCx}. #' From \code{\link{DPT}} objects, you can also extract the branch label via \code{$Branch}, #' or the diffusion pseudo time for a numbered cell via \code{$DPTx}. #' #' @param x \code{\link{DiffusionMap}} or \code{\link{DPT}} object #' @param i,name Name of a diffusion component \code{'DCx'}, \code{'DPTx'}, \code{'Branch'} or column from the data #' @param j N/A #' @param ... ignored #' #' @return The names or data row, see respective generics. #' #' @seealso \link[base]{Extract}, \code{\link[base]{names}} for the generics. \link{DiffusionMap accession methods}, \link{DiffusionMap methods}, \link{Coercion methods} for more #' #' @examples #' data(guo) #' dm <- DiffusionMap(guo) #' dm$DC1 # A diffusion component #' dm$Actb # A gene expression vector #' dm$num_cells # Phenotype metadata #' #' dpt <- DPT(dm) #' dm$Branch #' dm$DPT1 #' #' @name Extraction methods #' @rdname extractions #' @aliases #' names.DPT names.DiffusionMap #' [[.DPT [[.DiffusionMap #' $.DPT $.DiffusionMap NULL #' @importFrom methods is #' @importFrom Biobase featureNames varLabels #' @rdname extractions #' @export setMethod('names', 'DiffusionMap', function(x) { c(colnames(eigenvectors(x)), dataset_names(dataset(x))) }) #' @rdname extractions #' @export setMethod('names', 'DPT', function(x) c(paste0('DPT', seq_len(nrow(x))), 'Branch', names(x@dm))) #' @importFrom methods is #' @importFrom Biobase exprs featureNames #' @rdname extractions #' @export setMethod('[[', c('DiffusionMap', 'character', 'missing'), function(x, i, j, ...) { if (grepl('^DC\\d+$', i)) { eigenvectors(x)[, i] } else { dataset_get_feature(dataset(x), i) } }) #' @rdname extractions #' @export setMethod('[[', c('DPT', 'character', 'missing'), function(x, i, j, ...) { if (identical(i, 'dpt')) return(dpt_for_branch(x, 1L)) #TODO num_i <- if (grepl('DPT\\d+', i)) as.integer(sub('DPT(\\d+)', '\\1', i)) if (!is.null(num_i) && 1L <= num_i && num_i <= nrow(x)) { x[num_i, ] } else if (identical(i, 'Branch') || identical(i, 'branch')) { x@branch[, 1L] } else x@dm[[i]] }) #' @rdname extractions #' @export setMethod('$', 'DiffusionMap', function(x, name) x[[name]]) #' @rdname extractions #' @export setMethod('$', 'DPT', function(x, name) x[[name]]) destiny/R/methods-update.r0000644000175200017520000000624214516010071016561 0ustar00biocbuildbiocbuild#' @include utils.r NULL #' Update old destiny objects to a newer version. #' #' Handles \link{DiffusionMap}, \link{Sigmas}, and \link[=gene_relevance]{GeneRelevance}. #' #' @param object An object created with an older destiny release #' @param ... ignored #' @param verbose tells what is being updated #' #' @return A \link{DiffusionMap} or \link{Sigmas} object that is valid when used with the current destiny release #' #' @aliases updateObject.DiffusionMap updateObject.Sigmas updateObject.GeneRelevance #' @name updateObject methods #' @rdname updateObject-methods NULL #' @importFrom methods setMethod validObject .hasSlot slot slot<- #' @importFrom Matrix Matrix #' @importFrom BiocGenerics updateObject #' @rdname updateObject-methods #' @export setMethod('updateObject', 'DiffusionMap', function(object, ..., verbose = FALSE) { if (verbose) message("updateObject(object = 'DiffusionMap')") if (!hasattr(object, 'distance')) slot(object, 'distance', check = FALSE) <- 'euclidean' if (!hasattr(object, 'transitions')) slot(object, 'transitions', check = FALSE) <- NULL if (!hasattr(object, 'd.norm')) # upgrade only nonexistence, name later slot(object, 'd.norm', check = FALSE) <- rep(NA_real_, length(object@d)) if (!hasattr(object, 'n_pcs')) slot(object, 'n_pcs', check = FALSE) <- NA_integer_ if (!hasattr(object, 'n_local')) slot(object, 'n_local', check = FALSE) <- 5L if (!hasattr(object, 'rotate')) slot(object, 'rotate', check = FALSE) <- TRUE # old ones were rotated by default if (!hasattr(object, 'knn_params')) slot(object, 'knn_params', check = FALSE) <- list() object <- update_slot_names(object, c('data.env', 'd.norm', 'density.norm', 'censor.val', 'censor.range', 'missing.range')) slot(object, 'sigmas', check = FALSE) <- updateObject(object@sigmas) validObject(object) object }) #' @rdname updateObject-methods #' @export setMethod('updateObject', 'Sigmas', function(object, ..., verbose = FALSE) { if (verbose) message("updateObject(object = 'Sigmas')") object <- update_slot_names(object, c('log.sigmas', 'dim.norms', 'optimal.sigma', 'optimal.idx', 'avrd.norms')) object }) #' @rdname updateObject-methods #' @export setMethod('updateObject', 'GeneRelevance', function(object, ..., verbose = FALSE) { if (verbose) message("updateObject(object = 'GeneRelevance')") if (!hasattr(object, 'distance')) slot(object, 'distance', check = FALSE) <- 'euclidean' # the dimensions were switched to fit the convention elsewhere in the package. if (!hasattr(object, 'smooth_window')) { object@partials <- aperm(object@partials, c(2, 1, 3)) object@partials_norm <- t(object@partials_norm) slot(object, 'smooth_window', check = FALSE) <- NA_real_ slot(object, 'smooth_alpha', check = FALSE) <- NA_real_ } object }) #' @importFrom stats na.omit update_slot_names <- function(object, old_slots, new_slots = sub('.', '_', old_slots, fixed = TRUE)) { atts <- attributes(object) update_idx <- old_slots %in% names(atts) if (!length(update_idx)) return(object) slot_idx <- na.omit(match(old_slots[update_idx], names(atts))) names(atts)[slot_idx] <- new_slots[update_idx] attributes(object) <- atts object } destiny/R/plothelpers.r0000644000175200017520000000125614516010071016177 0ustar00biocbuildbiocbuildemptyplot <- function(xlim = c(0, 1), ylim = xlim, asp = 1, frame.plot = FALSE, col = NULL, ...) { plot(0, type = 'n', xlab = '', ylab = '', asp = asp, axes = FALSE, frame.plot = frame.plot, xlim = xlim, ylim = ylim, xaxs = 'i', yaxs = 'i', ...) if (!is.null(col)) rect(xlim[1], ylim[1], xlim[2], ylim[2], col = col) } #' @importFrom grDevices palette #' @importFrom scales colour_ramp rescale continuous_colors <- function(vals, pal = palette(), limits = NULL, levels = 100) { if (is.function(pal)) pal <- pal(levels) if (is.null(limits)) limits <- range(vals, na.rm = TRUE) ramp <- colour_ramp(pal, alpha = TRUE) ramp(rescale(vals, from = limits)) } destiny/R/predict.r0000644000175200017520000000556314516010071015275 0ustar00biocbuildbiocbuild#' @include diffusionmap.r NULL #' Predict new data points using an existing DiffusionMap. The resulting matrix can be used in \link[=plot.DiffusionMap]{the plot method for the DiffusionMap} #' #' @param dm A \code{\link{DiffusionMap}} object. #' @param new_data New data points to project into the diffusion map. #' Can be a \link[base]{matrix}, \link[base]{data.frame}, #' \link[Biobase:class.ExpressionSet]{ExpressionSet}, #' or \link[SingleCellExperiment]{SingleCellExperiment}. #' @param verbose Show progress messages? #' @param ... Passed to \code{\link[proxy:dist]{proxy::dist}(new_data, data, dm@distance, ...)}. #' #' @return A \eqn{nrow(new\_data) \times ncol(eigenvectors(dif))} matrix of projected diffusion components for the new data. #' #' @examples #' data(guo) #' g1 <- guo[, guo$num_cells != 32L] #' g2 <- guo[, guo$num_cells == 32L] #' dm <- DiffusionMap(g1) #' dc2 <- dm_predict(dm, g2) #' plot(dm, new_dcs = dc2) #' #' @importFrom methods is #' @importFrom Matrix Diagonal colSums rowSums #' @importFrom proxy dist #' @export dm_predict <- function(dm, new_data, ..., verbose = FALSE) { if (!is(dm, 'DiffusionMap')) stop('dm needs to be a DiffusionMap') data <- dataset_extract_doublematrix(dataset(dm), dm@vars) new_data <- dataset_extract_doublematrix(new_data, dm@vars) if (!dataset_n_features(data) == dataset_n_features(new_data)) stop('new data needs to have the same features as the one used to create the diffusion map') censor <- !is.null(dm@censor_val) || any(is.na(data)) || any(is.na(new_data)) #censor imples euclidean distance #TODO: local sigma sigma <- optimal_sigma(dm) if (!censor) { if (verbose) cat('Creating distance matrix without censoring\n') measure <- switch(dm@distance, euclidean = 'Euclidean', cosine = 'correlation', rankcor = 'rankcor', stop('Unknown distance measure')) d <- # no auto-simil2dist to not use 1-abs(simil) if (measure == 'Euclidean') proxy::dist(new_data, data, measure, ...) else 1 - proxy::simil(new_data, data, measure, ...) d2 <- unclass(d ^ 2) # matrix (dense) stopifnot(nrow(d2) == nrow(new_data)) stopifnot(ncol(d2) == nrow(data)) #TODO: zeros not on diag trans_p <- exp(-d2 / (2 * sigma ^ 2)) trans_p[d2 == 0] <- 0 } else { if (verbose) cat('Creating distance matrix with censoring\n') trans_p <- predict_censoring(data, new_data, dm@censor_val, dm@censor_range, dm@missing_range, sigma) } #trans_p: columns: old data, rows: new data d_new <- rowSums(trans_p, na.rm = TRUE) norm_p <- get_norm_p(trans_p, dm@d, d_new, dm@density_norm) rm(trans_p) # free memory d_norm_new <- rowSums(norm_p) d_rot <- Diagonal(x = dm@d_norm ^ -.5) d_rot_new <- Diagonal(x = d_norm_new ^ -.5) M_new <- d_rot_new %*% norm_p %*% d_rot if (verbose) cat('Transforming data\n') t(t(M_new %*% eigenvectors(dm)) / eigenvalues(dm)) } destiny/R/projection-dist.r0000644000175200017520000000250114516010071016745 0ustar00biocbuildbiocbuild#' Projection distance #' #' @param dm A \code{\link{DiffusionMap}} object. #' @param new_dcs Diffusion component matrix of which to calculate the distance to the data. #' @param ... Passed to \code{\link[proxy:dist]{proxy::dist}} if \code{new_data} was passed. #' @param new_data New data points to project into the diffusion map. #' Can be a \link[base]{matrix}, \link[base]{data.frame}, #' \link[Biobase:class.ExpressionSet]{ExpressionSet}, #' or \link[SingleCellExperiment]{SingleCellExperiment}. #' @param verbose If \code{\link{TRUE}}, log additional info to the console. #' #' @return A vector of distances each new data point has to the existing data. #' #' @examples #' data(guo_norm) #' g2_32 <- guo_norm[, guo_norm$num_cells < 64] #' g64 <- guo_norm[, guo_norm$num_cells == 64] #' dm <- DiffusionMap(g2_32) #' d <- projection_dist(dm, new_data = g64) #' #' @export projection_dist <- function(dm, new_dcs = NULL, ..., new_data, verbose = FALSE) { if (is.null(new_dcs)) new_dcs <- dm_predict(dm, new_data, ..., verbose = verbose) else if (!missing(new_data)) stop('only pass one of new_dcs and new_data') evs <- eigenvectors(dm) nns <- find_knn(evs, 1, query = as.matrix(new_dcs)) #nn_idx <- nns$index[, 1] nn_dist <- nns$dist[, 1] nn_dist } destiny/R/rankcor.r0000644000175200017520000000151514516010071015273 0ustar00biocbuildbiocbuildpr_rankcor <- function(x, y) { crossprod(x, y) / sqrt(crossprod(x) * crossprod(y)) } pr_rankcor_prefun <- function(x, y, pairwise, p, reg_entry) { x_ranked <- rank_mat(x) y_ranked <- rank_mat(y) x_rc <- sweep(x_ranked, 1, rowMeans(x_ranked)) y_rc <- sweep(y_ranked, 1, rowMeans(y_ranked)) list(x = x_rc, y = y_rc, pairwise = pairwise, p = p, reg_entry = reg_entry) } #' @importFrom proxy pr_DB proxy_add_rankcor_simil <- function() { pr_DB$set_entry( FUN = pr_rankcor, PREFUN = pr_rankcor_prefun, names = c('rankcorrelation', 'rankcor', 'spearman'), distance = FALSE, convert = 'pr_simil2dist', type = 'metric', loop = TRUE, C_FUN = FALSE, abcd = FALSE, formula = 'xy / sqrt(xx * yy) for ranked and centered x,y', reference = '???', description = 'rank correlation (taking n instead of n-1 for the variance)') } destiny/R/s4-unions.r0000644000175200017520000000160614516010071015474 0ustar00biocbuildbiocbuild#' @importFrom methods setClassUnion #' @importClassesFrom Matrix dMatrix ddenseMatrix dsparseMatrix ddiMatrix dgeMatrix dtrMatrix dtpMatrix dsyMatrix dspMatrix dpoMatrix dppMatrix corMatrix Cholesky pCholesky BunchKaufman pBunchKaufman setClassUnion('characterOrnumericOrNULL', members = c('character', 'numeric', 'NULL')) setClassUnion('ColIndex', members = c('character', 'numeric', 'logical')) setClassUnion('numericOrNULL', members = c('numeric', 'NULL')) setClassUnion('integerOrNULL', members = c('integer', 'NULL')) setClassUnion('dMatrixOrNULL', members = c('dMatrix', 'NULL')) # Added dsparseMatrix directly because of https://bugs.r-project.org/bugzilla/show_bug.cgi?id=17596 setClassUnion('dMatrixOrMatrix', members = c('dMatrix', 'dsparseMatrix', 'matrix')) setClassUnion('logicalOrMissing', members = c('logical', 'missing')) setClassUnion('characterOrFactor', c('character', 'factor')) destiny/R/sigmas-plotting.r0000644000175200017520000000757614516010071016772 0ustar00biocbuildbiocbuild#' @include sigmas.r NULL langle <- '\u27E8' rangle <- '\u27E9' angles <- list(langle = langle, rangle = rangle) #' Plot \link{Sigmas} object #' #' @param x Sigmas object to plot #' @param col Vector of bar colors or single color for all bars #' @param col_highlight Color for highest bar. Overrides col #' @param col_line Color for the line and its axis #' @param type Plot type of both lines. Can be a vector of length 2 to specify both separately (default: 'b' aka \dQuote{both lines and points}) #' @param pch Point identifier for both lines. Can be a vector of length 2 to specify both separately (default: \code{par(pch)} and 4 (a \sQuote{\eqn{\times}})) #' @param only_dim logical. If TRUE, only plot the derivative line #' @param ... Options passed to the call to plot #' @param xlab X label. NULL to use default #' @param ylab Either one y label or y labels for both plots. NULL to use both defauts, a NULL in a list of length 2 to use one default. #' @param main Title of the plot #' #' @return This method plots a Sigma object to the current device and returns nothing/NULL #' #' @examples #' data(guo) #' sigs <- find_sigmas(guo) #' plot(sigs) #' #' @importFrom graphics plot plot.window par text dotchart layout #' @name plot.Sigmas #' @rdname plot.Sigmas NULL #' @importFrom graphics plot plot.window par text dotchart layout #' @rdname plot.Sigmas #' @export setMethod('plot', c(x = 'Sigmas', y = 'missing'), function( x, col = par('fg'), col_highlight = '#E41A1C', # brewer Set1[[1]] col_line = '#999999', # brewer Set1[[9]] type = c('b', 'b'), pch = c(par('pch'), 4L), only_dim = FALSE, ..., xlab = NULL, ylab = NULL, main = '' ) { sigmas <- x if (is.null(optimal_sigma(sigmas))) { plot.new() plot.window(c(-1,1), c(-1,1)) text(0, 0, expression('local ' * sigma), .5) return() } if (is.null(sigmas@log_sigmas)) { return(dotchart(optimal_sigma(sigmas), labels = 'optimal_sigma', color = col_highlight, pch = pch, main = 'optimal sigma given directly')) } steps <- length(sigmas@log_sigmas) colors <- if (length(col) == 1L) rep(col, steps - 1L) else col colors[[sigmas@optimal_idx]] <- col_highlight #prepare parameters and reset them at the end mar <- par('mar') if (!only_dim) { layout(matrix(1:2, 2L)) par_old <- par(mar = c(0, mar[2:4]), ..., no.readonly = TRUE) on.exit({ layout(matrix(1)) par(par_old) }) } if (is.null(xlab)) xlab <- expression(log[10](sigma)) if (is.null(ylab)) ylab <- list(NULL, NULL) if (length(ylab) == 1L) ylab <- list(ylab, NULL) if (is.null(ylab[[1L]])) ylab[[1L]] <- substitute(paste(langle, d, rangle), angles) if (is.null(ylab[[2L]])) ylab[[2L]] <- substitute(paste(langle, log[10](Z(x)), rangle), angles) #first plot x <- sigmas@log_sigmas[-1L] - diff(sigmas@log_sigmas) / 2 xlim <- range(sigmas@log_sigmas) ysteps <- pretty(sigmas@dim_norms) ymin <- min(ysteps) ymax <- max(ysteps) + diff(ysteps[1:2])/4 plot(x, sigmas@dim_norms, xlim = xlim, ylim = c(ymin, ymax), xaxt = if (only_dim) 's' else 'n', xlab = if (only_dim) xlab else '', ylab = ylab[[1L]], col = colors, type = type[[1L]], pch = pch[[1L]], main = main, ...) text(log10(optimal_sigma(sigmas)), sigmas@dim_norms[[sigmas@optimal_idx]], substitute(sigma == rsig, list(rsig = round(optimal_sigma(sigmas), 1))), pos = 3) #second (overlay) plot if (!only_dim) { par(mar = c(mar[1:2], 0, mar[[4L]]), ...) col_lines <- rep(col_line, length(sigmas@log_sigmas)) col_lines[c(sigmas@optimal_idx, sigmas@optimal_idx + 1L)] <- col_highlight t2 <- if (length(type) > 1L) type[[2L]] else type p2 <- if (length(pch) > 1L) pch[[2L]] else pch plot(sigmas@log_sigmas, sigmas@avrd_norms, xlab = xlab, xlim = xlim, ylab = ylab[[2L]], type = t2, pch = p2, col = col_lines, ...) } invisible() }) destiny/R/sigmas.r0000644000175200017520000001754314516010071015127 0ustar00biocbuildbiocbuild#' @include s4-unions.r dist-matrix-coerce.r accessor-generics.r NULL #' Sigmas Object #' #' Holds the information about how the \code{sigma} parameter for a \link{DiffusionMap} was obtained, #' and in this way provides a plotting function for the \link{find_sigmas} heuristic. #' You should not need to create a Sigmas object yourself. Provide \code{sigma} to \link{DiffusionMap} instead or use \link{find_sigmas}. #' #' A Sigmas object is either created by \link{find_sigmas} or by specifying the \code{sigma} parameter to \link{DiffusionMap}. #' #' In the second case, if the \code{sigma} parameter is just a number, #' the resulting \code{Sigmas} object has all slots except of \code{optimal_sigma} set to \code{NULL}. #' #' @usage Sigmas(...) #' #' @param ... See \dQuote{\strong{Slots}} below #' @param object,x \link{Sigmas} object #' #' @return \code{Sigmas} creates an object of the same class #' #' @slot log_sigmas Vector of length \eqn{m} containing the \eqn{\log_{10}} of the \eqn{\sigma}s #' @slot dim_norms Vector of length \eqn{m-1} containing the average dimensionality \eqn{\langle p \rangle} for the respective kernel widths #' @slot optimal_sigma Multiple local sigmas or the mean of the two global \eqn{\sigma}s around the highest \eqn{\langle p \rangle} (\code{c(optimal_idx, optimal_idx+1L)}) #' @slot optimal_idx The index of the highest \eqn{\langle p \rangle}. #' @slot avrd_norms Vector of length \eqn{m} containing the average dimensionality for the corresponding sigma. #' #' @examples #' data(guo) #' sigs <- find_sigmas(guo, verbose = FALSE) #' optimal_sigma(sigs) #' print(sigs) #' #' @seealso \code{\link{find_sigmas}}, the function to determine a locally optimal sigma and returning this class #' #' @aliases Sigmas-methods #' #' @importFrom methods setClass #' @rdname Sigmas-class #' @export Sigmas #' @exportClass Sigmas Sigmas <- setClass('Sigmas', slots = c( log_sigmas = 'numericOrNULL', dim_norms = 'numericOrNULL', optimal_sigma = 'numericOrNULL', optimal_idx = 'integerOrNULL', avrd_norms = 'numericOrNULL')) #' @return \code{optimal_sigma} retrieves the numeric value of the optimal sigma or local sigmas #' @rdname Sigmas-class #' @export setMethod('optimal_sigma', 'Sigmas', function(object) object@optimal_sigma) #' @rdname Sigmas-class #' @export setMethod('print', 'Sigmas', function(x) { cat(sprintf('Sigmas (%s Steps performed)\noptimal_sigma: ', length(x@log_sigmas))) str(optimal_sigma(x)) invisible(x) }) #' @importFrom graphics plot #' @rdname Sigmas-class #' @export setMethod('show', 'Sigmas', function(object) { plot(object) invisible() }) #' Calculate the average dimensionality for m different gaussian kernel widths (\eqn{\sigma}). #' #' The sigma with the maximum value in average dimensionality is close to the ideal one. #' Increasing step number gets this nearer to the ideal one. #' #' @param data Data set with \eqn{n} observations. Can be a \link[base]{data.frame}, #' \link[base]{matrix}, \link[Biobase:class.ExpressionSet]{ExpressionSet} #' or \link[SingleCellExperiment]{SingleCellExperiment}. #' @param step_size Size of log-sigma steps #' @param steps Number of steps/calculations #' @param start Initial value to search from. (Optional. default: \eqn{\log_{10}(min(dist(data)))}) #' @param sample_rows Number of random rows to use for sigma estimation or vector of row indices/names to use. #' In the first case, only used if actually smaller than the number of available rows (Optional. default: 500) #' @param early_exit logical. If TRUE, return if the first local maximum is found, else keep running #' @param ... Unused. All parameters to the right of the \code{...} have to be specified by name (e.g. \code{find_sigmas(data, verbose = FALSE)}) #' @param censor_val Value regarded as uncertain. Either a single value or one for every dimension #' @param censor_range Uncertainity range for censoring. A length-2-vector of certainty range start and end. TODO: also allow \eqn{2\times G} matrix #' @param missing_range Whole data range for missing value model. Has to be specified if NAs are in the data #' @param vars Variables (columns) of the data to use. Specifying TRUE will select all columns (default: All floating point value columns) #' @param verbose logical. If TRUE, show a progress bar and plot the output #' #' @return Object of class \link{Sigmas} #' #' @seealso \code{\link{Sigmas}}, the class returned by this; \code{\link{DiffusionMap}}, the class this is used for #' #' @examples #' data(guo) #' sigs <- find_sigmas(guo, verbose = TRUE) #' DiffusionMap(guo, sigs) #' #' @importFrom methods as #' @importFrom graphics plot #' @importFrom utils txtProgressBar setTxtProgressBar #' @importFrom Matrix colSums rowSums #' @importFrom proxy dist #' @export find_sigmas <- function( data, step_size = .1, steps = 10L, start = NULL, sample_rows = 500L, early_exit = FALSE, ..., censor_val = NULL, censor_range = NULL, missing_range = NULL, vars = NULL, verbose = TRUE ) { chkDots(...) data <- dataset_extract_doublematrix(data, vars) if (any(is.na(data))) data <- as.matrix(hotdeck(data, imp_var = FALSE)) stopifnot(steps >= 3L) if (length(sample_rows) > 1L) { data <- data[sample_rows, ] } else if (nrow(data) > sample_rows) { sample_idx <- sample(nrow(data), sample_rows) data <- data[sample_idx, ] } n <- nrow(data) dists <- dist(data) min_dist <- min(dists) if (min_dist == 0) stop('Minimum distance in the data may not be 0') dists <- as(dists, 'symmetricMatrix') if (is.null(start)) start <- log10(min_dist) #if (missing(step_size)) # step_size = min_dist / steps if (verbose) print(c(min_dist = min_dist, start = start, step_size = step_size)) get_trans_p <- if (test_censoring(censor_val, censor_range, data, missing_range)) { function(sigma) censoring(data, sigma, dists, censor_val, censor_range, missing_range) } else { msqd <- -(dists ^ 2) function(sigma) exp(msqd / (2 * sigma ^ 2)) } do_step <- function(i) { # i can be negative! log_sigma <- start + i*step_size trans_p <- get_trans_p(10 ^ log_sigma) diag_d <- colSums(trans_p, na.rm = TRUE) list(avrd_norm = (sum(log10(diag_d/n) / diag_d)) / sum(1 / diag_d), log_sigma = log_sigma) } avrd_norms <- numeric(steps) log_sigmas <- numeric(steps) dim_norms <- numeric(steps - 1) step_diff <- function(step) { idxs <- c(step, step - 1) diff(avrd_norms[idxs]) / diff(log_sigmas[idxs]) } a0 <- do_step(0L) avrd_norms[[1L]] <- a0$avrd_norm log_sigmas[[1L]] <- a0$log_sigma a1 <- do_step(1) dir <- 1L avrd_norms[[2L]] <- a1$avrd_norm log_sigmas[[2L]] <- a1$log_sigma if (step_diff(2L) < 0) { a1 <- do_step(-1L) dir <- -1L avrd_norms[[2L]] <- a1$avrd_norm log_sigmas[[2L]] <- a1$log_sigma } dim_norms[[1L]] <- step_diff(2L) if (verbose) pb <- txtProgressBar(2L, steps, 1L, style = 3) for (step in seq(2L, steps)) { a_i = do_step(dir * (step - 1L)) avrd_norms[[step]] <- a_i$avrd_norm log_sigmas[[step]] <- a_i$log_sigma dif_step <- step - 1 dim_norms[[dif_step]] <- step_diff(step) if (verbose) setTxtProgressBar(pb, step) if (early_exit && step > 2 && dim_norms[[dif_step]] < dim_norms[[dif_step - 1L]]) { avrd_norms <- avrd_norms[seq_len(step)] log_sigmas <- log_sigmas[seq_len(step)] dim_norms <- dim_norms[seq_len(dif_step)] break } } if (verbose) { setTxtProgressBar(pb, steps) close(pb) } if (early_exit && step == steps) warning('All steps were exhausted without finding a maximum. Using last encountered sigma') optimal_idx <- which.max(dim_norms) ret <- Sigmas( log_sigmas = log_sigmas, dim_norms = dim_norms, optimal_sigma = 10 ^ mean(log_sigmas[c(optimal_idx, optimal_idx + 1L)]), optimal_idx = optimal_idx, avrd_norms = avrd_norms) if (verbose) plot(ret) ret } destiny/R/utils.r0000644000175200017520000001037714516010071015002 0ustar00biocbuildbiocbuild# There is currently a problem on windows which can't display chars in th # text/plain output, which are not available in the current locale. # See https://github.com/IRkernel/repr/issues/28#issuecomment-208574856 #' @importFrom utils capture.output char_fallback <- function(char, default) { real_len <- nchar(char) r_len <- nchar(capture.output(cat(char))) if (real_len == r_len) char else default } sym_times <- char_fallback('\u00D7', 'x') stopifsmall <- function(max_dist) { if (max_dist < .Machine$double.eps) stop(sprintf( 'The supplied sigma is not large enough. Please select a larger one. find_sigmas(data) should return one with the right order of magnitude. (max dist. is %.3e)', max_dist)) } #' @importFrom utils flush.console verbose_timing <- function(verbose, msg, expr) { if (verbose) { cat(sprintf('%s...', msg)) flush.console() dif <- system.time({ r <- force(expr) }) cat(sprintf('...done. Time: %.2fs\n', dif[['elapsed']])) flush.console() r } else expr } #' @importFrom Matrix Diagonal #' @importMethodsFrom Matrix solve accumulated_transitions <- function(dm) { if (!is.null(dm@data_env$propagations)) { # compat dm@data_env$accumulated_transitions <- dm@data_env$propagations rm('propagations', envir = dm@data_env) } if (is.null(dm@data_env$accumulated_transitions)) { if (is.null(dm@transitions)) stop('DiffusionMap was created with suppress_dpt = TRUE') n <- length(dm@d_norm) phi0 <- dm@d_norm / sqrt(sum(dm@d_norm ^ 2)) inv <- solve(Diagonal(n) - dm@transitions + phi0 %*% t(phi0)) dm@data_env$accumulated_transitions <- inv - Diagonal(n) } dm@data_env$accumulated_transitions } hasattr <- function(x, which) !is.null(attr(x, which, exact = TRUE)) flipped_dcs <- function(d, dcs) { if (is(d, 'DiffusionMap')) d <- eigenvectors(d) evs <- as.matrix(d[, abs(dcs)]) evs[, dcs < 0] <- -evs[, dcs < 0] evs } rescale_mat <- function(mat, rescale) { if (is.list(rescale)) { stopifnot(setequal(dimnames(rescale), c('from', 'to'))) rv <- apply(mat, 2L, scales::rescale, rescale$to, rescale$from) } else if (is.array(rescale)) { stopifnot(length(dim(rescale)) == 3L) stopifnot(ncol(mat) == ncol(rescale)) stopifnot(dim(rescale)[[1L]] == 2L) stopifnot(dim(rescale)[[3L]] == 2L) col_type <- get(typeof(mat)) rv <- vapply(seq_len(ncol(mat)), function(d) { scales::rescale(mat[, d], rescale['to', d, ], rescale['from', d, ]) }, col_type(nrow(mat))) } stopifnot(all(dim(rv) == dim(mat))) dimnames(rv) <- dimnames(mat) rv } # irlba supports sparse data, pcaMethods supports NAs. #' @importFrom methods is #' @importFrom pcaMethods pca scores #' @importFrom irlba prcomp_irlba pca_scores <- function(x, n_pcs, center = TRUE, scale = FALSE) { # prcomp_irlba supports unit vector (uv) scaling if (is(x, 'sparseMatrix')) { pcs <- prcomp_irlba(x, n_pcs, center = center, scale. = scale)$x rownames(pcs) <- rownames(x) pcs } else { scores(pca(x, nPcs = n_pcs, center = center, scale = if (scale) 'uv' else 'none')) } } runs <- function(vec) { enc <- rle(vec) enc$values <- make.unique(enc$values, '_') inverse.rle(enc) } upper.tri.sparse <- function(x, diag = FALSE) { # Works just like upper.tri() but doesn't forcibly coerce large 'sparseMatrix' back to 'matrix' if (diag) row(x) <= col(x) else row(x) < col(x) } get_louvain_clusters <- function(transitions) { graph <- igraph::graph_from_adjacency_matrix(transitions, 'undirected', weighted = TRUE) as.integer(unclass(igraph::membership(igraph::cluster_louvain(graph)))) } #' @importFrom BiocGenerics duplicated setMethod('duplicated', 'dgCMatrix', function(x, incomparables = FALSE, MARGIN = 1L, ...) { MARGIN <- as.integer(MARGIN) n <- nrow(x) p <- ncol(x) j <- rep(seq_len(p), diff(x@p)) i <- x@i + 1 v <- x@x if (MARGIN == 1L) { # rows names(v) <- j splits <- split(v, i) is_empty <- setdiff(seq_len(n), i) } else if (MARGIN == 2L) { # columns names(v) <- i splits <- split(v, j) is_empty <- setdiff(seq_len(p), j) } else stop('Invalid MARGIN ', MARGIN, ', matrices only have rows (1) and columns (2).') result <- duplicated.default(splits) if (!any(is_empty)) return(result) out <- logical(if (MARGIN == 1L) n else p) out[-is_empty] <- result if (length(is_empty) > 1) out[is_empty[-1]] <- TRUE out }) destiny/build/0000755000175200017520000000000014516030526014354 5ustar00biocbuildbiocbuilddestiny/data/0000755000175200017520000000000014516010071014157 5ustar00biocbuildbiocbuilddestiny/data/guo.rda0000644000175200017520000015501614516010071015451 0ustar00biocbuildbiocbuild eey&ι55kZsdCnxD({$vvKpdw4FMlc 99c54D0!% ԅ(3sM#35s7ݙ7$h212sl$_21?GkѲs_K{uk{5Wگe7ñi<%iGO :Su}{/}w\'_k޾?how_~o?ӱxowmbw^}_w_~{xNGNaF~}oxJFOY;=KF˿xëO;Wo*cdn>@7W}K\2y5W__yU/ok_fdz{+_˗]N^% W۷_yeQjk}/q5W f>}^s&y]!_s_~9@"\ҟ>V}:w{mD7i\Хǘyp\ +6_wk_lƇ^|iߧkG~/~6淟zD?[ ?6Ol~om^v_ls| qܦ}D/G6~~ot1hy?LKf(i)>݉nNuh\}?yXѸӯ|3ѺS7΍/FywtԊ^LO{9wsH/6֙2yD4OW|z'?޷Yn`ct}xO5Ɨ|mܯha~sK^u=!uc\\OKя>7wnDZn+2 ]Ɨ\t y? >r[:ߋ~I;mFhF~:}7^x=-<],o㸾W#:"2 :Xۜo[>}4u΍h>?s췢}SOKkk+x4=|BS; >~||Y_|sIG?oUS4A'>籯tB9ȐYtJ:r0mny=CEQ~ oTo)ȋ))3տWe ɐ`DY6`;-3Kz|_P ԛJv1X^;‡xgCoxNWil2#|YЏx/FSۄ-t? /ԓ^= ړ4~tĿ+Hb0_"G ?"O&"99G?lM_*zۼ'1fĿ=Oȼ^+3&C3Z{s~|,WE~$?ZJ:>nKދۢ1G@5YG"aУwmDG7x.`1sߩ~A%˰+*l4v87MQ]"YYЫҷ]z-x<~9^4p,W m{K sNY jR(g@eGB{ZQ߲ؿ׼$xa7'|r~? S_cBW_FQUbZ-cpTOӯKF_b^X\;A~^; ;? ;4Oުb3>ދ{}yv;31["9c@{bЧ7iW` xπb_?.~ĺ@~γW|֭l_ዱ=p+XXps# >2?j\)<({~Cv0Év;*E#"GGĬ~qh7e߸ώxr~YY_ ,@E|v{/O>}`U)9%oʳam"6 z,@.B?m ]y0%+&*Чǡ܅vVeckǬoF/C/Y9%a-%GMؗ7op?֣җ7xI8 4~:d^~ V4y{]"v~~ ]~Ѐ^OU;Ӏ~G;lN$do.H|{r"4Q{zs;Qx1oN?|]qf?UNAŮW9p?A1WJ~>yx`d!qʙuTη`gAW?>od݂O?Y2W>kb-@O[َ6^)޹O֫ L=~E 浊qສG kx4@,zxtWպ_[w`~yr8>Ux9&!={/b:öJWgDtq_|n 3g[絃uK<{¥_ sm؅+O^ q"0@`g ?_{]J$Suܿˉߵ2G|=/bs|6'zE?)ƽ}V5~1ω}= {"|;'缓;#>9m*hQ [ r)#zgd9!~c|o3x"7 Gqy zq`|~8Z8D nP?\^{ w o맰ΰ#tXخ}L_g/1G}}G}+)%>}v=TCA/~([u5ȗ{&]>7#qa`U^OEy7ʰ'0q>xy  E~>Yw ︹z@;Z;/ 7s?+'9g#|wTIlu -}~E.OP]zt{Dd3G<m~: {OJG޷ }jG6`NPߜ~K5_0^K)?C~EypoFn1sCw'T4m.|n׆o*0ތ}bQy%k8Ѷoo8+k[Ih=~:7nv ~Pr%e}|{Kآ_zǢmr2al30=K7}v3#w?@Qb}Yġhwю?/ـ\!=~EWo۠g#',ONϵ;eaEA~W V9~؏Eܟ~3@OO,-ćWqP} 7GuPo߲'ԯG<"]7x˘'/#zz߼zyÿ3fg߮j~%ԇ^ h!/eە`QC$o'o/yx/+4"-# &&'щ%`x ~3ge7/K?Ѱ߬qGT7 }fOo~D.ƅ z8YaM̿Qǩo®,~WL\ >Bj ?G?7 cx^8_Yq>L8ҡg+X%g~F~d0,ڶq/]ۚ~:C ?6J#sf? eI jEėDc_nv.8}[1qa0S'i¼[PnW{m!~DOUߖ!lWe# y%ǶK) &-`^8?gn^9wg<$ ~P^To 'PA`~cG@_s]E) Cc5 G_9+q?Vwq,[S^u&~_L>tttDynn"msX,ֻ9cwW/@^EK{?+0MG?zD4_-;tϡ]jǙA<7:.w c)G $Դu+gECjϚ\y0#4#K~K |"Q᳞Lux)y?Xu#mKztgOQ U?{v菁]y~,Xx# -@0~^ɋ]. ]Oo*"Wn~Mv[!AkKcG->SЏgoM.]g< G3,y״'ՎAѷCz 8^Cϭ {~*)_ۚo~G:{Q1n>y)0t%]RcbJqu213NK85-o⃫0?x*`v>7[/1>">7E,@#.f zl4?#}~G'D_-{ɸ/JK78Я0oEq%ߤz_kb+~, ]߭lpGmm+]owIXw[u$Ʈj|O|o?m^1ț,C/ǣi 9Ð%KЗ29#'9߼'O5k3)RP/]"E{db~: އqy2o+_|\y+K{u݆xM6홋 4]@ę?C֭y~| "~~)4iYskMx4g7;O<0W6>񛏚83/7| ~t}/Uߌb=3~/aLns-;ɷpwx7G{zxƍU{A=E@.O/vJI?])+?S@k C7kЯDvWA\.M虒?yxNSyƇӼ_د#Ck3mܵ#g뜅.v>3%rw2/Q7 v!ћc{?3/q~!BnO[=^/8&Oᾆ܁7&Ne7q,ט_3 {~eNZ<-˸R@J݉w>֗} ># ?ݻ_~%~g8a@|W=󄳘W#["֕8"5q_Oz^gI~J_F\Z9}g-Z>)c=rVC%ކ-G`}b_s?Nk2辭<`/Z4@wOʤ+׉[#Q{2N<g } s[>O\k 37믃 9Iޑ55;ГZ 8=};+<Y><^+/l,/ap}09Z'ސWR=0A17mF֫6Z_5{a~ovԗ&6I~3zꏌk^$q掭ɰΧ]xN1*ܹqۀ>/%{y8KfY׈qu]پZp^zg3E\KW-Wȥ!Vn"3)6]z=%)=,#П¼v7 c3?b%'VgW0{Ҏ_뛄:0d"+05U+?ĸEqm"qcn\ye˲ qy3O\\~\J 3ɱ b|OA?m@oEֈ[H{ tcdmM }5tTC|u%L+Qr_לD'+~|?+vJޘ⛬K1?D^%>1g](A7k—<7pGMfe?/v?~OǰJ<͋~lğ {+%T9՗O1Xo ~M)z"୼ú9{sx,yk!aye x tƥs*~CYgo?\\9C~W}a ~ w5/X=/ߚR{xC?rqE7♓5?'+8q*'guH.y}ПߡӟZ6G*棎dO?d'1 ;UP' ym]:Oaƺk@M>&g[,_E/M!q6̓!nA>mǼW>#sM.AO@oE_^~8m||W]D쇹=ZrcD̀? oIOX}.;}eĕ'1̳%}:C)ū}FFJq*#J#^ >/S@Ÿ<Rĭϸk&_kCXAzڕ\$n׋D|z7ۧ4u?Kkgy?=3N0?,?Y~aߺjG UCпzWuUmv$Һi2G@>AyK[|汾e[Ku{ yh;l@?my@Gv|9-=yM^zqo uEMZtHX?fG"!_;=q %!!6sE޹ LF9`_{ ˒Gx9ty-)﨡;1MKГ'瘝{U|,։,va߳.HU/k(5$-~iuLܝ#KA?A1rV43~wc]Kb ֩ZKؕ ޤC<%QCq/m^y*̫P5SO//B^U9 ;x RW` ^蓃8^H #Y!>I|v<~Guwkz"%jAruݨv+FcFҮļ>NYUT7XoY _cg34q|qA 7-Y%rKG7߫CYc2zOFDpևg^Km ~fɼ# yC|>嗌iUa_1zvS? ? 5Š_u~_%8`p0Dq)GE*EW[|?G84R9!'fʈw zW ߑ:*z3/|Vw'i8nWwǢeS9_=V?|vIIM G4bd~ O% aݢoSPkCޫ; u=iOQOsN7Ys]%$u6P? <33G:Ba{O}ž`d=(vG'Vr2x%? yClR2D:gٯu"㦒t>AO K}!n멒YGs i~bƿjJo?(u>~'L!5 vN8%CY㇝n%5ꡬ|,ޛ;P/G=/'#`C%$`m֧O!1m!: qӰ 80nD?ԇŐ.o>ɅՑU_Nc" gE?<((߷}= '8ޯF;~ꕹ!q1_Jk!w&`~̉^/֧08᧣?'~AlU&*|HGD$x9 #6 2G>̬ߩy e.S$=igh}1Oۇޯ }`o?9LU3`#2_<zh*>|ΕkGd  TF7uMďx f?Mc}B4?97?2湃2*Nu a\jyNj3o'm(z^WJ~󑏾_yجǭ >r~_Eb^|œoKC Nx]\:.~70Rh)ynk>Iz7z~O/DnVp2#A)B-odJ7"R t%ڇ, rE+Ss_5r>/"x甿}4q6oyނI61[1m>'`o */ׂl{:<+#yO7ohx^<q=*;x}@XqV~'u&c~Nq?  ~W45_pا0o{߁H}ugkzq#x,C*u&>NL\8x*J.摗ϟ-`P{@'V$~Ot-UzNe߻"):q> {E֧I~8guuH gWPm\{Be~gENjvJ j)'2x'>p@_C=X?|[ݢ> h1T|vhA a\.ƥ|eB&~;_R?ٓ[Ӆ#q'zkG0ʎsxA ;xO?eM#ѼuFďb|rAwOIOv泆|?1;~:b0#+xa]$W o[I?!KmX8[<2Л|i#H\j!g_̟yK{ ڹ,Q5wϜf<& iR]![A| ۆ\(XkCfgm/A|ZW /gV v/ߤ&ׁC/YзqJ!Ǩ' Oo#bVOxzn@gKFgHrѧY>'?1'er5GF"/y#cuaN_\')gQ]'޼RFܗ I6? za #XRÛqH<>Gx`"GzqSY*-~4di|'ؿs~efe6p8['%7 pg?,㉌'3j"s7T jV.?&} ;b?4G1a|ԓ>w KVe~.cfa^E "{Z:%>z?8oY|/>x.׽F΢I> 9'ytIT Wg]$ǒͤ.΅/O'EGe<屏E+U㒔k6;Ro?Pڣ|oq}.@>Y aOK^}xeK?GGvĕ> }Y 8s+|럡n?'7'!* qbX[gc= }Y ӬxN\ ^>TEyQĵ@_WOV`nG9ySLyX>W<=ޭ_}k&85q?Bo(W://0~92CeR>;E3cDy\jρn/2O{ba^|}zw03W~rxsC9h.vd4ߋ?O.mc8mN@ ~ g9}/ES~_BGUfו1nͤ ? Ggu2#{bE=ENO2# ~#2n?^z<3 [g qxb=$~WzA]Ex?ĥcFcM#gAE՟/yh[ ;,⟟S Ѣ'8=Ii_ tL@ݽDǿxswq=]cآ}X:"Bf%Y6Xn}N|acMzc+؊oJO!ȺV듨?kX_DoIqzLЯ@!ueƥngžbO֠/ g@.ߝ?fӒנo{ߢ?Rw=7;ؗm[gj?b/s ) a^2~}'v ?ߎӃ|U;PߤV+^Tnƿ_Vay!_1?' Ԍ6"tOB.w4jY9>,>z*ӿg 1uAn@_km0WV3>; ?ȉ+?nMC] ? _Q;DÊ, C?mPzF;(|.`$*cCW"{Vlv7z~@J܃/c ^H_㺒W|mxc|"Ny^Zj돲~wc=k2<`Ÿ'`o~̬O"|׼\adCb?%- ^؇J}xe\qdzNJ!gϟ:l~;9?ά8@y;qOP:J;x/{tx#qz zҸgG΋Gƺ԰ _Jݱ*?yʹGsc ξ'thic{)+뉍 Gi3?%q2e47Zg}ȵ_Y޶;?Rg1;ߠͺgBzVRξr73>e47ޭxb?7ொ< $_#A C?o[/z֒ FsG sŨ\-?WKiyAGg^){u,C^'vNjı/ӯ煮lb.`~)p 1Y"7jۛ78'x )_U)/w'S쇁ߚ![gk |v(GKkx5}j/nPHq'/D|k|{@\P v=-q8W񥧡az7!/N"f날_hx+@TE Eкq>~'oCO/%?k!E!tz5鯍<Ǻ; z; sKs}'MOdqǪ ι僌ιx ƧԯD?!g_=gA2s+žlzqR|L5s՗gkß[r_C ^u';}t} y@h2g%? q&.󌹎x )2#_'Ob_tG駁]0nR_^ԩ?/'uK9Kpauxԏz %M c] I}gsg{6:jEb~I_У[h?`WB._Ɖ ecm1Y7K2>*Mv;}R:7fqfşwQ"'IݷX&o&ǃꏣ6/!%FmUgԚ ~D~CZ/g!~6q+?8ջ6RG FnC<:GؾUsAF@Uoo"ߏj q~'y?y}k!}1K4|E׋Ώ A-cRWm G:[U>_G6w%:3+x.'_Uq3E>7.2/Bo[•"&Czz(>3??gHcUBo!Zx_B]X?%a1@?)6H}iW<_vF}֕}oM1#0<Vį?>iN'>?Iwe6_))xߏ)߾oOR/Us!_ovIn;UaŇ~de=6?8K#`ڄ=Mw~{9Dw@# q긮@?qY= :('a,fA7/_ҎPqqR_W2v)W TOы?ۻMW^c8^w?P^1I@sBz%]EU@LFg+A6 ch8:K2_TsRohK$}鸈X-a!| O{K-b~oF<>[QyƺD6DuܽŞglW;30?(1Py8|3Z!EEW/Ժ+\>靄_J5)5?&9K߫_,zE:+ E޽w )<'@Koh1(WBgU}yw6( q#tc rN<}nFK<=|ā5 /r?7cފ-GW@3?d5'yo|KvX?qg"/'=%a߰/?ҿ#}fC_N;9P( ?#Fy6YL=k_o?yʟ!WPOCq\ǺǯC;w Zt!pʾuSlY1sCtw9S2'\`}S6|F? C 5_ > .uЇp/O.)/?]z-Q;SCGEbj>kW%? zZ0OS*gWz- P .9%8巉 wb9Z3Ƨ jo-ɾ~Lr{lrDuq& nOsF%`M1Cȟe!*$FЅ͓2^;q=UWʉ>Q<mأkys?ݼc}2&ǘGPQ9g]YGYiF"/#u*D9/.cfb چ#:z~;$``hzSv^>./`]E_48"9ğ~;./L+ʆ`#g+P'D^;Qy$?tt>e~wЏ?F_<(u_>fuK$qZ/x2nX^O:PpoF`usqu6^r}:{zGE?C.9: ?zOIyX!Hcʛ\>8M})n¾-4zCL3GGy|+vQ_!}f~Kkӟfzg }' ~9X\N |] bk{J? } ;ɟʳl>L}i8Y[8oe`Rwr/P'gn@' /E<*?co5g&aD(yc*~!X?4xO$d.HHLj5g-п%ை_q~y E>|_nrꈌ_ImX/)d| ر`Ϩ!_E;uڤ~%~˾K,f=6Ÿg nS!. }CW|⼉ˁyI8d?7xxN l}pz%_2Z}gu0n 6Y#!AHAO@.mW 3Ͽ;}y}dόSI+Z߬]O?]SAp}D^ vοk+(a^N@/%nB$nMc ߪq{ˍCwqsq=xoc<~{7GGA?0? -_i!Acwȯsqk ~F}os mK95g]5ew"1]C^Ug`Kx'ا. =I➯OD?_9/"Τ}":\mO+ }0y@~-b}_$b8wwm$z]=y >~|9]W+'+:5zOjN %yA/wSQ IįI_uS`)&v_OAÒzxn\p'}I_˰{kMuHiC.C\E^GLi$oľ uGB rEIyK/񭛽o Jo`|볟r4}= XY{u.qۄμwU}5utϺ Wmqoy\4fp{M8-s7/\ E.^s0~e])ϔOW z?sG">'Z~@A< }>7_oK|6/R z̫u%R |I+m,TuE؋+ąag֡Q0?Uڵ3ӺkG)G[Ӿ5Wn4 y^꓿fM V.q+sW .?XG}F`zGE/ Ͻ~ؓC+y>p/ԗXW[|0N{+>P&Ne|~Y-ऽg 6G ^_'G,9'qWKIt^3. u?}u?ͼ/C~v\WMKsGy==?q+c#-j}HO!o`4X=B|f};exԂ {) R:^Jxo`8oodg>S?[XaMcdaJ<8qY?̛ȣX>~.9xIcʢo ^ Wm F 5vCQ5T`֡P錄f(cKY11w^x7 >[_ź>:w]?}R~@܋]߂.u# 1nؐu3 _ 8_uvKn[ H{zr`1I٧y{@WS`~?4\dz0风8G_s?;  5 f?~~uց_evk<8ذs|l8? O$=F?jוy8)ȯ =YozՑ)gp=ӆn p]>zZTm~aڕ̧.6>1_˸ ~LSwtDXW862AeKz'`#FO(߀O!Syo DL|IAk ]~XֹN :wX3y?`_`52.T=:ҧޟ}̼Ff!7~wKCޓf'3_ԧ{ͭa4>$uāggh?Hj{}t+ӎ8,몸ij\Wč=K?OTJW/{T>zЗ&C?B}q2owԑ-Ռ~=>h@6nVc`v0U2'?Y S_᧵9Ѻ>艗CWk rE:%Сⱡ 9K1Z▚O{z)wo_KpN6bÁgoK_0܉쁯_;.z9>0ގ]2|1)нȵDv {/Co__i6x?g׺1#7lO? n:yw!7=^>A`?=߫}XAyOԫcgC -> >`ڋ-'8>lG/&{598Pօz? \z7'N}˘7bo3=>k-gg݁:/C?Y^cz~.)}}:WIˌi-,yϙ8+y)ח}؏'^Џ,8"6nЗ{u7z7.q}DPN>~q;}>>` [υ}_.~V=˺̃ߓok_%'W=?;nYu)&O>#o5tigyjo)î]g"yz߆6c #A\|.ߠ3G܅gT< PG_2ޗDAI|wߟ~4>kgK'{nSɲ:iP?dtݿ^'t,g9f5 >qsf_Ág=(󓆿?ȕ~Bq6Sf=P4"7ÿ0}-ĵ`W͸yO7~ ~{8[^˸o܍@1U >ď =Ri9u7Ս|t#_+wq'd~uk~ԬGz օ_OA~0.4ZoY9OE:؇yc_UAV_J>:)|t|ɧ;u}Yqৌ2ur` &xTqEswtpw eți߄̼v+J' N3\s\?h#ע|k0*A'}XOw.OChְه9#uK8dt3mNލͨ_NzԚo:j ;?km#g__Q; z{|CUN;4_vp4 _b__w3i z4Z?o#k}_+x)-#:M3yw_\`\%_KfC @7 Ey$d_oq#?+rD>F*pONӘKX|Z`tJ?iMKJƮMWGy|Ht3y~qsrmH){hA;*pia?K1?6+B~c#}=qӏӢ?T^od#IlX?}_Wxƾ}UpP/U!样h\1>ɜ&"d?7y:^ºuIr I=u}։zp}!7Y߉`J'baɣ  A-S%yd>0 NDފuC@ߠy#7*38 _*50/]gMun;wj2gՌxho!y)VW\QS猾D [ 89Y~TR$~i\=4?4q8sȟW_zr :/{/3m6_a~G?&9cq,XuВ^4 \~5 ~"z;_u ]ys0}*c^V#RO^ ~0K/51a\T>Z:,czO|rB 袃8Fă7ԄgK|%t}x@܁|3p;P2$*NoL~}XwG^m"}aOB_*(wV>?y!u.R`^)u}|]!C`''(^zZ77{yAszxwUz0c 1%&y2:\,W= ^v֏uĵTH]wm0uQD3{?ގ1)+N#{7g}Ƶ:sg~#?,\~:2'؁@]G_zհXg@o Ξ|9 swӓIJJm?L?&Yy"?3#76ƴM SH`>e/_1>Kl|%ʇC1M9Q'oIaX/m\>=>桇;Z38Vڏ;ݏàx?2rz o>=Oh0Ɂ/Y?hxCҷB}7]蟮x*}?QP?^9`'0q\O&r` q/ /Ctiujw`JٷhŘ3YoF߁xhNi0'>(q `/V~?:= .Tp?%O!UA\ur]~<7^UC|_<ygوP?y,s*CV%Ob~8W2A7ͳ"!~2jOorH_:۹A _4^ߩc5//0"/|uPxI3gn ֻC楰NXzͷbU~V:~~%,Z4Ožd\ʌO| g,عy,dž_:`_=5<9wx~Sdz~} };3u7o|BW:u:k{Z\9_'T1NA_=G?Oa6'b^kBwA`Kok0%Ko4N׋5)qo'q[zc~- =k}/j=S\Nw qsp~w-9>;яW=aM q\Cw{z$`*٧~ͺӘ,üH\`Nk!1,>YI ~z*&I>-dis\ϡ_|8wa]:Wvj}/c/UOI|0x3^lpuO@=M[>h q:S >:Qby0taza}쏬%|:xX}B|8Co7Ff8O?/w-3SlFN3з_8q*!W ZkĿ>:+\}'z+MR|&^%a_ ]. Ҁ^=!m?#N֒}WW0,Ikht\ WM6~)~/A[Uֿ{՟.[/~8 nşM?J~Ì~>0uEq9@/7]r?: @{]8]FtWaW?2p1 ccƒʕBG/S&mqKxt@^Q(GҡG}պX#Yv'.3O{|k^Dnxeլ}7B};꣣z\o(_u^|}/~d: ~ou R_䙯13p cAB~?8RcIF`&6'1ﴟl~20D&)u2!f{W!A_h}G︡Cf^/uvR%WAz=+=&4{ދDv EF\\\'⌙OIs#k_uS?i* ]I&.rYѐxŪ^10]ߡ 9 y+q;Eڣ8qc)۠|q 3#WOa<%#sw:Y m3GN\})Aob;6!O COo@?xBˆ:$?g]y?00nƍ_z }To/SAG,x!q oV&uxH~QwB )?D!u43?} ߆)Qs @W9:i~' jϒÎߵ}^-kR̞'~Ke*㠃Y7 Mk)sƞa<@ c85y]?Oά+ޥwJ_s-a'[赂3x{4EGfUo;.NE_WkA`RXWQ5[uN_~wiOnv1 Lߕ}#6^]< )cnw+=?$Nܟ5fZJg]x>9~HPow~ΧIkE zP0ʭX? CqGW΍h*F+OIy3񱧄oe? 'fSU=WWd>S=O+Zi1e?V`L|@pg).\7@q@N6gǠJ/hW^.^Dtaz>ZA_yʧ7z>%/d&Sr}ٯ.{Ǣ[M5;P1IyļcXG#>ǁk]~UW|Xgaw?;`PO _\#|G.A5/C\ڽKߖxt Zrq%S1}_ ymWDTď/=;z}Upp xՓ75O]%O?џ/vE~3'槬_5W{ܢTirB!ㅝq_K! ^1Kr+7}qϺkosy ƺuߠ|O/L NfA죺I1>|/:)ka?>K1,y/_"m$*OWQ_U-gk9_N jFYrGu3+=Cʝ.>&:92|!r%y~~Y3AGf<#d5peF5>[rܯE2~49?Py'OqX]AWwxGdco޻y"7HOܷ#}0ck2/w@GꞾ7iw08>k uOb9"8+hпt#o׀w~f مQ,KE Їz-ZmY?y6~|nyz֥ _"$N Zǯ;Q_o̧s*`w ރZ;ہ_>߯>z-z@_Mž`aQw'eo>R1gէߖul#7nE`"q~?`%̷qy/7 ={@7;6ġ*}?kMnƿX^< EV=]~esoLWp7o뜅~| q͈|3ovЯOm_XO =uR'CΈOz^F?'s쏙xK`夑A5JW/&4B2J& Q\oℬ(tؗ/}fxR?c*~tOfiGy{u.u>Wnwqw;bgzH>ugY_C}<{`ϾHƿft} :Aܣ'q@.wk2ogy?7zRf_&]7ȸTC~Uʸ5w籯yX7?0M]%U6̚7k'zGG #̓=:!c}x^jmߢz5%Ǖ>M? ~;ֿ4zy`rK++C*>xRKWT3F)4u031 :CpE3R v1qx.6-Hw:'>Z\Qߧypss?ѱn塽8/o.3r ߹(A/OPIeUȁ%w2!ץI?Mi}OE/=r??*ꋳO`>}Wo&IN.Sz?s@G"nɺC% пI~\u^pR0~qĝ{JP6L9=]9JbD!:+~;5;_ qу^3WoBB^i);CN=ه-k-w Mc=!mF@:Oq:Tyc?Ց=RF?[h7~5.kcލ>Tu2,^)I bsyY/AբEúvڗ}HwJ/1Y+CW'W])rC@=bGߥzc)݁ Y7q2gE_+to:Q(cOgӬwv()/A/c?I's¯賟R9%g}~'C}ۦy]QB3>|N I#{"'ȾZ$y:?#NgiЛAA@٧Yh aU ӺB̫gvT~4pz=s9 xUA/ N=<`g]~e?Q| ^/䥰Nq??6oD~}x{œ _ݜ8K:|٧t1t#vZ]Ћ[XCnIčOP]q}XR ~/SwiO eoMYy\pt7LKWR_^VkA<8ZڕB WR5~G\yL;%Nֆ<@g ^Q6>Sn?늠TmO<:aMę*?;סڗ +?ǯ/ ~tyU";ޠo|Kg ]Ï!gYD*+T9ˍ .Ҡ;V';PϿ{UC\%7*~_7z+q1C1OMQnqD9œF`? xC^J䧈'AA8? ny~ϲ?"f`o<_ gbYžc_()?NHo6~q5<,{%Y4#Ng!7/5yC>3 8J iEp<\C>ۆ<;I|rb'twL jb}+Tߪu3 v܄m=P?j !_|N~Nq?1p~|֓ͺx>S x/aUs?[oA'~)d>h޽8#c+?|8P<'O(i.\fRՕrYÞ+"A䮫틣zp>7ėw=? a_dSy}J @^YaXHQ2qZ&IAe3ł{ר\=u>/K#~{*kZ7F-C϶}2{]}8nfk+umZ(~޼{{Z3rAY;]I^㜃>c' S ZW ;3#A?q_HzUA@#_{hAa0qQ+c9n{qA8Ec;_(~lN~|r__-}NWq%7K]\0@xw~2֯` 5^;t!2ΔºWph>alOe|-5`ĺyfZŏ1r>{Y)Ai887gO\;nwOc_s |Ů}q~IFۑb;[p_DA/R2v^߳T zh #u0:ƻs]u?@DJ1EAf߬y zu~tq$nc~rZECz\:G|^nD}5Lz-d_J}.]z/dú;exQ7C'SO}#)ߏO7yleֽ m'}rrEԠٷ=;ެ/܀e쀕oJ㍃izy%ģrFca';O_C'gע_/6jT:oDWp/wOcYJo<ר[>/Q,}?#q~\s )s,o-sǾy ??:$?> aRʁ>vu}^;xЭ{}IYO(yUP_ϷrkR<8eЭyL}`'Vggg)#x||ǰLVwy2OqQ>ZБ{q:Sdqljq?3L_>y);OU3 {;OZW?;Iѷ3,ka_b+O5[;{kWOYHX7:.P#ކӕoRyCx|Е80U03~* O ṣu%RW~Qо.7G=K^E\+'NR(l$5K[>?Nb'nyQ8s( i͸foop=H=X1.KAu奈>~ξ9\f-q|i1N@\WoY2~Uߩyݬ?:_;n-+Z$XdEKԾ;!{ʗx0uVo6)CoFcʐj|s) ڂ( ?OCxe[6g~8ur> !u U" KWt}h bv1|C>u_,N3k_?Yp}K %X}Cě0Nl9po=8;ַb=E<|h*~*>׉Ae#Y2 .oqGg5r>+c Կcb_oka#gk~zCW>g/@p7߄:q 4b貹 J=@H؟`=_쿰:{v=e)_r_K_Q?_~jW&oO;"yl~r t~q77W݃~%ޡ>EYsf}d~~bƩҧ%+=3ք ngzbXļ;N[a4/\8¸9:Sw@Ͼ*.q$lYog}9Î8q$iح?Jg ߊG8XכALT Au_=4SGᩭߋ:j@ϭbC?_sp%ЛExŽOݸ-K[ә߂F/ ]KπD۠6Ozq?ϵ>5N~AGyO,>X , vo^ğH82~b>kp% w)фh 㣿9߀}a"f:xv~xKC;>0(q0ƟG6?$Ux/k9:FoaI$[G G:mЇʟ:ǀ;~\Tt[P_6_$RW]~>DF/yi=3n":sfאe>Y[|/Q6_D>xyڇV#y19QC\8{Cs_<?:{zz\|r L{ Y8mCHԋāGf|8- 'yO}8U)3gx=V qkzz̧G<8Gݟ.+qzݷ 𛏸طU @»M/f!Q;\w~נi|ȟ෠:s]zh+/:}<>Y4 C Cgc?awHyo˰ڿMH<2h'-^=T/Y^hO#ew7>cdp*!ΈxDnE=k/zBi\E!~7.FSF\=qO:Og[2(A>Jݪ~֋Rq@Xˠdo%<z֯}A?Aƞ{ اRf3:HCF q޸µwX7O ~>S`[^g<73 y0q& ;eQK{s)`h_ 75غ)|ߋ8D֣{|o:ΐ1S|C:W_.{}P%#Oli 1a׵a5UaqZ[ww?W{т7gnO}B+qyp`d]ճDEYRjo?G!zcyַ7iSL.>`cdC-3X@Oc+wn|Iw?1 `.I/o.u/'>O}zIqL}X;'EY?3M1G (7g,N}LG9kzLt~ u|(oq |v[C݇#v=ƎjcݪQAK&$7ֹBxԙ#HN}V 7'xվ~rGf'E?3.M(9ǡr֌ B8N~Ncߙѧ}؇];ȏ;sԡzF %m9NPza\#CO3 #8zY5]Ǘe@` 7d}WOܬ`]_%ETD7:Cß[C(޻8s~~j]?W/Yd ~"M\)鳳=gsći=L/wy?ߚsg XW{ 0c_ʯWøDɌz'qq>^2ǫ1w}&\y'~\M_)yGp_&MR?yiմ|X_d=;2nbQ{>$^ !gG:GP݀rqIS{UDptjt>aw_F@S:K',?&M|MF? XQO5l~?pӗG9҉ƿ'FH|xݘѯT^8~&\z6,n#~׫^H}iO?qyCTYGw 5q%?골>~N*dže9Oۊn|{Ƹؿxn@ߴTIpg}GL$uO Iat<8uϙ&N}y'}ߐ@ݳ{Q7ѻ?r󟄽Yk8gO?uG?9?q vza/'XB.f~ _)!7-WtшI CDr,ۆFv?egg9.a[ԙS+oRQ{`&֋}^/"/O]} &+^IuoH?xz&; ]wa@YXG}<!0MߡAS^0\#s/GģRN5@M*ay8mGeS+J vo`VG(Y q5+f-b~{u`OHXlsG[E 0w ~4u~+>t>lZ j}J;MQc쏀Ϊ ܯd 4]FG$NI=׀UGߟfHA<%sW}xϺHKYg߳k}HPဟsF}*y[^=~+= n\%-q/}/̗ͫ'v#oS=- as*82s{Rq}n|lU)ow@>IόN~I> Kr;nD> 4O>Dhz%?D|u0_/o9 5n9pmMȥ~qqqr?NuL~X2pޟN WjMg?*/O;?x/k,9q y_a[x)#O1't=:H~1?#\|,elqS3^J?.B3 }`I}}5|V?Bqvݱ/>/BN5/"}cI~H[jH<$)ܙJ{?{`?Z|i=[QOn⑼#dj@/EpjOr`7O`7ȘzuTLYXe(xO1Cd4~:z?`U];}3M!}qx!CvZSF?hzl_j  Gc>Bޗ!cfbVn8~YB~/Ma,-ț8:ȵ4u畲Nk]};ˬs_DZHx\Сdq]ŗ4^5{ nBDWzݏϛ𓸻J(7?KGv4kc2.CG`=jn}gOۈ_/`}{?/pOi[!v҇J_= %W5y䶙5f0N WTzuY8aS ~۫&t< L\6r8 c̛^~K_3U>8\~_u츙\'qV F6"\ܐG<uow<)/yiqS'x-<߇6Ok<06|+ =L}ӌzƕK -g?j$'^{sES{ ķ7vٴׂ/gg q?p(`s;62ϞԷ}7b"ɟxrh݊y-Jj|[x._4g>C[xzyDQ ĕg0o3BwDg{o?W cX3Lek`/Hxu>*/} &"Ye* 3@;v17X!qymzek{daOOFih!^?TB ~@!AyluY6j#_gU7ȷZi#wl~OG'9w0q^D;yP;\?^gA/ȧ cݩ#uRb_]1퓌{ is7,t1C֥ N7 }}wn7!gg$(:`_B3;d.r>Ƨug.32}ɮ7µgc>fWq>mP9ڕtg\e=1OzE\Ori=Yf`aײ3=W1I]z/L磎H7d'םT~g`.sCvNY #u ׺à6>,K7sq=W}G3x, ?3nSdSx ;`/$cM|F?G][#Ѳ[q 34 1@{(|z$m]1c^'l`K 'I̿2RRU/stEm>S|/YJ﵌OE/p1+gJɬa3|!YYW)> >w@^d}SWq~=}df(π{wz@ ry\M&^ r>}هr͌g(nI%ٶ [ LcqGX~c/;G̏LjjWa_2qc^DM ԗZ\߂:sR\znmx@)-uWG/G%? 5 ze݁!B߁*l~>{fIeXh~a_]d_\=@ͫ}F>F̛2x69\&D;pε~X\{\}' /1.kC=ym7|CZ׏`Я<.5#+C+FuGR2iz'K&nںO׏yf;*ah5?Rs{̟nBd^qO%tpǸ#x0> x C"be?pMI!=,6?b>]y3U:xҧ?9.Zg nW 3z~ 8ևT9d}:M\E];~Czf=[׉ZnWK]Y' ևmS?л ӆ?17iL}: 'F=mv6~8)J7c@Ĺ//{9R3wn=~]_F2 }[܃~'73DA{̯6zVzrd[`Z$=C,[G'3_1Xpq>W| mc{buXoa O6UЧ uy&. _zP'bu?~$m0~_q{fr}G /O6u#7ƣmA?dj:CLcCmE)W/ya:V6`%Ľ`WZVSgpցk߱N{z_;5\i}*ve ~"ZߘuG*[,0|&\Eп[/PG\53x$~uuK ~3W)79u_s!NÏ3wb\xzX>oϞ7鲎ӗH0U3Oy}NF|/!ׄ':!%KU=Y{~J+BwR>yt}5hR$kKǰ<'ѻGT~~S@>Š3=8&M#=CgsɿN/; Gi_ >>N 5y 5|þ(2;}xy O;67b ]GcgeoX?dЃ^??H|=. glwG_ P̯ho}T|U%֛kks~!}@pk/:B}hx>֋`~KEW/d4?F 1}ڄcSh6uj/1o:w'n|]ꤑv>)(Eyș?s( 9Os_,qzu)C̿!><;DϷ}ESae^:) 'ȣ<◵ƒ)qxh}} ~f 4^\Nwq2OpZ?i6ܯyKrM\O{gyN*h:o!*_iBZ{]=}/ne (wI\}06es }#SطO<5w/s[OP5Wݱ>p.Y mR{qh_!raE?u?Xa}tֽR=_d9%Α}u9_/`]Q;IxF|XWe=>GaEz^!Y~3Cu~; Qtt>W|= ԉi; ofG1g<~_ =ʮN"΀}#~?|#_ U-?GiwxX*uWO'̂XrznF'n}7u"oC/|q?8는 .ŏ Ct'M\,8*08l;};uMħA]=Cz ꡰfjb_=OW+~ԏy>S5_#ӯ\{זvx?XG֭%}#~6:5P\l?Z}ҋ׾ ?!}XN%v2U~ n8- ֘">:R ~Z[\ C2kmC|/VhC߲utx_a /0Ow g\?= gYgQCf[}Su?rƟy=ӏ%><Q\EnZf#~z8ױ>CK_ߜ9~ݬkЗvƩا͢OyyLj;>D#Ѹ.c`}?s, F'xhwN-sup/ʐ{Y,Q֏Mby ا38zqݟ6qiV&#?N)=\}+Q<5f\nzkw\_C@Wup~u4_i`>7%wwG iGh}_iSϔ3Mqe?>\x {uQ įgTn ^{v`f{Nsx熿D?yXļdyς7c]):WY83{''fǃS/[.eЗL!ð?;^{a_ '3!~+KZ묲AhA.N7vp/Ђ]ƾ;{QY'9Fxqc. ~E?r z zGzا뜱+snE;<鏂^/m}/|f u?@q_r߁yl}';mohB)gu~+3Jw>H*9]*Ꙣa_=&A= ;jjqށP%y߱~Pv*Z+`挞1~9Efn8}}n6 |c{ 1ĵ _<C:}s΋hw^* 'o2v?=3DU:Θ3/jsIRĺMbzɰ%-O;wx^1z5r%i!U?ikV]Gb xm,#0aBOp'kc^~bO+Xs/1 y7JϐGYA6Z7WwaV&>!8 ᫁zguzMN N^J<)Sx/۲YyX;wЎ1?4"Hb"♉kcG\pSrkG[;:Hя1:GʧM܃qa{4au4:C֍zzp7'W5;`av>҆k ׮= yx,߰ |=k_گ~]n 룛>MOR^:O>XZ/W{b1[ n>WݦD>kM ߠ_kY}'aYzͥI|NNޟ}EI5qr{>췆ڰ3Fް0=S 0B9/c) ;ue扭C?/i~Lt+1/Dskޝ;$VxyW~g80֭:N O_O>ohw,/ߘ/E]m01 ?"`_$3?|Axx_zI膿 rzƪ;Kf}X8=9$.1rb8Dwp>Y1*3~cY88|g }ykǾƞ#r ~ WU÷3sQwxt=zţvQcF]?x"◕oq=3}͙yW"ּ'!&1҇v>{c>S ]G_0E~?W ѭs߂4g ~dɧ?=6D58@}yQܓhuQq )`:pьOg[zA܅9yn#f?4>6z+)Ӑ>\ߩx)ȏܷ];wnϏD %KCz˂OeU:ytDr8U_ځ~Sѷ;]K"!u{Znv#w;+f?oς}x}`߯\d6i0tr[-#7my]Eo3o9u|%2r^OqJwSkH?^I0?WKz'$|WQ;xrf8kCpm-ڥ..=r@"woB#`7&76Dj#Gn!/ {>NB'N\ׯ^vc$)GJ=+"\I=~`웭|0B>uYq}J.` >Pz7hP|hۧ-=#z׷ .T:⍈yɋN>. ~3EE_=^sUYwۇ~p?[1|KCsy6H~$X_G=/v#?e>SD %i_ _83zzj =x{xNarGb}䭿+Ƈ\Ӱ:*/1_aQ{F/lD `иnlyk<|E raD=񺙇\}}2b3 z^U6> *zz"Eы@ (x~$uoUܓ{g u[iap; @ob߮KX̸W`UY׷ĥP"/V^-q3rIze_nD3.6~0tF_LY|[)U3uaXw!z>|ֽ6m?t^r ل(38|ڟx"اÙ!tc|ΟG[4U/Kq:/F!^"q8HpW3 {& ?Z>y0uyF^ɍ{? qMK؟3^7f~L/q<y5]!4CT'_`f߳I _#+}-*߰ ^t}gMV#{㉁~I<)>x{<6`ǼT}&֩Q_ gh[rooNC5d싄Y,MR+?$N1L?cy=_X~zOyc<<13 .]<׊̃!{ÿ#u['|? >2zCz&&Ǣo32X p?2ŵ:Kf<}ѮMp&D/ ѯM\Y zJƏ27~fAܢC'uɀo/~ޱjp۱wlg=| }pk~7]?`@51}OI҄/Xa\]1F*2%"ƢQuWp~&`_0< ;q$dDtUK=M}~uwU3wzF {iu`1ϸ/ "O8߫| ֋Yo13"xئ8Klf^wX7#3撩gq]*VKK=z/^^~w[/]{{gt.>ͫ]xվ}{'fsl篼8_R^+,W_\x; &6O.tֳk޻ }{ <{5߸tV/ޭ'W}UqN^t{COt_^c}{#Ru_]WOکڥڭڣ:3>CG;gt]}FWgt=}FOg=}FOg=}FOXg3u}ƺ>c]Xgggggggggggggggggggggggg;;;;;;;;;gggggg8Gq>}9s3g8={ǎg\3?igO;;~Ύvv㧝?igOOOOOOOOOOOOOOOOOOOOO[?m=~zi㧭O[?mgvO?mgvO?mgvO?mW]vO?mW]vO?mwvO?mwvO?mwO?mO=O?mO=O?iO;'~9ΉvNs⧝?i1/ƼnK1/ƼnK1/ƼnK1/ƼnK1/ƼnK1/ƼnK1/ƼnK1/ƼnK1/ƼnK1/ƼnK1/ƼnK1/ƼnK1/ƼnK1/ƼnK1/ƼnK1/ƼnK1/Ƽn@1\sn51\sn*Oo(u޷_~ի.k߹pvR8^|1K_E}]_ψuŐ;msMxKx8<o _ K#mqix\ϸ"<2><>[xAxq[x|"<> ? O? ?IIx|6<4<? Wx|.<<<>w.G"s4hgc I݄LG:<½؄olgYr}&&$2 M8C!<6› k=<3e 㟅G;<: ;mB%hDb{Nx<<87<~!<8;<6B/d!O|>d!O^!O|>dJ3d>M4d'L{2d'L{2dN{8dK{.d7L{3d7L/d'L{2o6q 4C _j})09usӜruO{{=5qO9v׼v׼v׼v׼v׼v׼v׼v}]kw2qO33333݋_뺧=t=5vOkn^sݼyu5ꮛ]w_{}u^?j{=u^{;k43~mܜut{=qO9챳ÝyڿwڿO>{NNQ7|"y]|s9߭;4g_nnw{8ߝ|wN=upÜgNs˜6{9pfb=t=rOw{Sg\]wffffffO%=qsOӝnt{vL8=t=rOw0^7ӽn{Lu3f ծ]7Tnv,n k7﹧۝.t{NwwyiyfwyiyfwyiyY]3ܮn^sogNӝ.t{j.wr.war.wav}nv}nq}{qG;uGx. lseϹg< ֝߭;[w~Nw;t~.wߝFO)sn9_7;.sۜ15vpz3ܮn k5vpzf=3ܞn g3p{fffff~fffdv]컆컆컆컆컆컆컆컆컆컆gwpf]{n }\=]wOŻy]i=]wOw3uw_7˿n,YufPpf]3 k5wf.\?1qKf3$Tx xT{oY7Owp>)O҇gN~mzDžяϼދ\׽^>}=on|Տ߽*.Ry:_nx/|l_fb[>r?oo{']K{ 1)O-\`@\+qYN\+pqy]_w\?^De~¾{?)nlk>|*Յ]sT\}]|f}tϾ}g7_\w޼{9 {g y/|W磟+_O]'kvnOJq7N.~ yc?vM=/k򭼘mo͞-~b͋w't#L~sݘ/>ǯ僸Nue3{?{U\xxw8~o_kn+m'yY~2/40+=\;<}FMoLռqm/oˌFt\͗_q=4|5?ͧ1$/.Qk:/4~m\om8|s3W>s+gy?s'?p1N:_ϞuXd|2o5>Ϲ;1/+1Wߜ6b߳?)k%o5y9yӼra|%EXǿbܲ׹fx?r9-ѐqϷZ<ǃٓu+8?X<~oSɷdgy\ފy˞)nwaxxq~3_[ɾ},}x;<7sb})ߝ "l_$_Z}}u0*WGˏ|xƯxźž_[g}.8>V)vr;_o$;2.?a(ӝ۬uﻜƹp~~Mj0. l_ٳطW:bo c_{v1.M/eq<xse[yq ;^>W<?k=?e=O9WYO~E)Geb}+x|zrr.9%/~oyz؉cc~v~+ƭz8sco W󳊝L/bUE~TZ;yofϱ?v3؛uE?m7ƹ"k{ǹzÏkuFQs%{Ϸ/?/~=]qMekqNf_M{wm{,~^ln҅s6df<*1Ás1ޣGٿg׼fsΰo'y>9\|Nwu5b+:8׏].~냿W?959#uƥ<. |5!{hs>X :&Ng$xk矋ɞ ?{ž,s~+/3q ~K3|_mOxyk(vS\u=zX|1>(Ͽvz<ǿ{uΙ=ŏ iw8'Gpcb'G0b|/o(`a?:ƹ3~{.OCq.o`dO2_/?P˾stz<qc37V? u̷=ȭ_Z[]oN|l0/Woㇰ%k:έj|y=8g9WWOuzb8Oc]e3+aZßƾo}>>72}?!+wmrF%[χ)C>__`oǠ i92n:}mOF6ρ+k}Lbʸ_?Y@ᇼ2c^֊/{si-|<(s) >vssU|c^w ^;b9ns+}< @:gk̻~__ae|5zM'hn9ꬫ؏E\-,w?m|kgrP|f}vgn"^?\gk1_Χ~gy9>c25wem<#6_m1>!;ߧ_? xXOm $}HÎ`瘇!~>ᅢcΫb]|>or>+5>Ͽ? ׹1-} qnq^3;=.1.m+qΩ.o޳c+LĻ6/ *dW X>'^Monw8Ow/u{o0u?!_|= ] =ӂu'?6<2>;O +,&Ήw[|Z1Fv:v{ܖ]bWy/㪭|_ׂGOq._eXeReyV~)cxl+>|>x|lIeSL8J>nG.u OYG#!sߴC^ /;|Rawy#K8>f_kdwaLJ̓h Q|8S{\^4_d7Cmpa:>}]c~ĸcJU>\z+g}~ mD;e__e ;"'{}5ź;752p~Oȏ_;Vح]$uO7//UŸ5ןN~``8tpk4vB?t>,qcWO/iGJ;\5 x/xsym^‘W+6ìqs<+??`=$ϻ8o8̓X._8w͸b{WޓZeGU3y}* Cx.vV|uX_x>1};+oݗGcds ƵUq!Ϲf\)7>}> og_'B4?ֈg/wEexl3s%*{F'8'/ y=x]luss.8w;Ba}yw?޽Lıbmb\;?_ oqM 8aξq%,8u_ )Σē6l{^\߸>G4O-}gÞtc7z)ՔGs?[Yǟ01hG+f[5<+ģֿ,MyC#7W+}8ň8h2ﳮa;G|5~yk`ߜ~'-Wg^8<[/WM{A{V7Γe_#}|vdGփ؟s/_:xB#-_5O3 C p뙷xvWqIb[*b?|s?8w:f]5M9"W j a>nLƑ#?=,Q⯲Oq8kcmpo;"`/ƞ~=i)O^V9}X_yHM`tHq1ods_O*Uq瑇ض2%~'(%>-Go \/|iGCŧ[Ngװgy5(R1ou#}*ιqvh􍰋Wmo}{K独طASO*?>xsO\X;@&q°_C?s?ڼyWy|o]WqW=>(S)?{=kj~z.qC{ͷ_ao3"a> qho+&w#v6osv_6d}-;|xy 2vzw3z Nao?vO{{/=E 1l7W)V4cO Yϫb=l0 Ǖu-g?~?>{/F2f7ۋIM}ߣk<=G8t[jjWնmsq8&v0|+ k)l {%2ny97]7Cj!:8h3NMp82|yiqα. ~ؗj}f<]q,28wޛ\}J~q1nQSM&$x;w=C9]uB56>`7ٗW<*9 ODu?u~ыǹw2_cO9>_#BYcs&>BL]Rt7Mfo47bX+2zٸOs`7ĕe˺U1ㇹO-gvxUX g+};<ĉ{.oǺWSc8oϻ؟հ[yw 'MMxw {yaΛ5pjwyk|awk[cOofg3WVW?ɻʣw5_ nvݧ)3*W%>2yzgSW;AMyW۬>x@um7~jfy*~ƕS\KW 7vx>yz~jrq.9;Iy cݙ`^y9ȹD~ א}5y4msXxasZ~`+})=x/KKlGs<|?o|;~. 88[;N9O\z_/0nM*}d_q*}xK2ͼ앸x!q@y7_7WCJULed7w9=yxqyq?/= 9"^?cJJ-{G\'"?/4ٟ/n p.6;wKlfyyy&guY7~>-ǰGV\Il )[m6G8'x_5'f_T_]^ob=py}WˌvOJǼ_?,\W+?˅'ciuЏ'.٘9M]f?_OD ~`1j0{㼼^.moGWVoŁ3OMÌy}}]xW󞤎|}?:)N`R^5aSZ)2ε<7qav}ɸy7*g7-gb^Sy3?5g j:ɯo1߭{P`8D(~fOʞ)H=ovgHĸo{ȲE6^K\h؁㬓߈uF}թ|%x){=}ckOh1"漣ocg q Iu_Hq"J^'9G7eΔE`}έM]-8Ѫ6yk!OڼxOyb_q'ςsK!qO>%{s}8c\u3":* Hqcý(CfQwy-r.3_q6x>p~6x}(|b<+۱^௲WO|uo[ԇvqU份2|̸7?eн|/\~3WڃsR.yu=y^o!2?p(>2oK}=sCZj8|r8\]A\?žTϽx~뿭_K:<(w=/WݕϹc-?3WU׼Xz9Z6~ӼF[+Lf!vSz[M{}G-C'?*&/r__-WNb5`{qs69V9gaIt_lnLWﲫnX%#~j_Ì,~i{Hs/䯲(b%.FL|5 nb^| <Xz+C%_)ӹĎ_SܾB5~=pd?7.7~_WR3VL=Cy98yAJ:&V.e,J>~?O9oa3vD< fϳO͇WOOuUw?Ífq̞̻#B-콺G>F ܄Ŀcro/Ƽճ2wYm4R^;u:9:X`"9? G#@~:_mO_~6^Dܴ4_}b/Kܫ!޿:yˌzc>gĺM->?v`=6WZ84?aaރtWk(c{i|a_:+yxq:~.b՗_ rq~\3G-Ϙ{F!*CS!qTq;.x=8/=U O=nU%GUylꮙWa8Aw-=}_0_W) o˞%I&Z!Z_m?,{ii=cqL LA0{5嫧}e_zu#W ^X59=Oʞ漓w"o}J_mcvmEp;-M>~o~N4u-~V\?Y`8Y~ݬy\XW?~'xdxqy}U2L4sY5p qi+tkl]^eJ}U%g6U͸~IgyKu͜Y I;.{~7`ػ6vMbSqOGߔtpCP?\ɥzpdj}b}Ewt>\'36+]d%#|s|a]3NOe;X5΍>y)[.ޭYW]z:$^PG>⿖e.S|ᑧ+'؞&#A^uC_Mq.xq}fR>`]7ۯG/Woy^+̏q x6TE|=zG䯬 >$z)e&Nu*{qW&?m f㼊ZAyǬźCW-_w!? ?wƷW5S{>{l.9#D{1o::gV,%_{g.o \dۀKs_UgΛޯO| n4?Pj+w{웽o'틱y+-oޘUD_uM')w>I?|o14^5Ƶ'_W7w-<~/z _mp>8]7u×NP޺,qfx1 c[jU˯MZةe<5__W>'Y篍y?&;o#ω< @i\̷caWgפ5֡WoTq>.U/hٰ;GKCN{  ۳8:3j{Mp9v|*'> I _{_L|t>yK! G׆ G_E}!qyW0?6lb仍=|nkwॾ ؉>wu9~:| A_(hS뗿 K5kaݔS?Xog7?p &e;D?s(_+.F26gUg`_:;I{އ#kU<{i'_e|q잆o|~2%|*v8_1oͼE\]>:ԳJ:YZ)Ne\|JR귯^TwPIx*NKG|:n7`k= uv!6X:\|@Jx.qMwv R]b}$WMS̿i_Nzk˾}?_fߎIY}viޯ#aWuQrWnjOKx8$S錣8!cY{ZgvGbt8+m63ع/#e?JطL}yf;}5~_v}e^fvҾGGI\qT>!ӼOu"/aOie=aW"^RCJ'GĿпޔ^Dx'R~||C{xRT׭h~ ]yPZ^l0-b|0m=+5[ְ>y,"5myVWY>#/5=omb*G5WY~ɾ''~` +-y}P{Xs|>to7!.~fúZ}vBoMŹ4`0QTsz?BP?pG@=񣫼GK#n0wگҸ}'uXW7N}Ȗ/ηMxb?rDs5b.\S}uZBʓ1X q jWMsGǨR:K{{$7>z2OGn}~^Λip}W~a36KG?F\W}~e>C깘8}`;XWÿNń8BG0?}yI_ ~Wo̻92oAG&{p]u}w1n_Zطt?ˬ|A|NἯ>~5F)Z%_X 5uQ)ûS>{ ?s/|8/r.3Nm] Kq%mrvqy˭K.󮾶}O.d:sQ,M*;ļtXWS: _ s{~󶎟Z_-o}-x&u%5n.~ُWź?ؼbݾޤڀsL?:|?p8[#Yx㜷:Пg<#iZ? Xg#r=FbVď/قasՅ{_}+Gk_bQza]YxܒY/1?P}H77~<[!v>D[,P~~D7 <͸b/鯛+ا#hAS}\>A%8b7}(1,q[w>`uL+!^c!=zwP2!t^N~ɼI7t^z#J/L[WG+ѳbN-Qou1TQ|e> k}j/ױQ䧨>!p??tjMSTևY0 k{x8o[Oc#+ٷ?ġg٩s䚤?9iZuoEx'Ցbǭ.WXf'S=~%_{Y͂'~Pv}d?M΍rMKtԷjnצ*qG-36 ̗w2<8"n8qE}o([ _e9np w\_e)RYG4/ؒ ?>.QҼG8p*y*bqJ;9Pc^g}j^Ry",ߖ'oW8G<coc ?x٧s!)$:>EWɸeh/xi}s3nA~$cVs?a]i>cFnޔg|'sex iESj"zl%,tq/_^iGُE^~V[e׍pD[/yo]qBvCo`"v}}͐8q9mԓ&>?GOC1z :;{lm.sl2>x|{c=GOskά3?܋k~m~)eEsS~A3/Kғa>+Ro.9ok{hy_k/̯bOq>x$b|W)f"_3?`##X~:9H_3~C :&Yy*!Mg8GI|~ S/T#>&?t=W/q?]e(^GɿʷxOG$?~tz^W9GVrѻ5pq:#{ rTg9A>lo|gI\.bΡmp\c_oy.MHWu96mL#ϪqG_度'w⇫o}ɞN:Y;qʛ0.Г[WN_gzD|y*هW|lW }$Eॳg3oSpmO<^+ ~GE_񤓦 >py͞uuR޳}̻?5+g:a9Yٓ߯M} OI}qn&t[%o+S౳+#&>G&5u T/x>!΁w Y5wJ<[}᯲,(Sv[ޏ进Gj[I?P>.U֩:@П4:X?dL}pKBcKU y-գz_o503 ݴ.gH_θyc;3n=s߉Ϙ=\y?p۟uЇK} */}⯌AYo>y!?hJ{;G=~?:j ilC XO8d0bMy|%EF\\5+~Ev^Ͼk։2?xm˛uIv[ uԷ~BmvYe~zuS},gOfX2:WS>I<8$^dU2bw!~!ƻ˺Za\k49H\x&'xGcGO-51}' 7җso'2ʚcyqNs q{_O͟;W|;]Apʻ9yts5>f{~} m84~}n:8wqYc|uXG5^3/^OdxݨoaJ}ojy4o> cZO$ůI] ~zUu=c^|5>N:#Sw$^BxُY};y˥ufdgPأkRecs`U~ME|NF/k'G-Hnr.ʳfϲaSϕ~ؓ:*gZ%:%n2-ڟ`y 3䛮{̗{[ BYuaGnLS/) g9QIeh?wƽg}/UϫE;{lq_Yts|D|oG✕m+u꿆 ?!?7d=_m:_}6C}xZ:S¾"ӱjib_D7[/jK[xؙŸV/T@-+6[IG!չZʳ^q}%}uu⽤O~nóps+OYƞ.o#WYgWgn ! fgW@u N]/ :=g~] vMv(F.sS^=q?/O:uWװ3/m?=ql}~}g֯Uqh~`?h m>[ؿx;okx|*~zV-=eO˳/෌ӆ/;QwO>U=3ٟR_}ޘg7TÏ3q_=9dW/Me'>,>cQ󾤋[}Tz̧Qz?zW%(gc;Spgҟ_ܝy  W}S}W1xKcz\'^~/%#pMpցoI T+&|&'ۯG^Q>We6Y}xkq<,B/%5Dmzba]}jb7:~ AzSuS>׃v|_=.$`'[a~CZjR=WUx~y 7qyw:9]c/-~R¼`Q`紏Cw`'3I\> αOʐf@(>< _?ܞyv9wkx^잉uX+1nY辝LI [7S/3)>[Xשoa5qyoLň+jcS1NS m_cx&ݿWҹXa_YvR+xojcC3O_U_O 3ԍ}Kg:T;?AKIb{c~y|4'/jKy'M>֛u>c=+;9?y>ܡ+ >&Q_M u'}<|IWKio>pbQ=haz_Q'Do˞(ހ}kad4o>O_l^Q|_Yuy Kdz_||YM[$ߴ>ViAK+yԽ=#W~56\o^J_|d_Z}^s:JeLZz^7w=%*LÇķY}2ZeYѯdź{DL~O3;\wu{W+uf2~gwE/sosLu_m2~Mr/-\M3-y8G"?|h=)>ӿqH͇ߥAҿ'p>x"*B/J0S :dYc_?k̓Wnp >KX׋7̫}{ا :$OzW⽶RU6ǯư1?_ʾUN%#X?xsϺ̾Kx%:/IXď @ٹ>uh~$\W=7_0?<KJ̱F|6sF%WEf=iՍ _xTJ~g=q:>6]YyI%?z0OYIUUC"~zMX1gs^؁ Zs,D|ݲ*ρ?0Oξpv/ թjM޷κIҜCqɒ~`vmNLTո8SQjRa_:rJOnI8&n*;%d9y{R8s%z=̰s&|_LasU~)+1]8y'~R.KGCċm aFһ" oꮨo;E= /ӞfgKa܎SnKqb7'-Sg݊\'(e;uKd|0gb>qϞ<9R1uK5S3XTI:9֏<|#_+;_byx!3ĥ4_5?3+u%ekW>&lm1I ۟M{O2.m^ľ.?j|'e?_ O?{{[Xe@w}C~^⯪~:0W)YOR~yw˼FާRyփ_b^?>bY?ynz3>'}%MS'o_ϙ^K7b]}&߭~`?|%_j 2.J}B̛Ї}V|(b?g4}@K83Ⱦ8_%ѾH_yx uW틷=i=u~Q']MqpN?@y@m[ ylj?lϵ6qΘq_;o~;j Oqu9WWʾ3HߎN~)kMc`_'#2=s=t8X{>`R=XL5¸y=Ui0^蓏#>}K~8%<@^+_eϓ7".B<=}-sL~SƱJ?1 _dO`ߏ߭TG}vԉ.(3t ܎Ne: ўRg??a;1.ozo|6W`#au߁ip?-#r^?q pp?)2v@'${Qw ȏP:W@TS났&/Nz[:(J$Aѷ/4_Wx[nX/%8o&_ \Fgu|>r}R =^|V8'a@ #^,~_v6qb 'fooOźt> v |T}:<}4u}_z+ߏ>v)μoIo~~g~w9\o<<7'A`=f|aje6q*񻨟y:V_?ӵ~|^|TǟOfzc=97>o\ŋdWRŸw&+역|;gLӰ_UԱRH|n+1Urԁ\ձe _5սzch=<wOCєqG|mr8~W_-x.m/so:t)T?6~_mg[ϥ:XtSkW[πZo8aHca?O&xO|1vo]H:i~Jʼn믴 U G}躰AEKN[^y_GMIDJ$}Vky0[ORs uַf?zh Uιf'W3MLD;J}IJW|Tw7&Sq %}zʺyUB֕DV-_| @RiMx߱waWO3YIJC~>@xy|ކBk6N$0Mü:򍬛<%}^T'4x[,J|e_t_ifWԱÿ? G`70H$kx*a$+7ؗu=κq1<ﻰN/h\;&{HJ@9s̋9'M;~o!ob]ͣZ^[~qEUu呌l5e~}0ԷG'?ng KI߬};7_ tUI:k%\'e|Z|a]Y?n}h1.Ӈ /G#oI=r%y{6YyKefz_~=]sͥ1O-ާ_x~0,g>۾-y份9?3?Dgɟ3W84NfHj 4ꮿ<Le~ UҷXXܟ#pQ;(﷭_&D ^|~q*+qy[P7oЍ/?}yc(w6b ^}wa{S 3I߂qP/{XƟHyIОgKdOSWO G^@|)0_gƾ_ sX}4nxqr~42?M"?_EƮ|1)ͻ.mz >'ٓSe!?~91~}RqΞ-?O^ހ'YR~=&uJ*o0?I\_~S?2yA7:dkܙqe?-Ȼɞ;VMR^gW?]+G9|_=鹈]_鷟?_iϝzQ¸\+ٳ{ޔB2?أ!x#{/_֝i\sUֽtg__>'Sj&oK|f-\ouݘ+i7=g_?D5!pw-Wº |_U7Ⱥ/-]l^OįQ9ڏ^P}pj`_Oꤋca*5^~>qFy}~X9T?o!_f89 >wkF]xS[㹬UB@UuOa'_SY_`_8ȓΞm1/ol\gŸ,3,KNpW|'}3↑__us쳤;0. '}v/xؗAe~A֟u=!dv<--R))! ,`/,cߢN+I}K5?O=vvc]Yu=Z"~kR(WTݸ:}?[e#:|VѦט~I3<\"_*_!J}E|D]#*3uUfإTװ^wm2F5:vקم*d oϧgױkĵM=h<>'܆{3cr1n* C U]86%.1+qk'l3;ά>J'bǦ9F_;ƁX>{yOi8~ISd\WgO{Mu G]ϕI?qnI>㗫gXGr?kTGoU?0{x:ue?gϩc\e_WXF<;!/_0:IT-[XS/899z ;寘2v-tnI:_+BGD%ݕ\0~}N7G=Y! WZOI^dup2QVބI֏*[8v1LS)~o1/⫙Oft߄|)yY[o|{#jouk4cyc`µ e~`Y˹jU_R>̏壬e}9P?&G}2}vyxB՝,p]됭k<%|eN߸(uü':ؗm$ެuQ8o'=S?ھ8Xv>oQ׶R^"YyudF]7{ӣǻOL~_IWmqLNȣ?|W᭿jcǞovݘy}kgUsxGؕϞtcԑS9N~y«o7&UVGGXUIC5Wx jPgSk X|?^eW#2}[Ǝ,s7G:u滇d"sn8mWugg3_ɇ qP¹Ko;f/޷KG<;s~vl߾7o73x?믺_/[t'+A:] B6~˚qd#8m>?zd~Wك|~ޘO~{IZva=o`_']~_]\쓡~}Ԉ\Jsk3~WI:({&.鳷Y__?Zy?f'?sraԥ8=@os2uxI*񈼇\|Eq⯢wy3y6ه\9 ^?Rݴe;xZ\ֻ͗/::թ-3nm0/L|}(_DgmC_Ǝk#,p\c=Τo`E`< BxP}}Zo8SEi}ע&8]믖O]fSP~|v4p\K5LqkwF䓾ˤξsW+S ?M-S $_Xdl ~SO[!~/oq|L?u&ܷ_+mUw\jKއsL=R]MƵzuN E|dch}uWVZ|5ϼXa*mC^`Gzdx;c p{ɸW>^+#uc?_)5ֈpgO`WZ&TP>O.9i{(|WTB;zy7Y[ /M\ֵW䯴Cuxa; W|1T߂:o19cސmbgr9}^6~"&~L誷R< E?~ʩ'eu?j7?`QVđM˾*0?pA~OK g;;M?WbnIqߦq_{Gҷ؃aϮpuz곇wuZO[?Bk:7&y*eu"䭩o _\W)&(š R+a[)-k?;~#=rH_KUγN˗ˏ3>U~2~_%*z->;__ĩq"V "׉;m68.x 5&ƱՇj[v_+Y'"Qu _5U+͞~@u6Z/|CKb|'ٳcy+񕼵Z~,eX8l󉿪3KS0xh G>fg?W߶jq^3nh˱'"zG-|_qW`-gӀ}+}{_m qդo~u|"5;y={"_<,D?{c!e v3ϕT_>}@z\ֹ ?و8~`v:q<+ѡx{=W>{k&ϗ+3,QwU]?~)+u(շ>.(ReKj6ÉY[PE5)+9w;Iy8h2_u&ݜv1o̞L}j^#^mFIER O} _w{?n?^yOQ 99?ǖ}OWG~:cxt.ցIϜ3m)88_BMI/ny_G8n쯋˝Lo o1o)qF/8Y=ԑ8It?Nq1$u+dS=g$qB_X?v_ mv2~6z3n.}߱}=?1Gy]ΧeYL#Ν6vx ٗѯ&y>\*W#< p'SØ)ڛXK8:TeNd9ؕr~ԝ;7>X|Ed?ɾS|>߇9w#N!UCϭuEV?(|yJ i?_o:~m(X|UGA?>9W P-?Jx?*g88]W#I]gCMN v# 8' >t%iC>s}>@7φxzpm~ƭU@* +/N$B}9@ٛ^]Vf}S|{zMpJ1e}54BH@J~~+|L3萦~2 _79犯]CGB?_E ND~$|kS~Ңv&x%ϧ=BI:TN*~VI8}%oTg@(q%u뜳qʃe_7W|~`[~|ue_c[Uxyyh}իbB/|78Obߌ_qzѷs=¹مnЯƏ5t/?n>s`r}b~Jqx:[m~k#~^Ru/-&." ?0.?{ܓ6b=ѵئAO5N1Ouy nǩz/b}a}GY+pI#\S毬߸9w#?^{).D pu~%nOiϙ/-kԫMX|<GIW}k o2/賛}ϙ}*#aF'wfwxO%|>;G;8wi_L;O)+CBW[~^!埮8?F՟ԇ}:>J⫔q"VgY_Cn/Rc|+s #wu 5:x_X}uz@uL+;n{_OŇSU>c| Ucڑ?_':?\1$^g{'={g9Jϫ+`~Ԁaߧ~uߊ9Olc;qmy9X_ݏZaI}͈S>U~-ne%ց_zoOWGpQW?+_=;ԇ%,Ya:kXG*iao{,[/B uMtVؗ9&&],_S!wc?>A>xC^9t Ư'~-ڿ~(5EOz7=sV3UeϰWX }`x`=} -o\<&vnJ~?6ox /Xw{_1S+V؏|b ]0'շ޳]|q/ޝoe8:,[ߕcR*^ _=8-{<^\c]#TYkg7y2zJQ}{/Wcç>M?$xvtB7짒~,Cӑ|NޗR~JGaG?u8;xJu<*ʹ~G|;~K#N?dj<+16p?O}=7믉8CNyu09鋛-e k6 ;|vn)!{{~)t'Ys`z/W~/?. u 17ǐ^6ܓc~ y~PyFh$<﵂߬n}MSy+F_zwygIwxO_}K_|>S_m\[k--ְOWG믟}!Z4K }(B\t%}Y`<]jOo~aK}^#/uI%f?^.80ttR|,qf,zC8| ^:4y; xɡGSM!y cWj>Y\ŞSE_cG'o1㐿"?0zaNGŸ"Q?n<ԋ:K:U}k>׵ys_r]_}$4L?Ux->=9__QgԷ.߮c)o}A\xFS>:18L;фv? SGsy{짣=Ǵ9?ͻOz(}#;Ϸ ;C8!/"?W&e&hv?Z̗Q|52nqYgyssMMǾߠOo=Wc8Wo;wu%߿iļf~<\Eֳh<|Q7N[w-f39ZҎdOorїzc;^~V(X rUh6/F?0AӪv?1K@V`A)O;xK{ ~G%}Tez5 C!_cj_gG7%__hU𻓟 Us78w<G_7ҺZԷxYB$I|Yy.kzm|uJhUyA~`a_xQuOF_9Ӊ{KΗ}s2R}؟7Y.]]p@2[ۈ{~"<朌y!T!%^POs^+n֙Oҷu/##q|5>MPGR|y;8qtۏGǰkǙ'G2 ToVĕ4bDq|$_`~Js(:~}$.[؇fv{>!c~`ُٗt,m}}[W_ܯ7xbēV:koC㽎]1We5պ@y)uAR8_*o-g>+*'Xeެur<u ! +e~:%t _^:s{NС?Hc)?z[f?zVߢk&y믌6wWB/8J&Ծ#WϦY=P_]NH/'}Xo;SՉ6~"g_IB{fQwi-uty~||fw=w~U_wqۏ$} $R =ėsl71du`~`s=N:#/M%|>yM (bO>2)!3ϫ̫W?>wdO=Q:n>//S/e} ̳UlkR?AMy=p<GZoEi~eV9Gѷ0oql68c!#+3;ucɞd'J<>茶wU7c\/JoY -Lj="^.mS.OG0oc8Q+S߀Ow>X'Sм]?`W~Q XSa_'Մo&W|eqX}E7`j_dNq&0 󣗞n{_C;v^q)Tg]]G]?W/l}6ou[%̺M}܉: yUug;M }%~WNSj/cBz] _<]Gسk?x碟SҷP75|/\ɋv/}\w'I4T88\w[~Ck)j]&~'"&x&q~WRmv){"~㉔mWpsvq;?;V̢ϡwWhOF|~^O8u]pAI={?j.zn&Il{K~`fݦ3Oì; vY^=_ԛqsI|j)m?s`H+d]:BIxbt3Wʸ_eO'W5 Og_>B/~;{u Y/اuRp'}.%G$o4?P@[[:Vūo"e~OS|]سe!vY=u S|%_X7O_~N>_?$pqۀG3>(e*_ox_#<<ـx?nz7+6Gu[+nSY/*:%8gq-(%}{+׉w^ad[+'0 '߀&X< ~n`Ǘ_M׊?ߒQ OJ>hYR=5zFt̺m'RS2?{SbxqXW։Y:'uv_]Y-iS$7Kj>QJxjFS3eo6^O}gƮk?mǹ=`ww#I$:q*}uf><_GkuCy9u/篰Cx*TWuo#^[圖p=91J*W'eOc¤d5+yG@ ;,m~0j wxKܿ=_-\#q'\ l}%[zW-31{d~[/UlOpqKnE]ꯒ'I~ծGj]-֋:/9{k.oLywVٷׯ$=&kS<95o|^Hqs6qi}݁e|dmTgƓW_j]2R OBᮔ_|+;Wi묿j}X Qy|NqQl}67汥~<'p*y/.{"Kշ(&e`g_QP)_tE~"~^{U滁fzďǏ=VߢW<e]pQ}υxyo ֕})?P!7e # ię_ɣX!TWAu "i⏶)q.y孳\<6W_؟~ao?Ahqg=O}u8?mXfūkIM}&)??۾|e؇|Oܬ]!!=_Yb#λzb̃!HuշHߏu4X'4Ϻ$c&ѥup4d?>WƵg2Zc;x_h*GZ!>}͋ZKzry{Q]?A|I=RS6k`/o>7C֥z@W˳=6gݰW5^W;$ksy_z38 IWo!|D}؇R=Q1e,oL|ꕘ?&Se߫_Ӟx>믈*n2o.b)WԻLwWWW[tw+g){=&{8?<[:k/{\.Mu{#T?kF-=7S|9e[c} oG9[/9pY~`g}՛P4ouZQ+++ #s~𡈫j:p^v|Km@۴ qUWOx ~Nߐ鿋??nUq_w|\?|{>dt֣}tW'uºycheia^?~]F̳u68B{q+U&7a\L[e弦yI7x}rjsYb__<1֝ܟۯq_Et6O_hGȳJ~#B&}1ywj> ֱJ*_Bs'_hG/zSuE/}:{ȯz3T_X.Ĺ~}`g_sk6<||~!:mQyS} ߏ>+={8]7o?5~ED|NU4T~ToӎoY¸|VaO}gfiv^V} x =;+g_%gK֩qН&5+0.8"eiYo=Ʊ_W[_xGg]eU)tu OxyvξTDM寬S]~ҾۑG{~)?P} 'e$vsVd=_8u =ǯ2psqvG}+8G.vb:k g/}:7acWCf>q;IBumL94^x.$YUK|cҷ(oCzYW]}Rc;h'Yo]~8^4~猺_opY[#%%i3uo!? ߭o^Q>tjPO6ϧqPĥi?}U8tW-oK *c_>u}ט߯_ |aq'q8@딆7Um\,ˏLg>{1/l;&eWy&h~-vF\ZW_ЃtH}a/篳?ǀN~.!O:vWqnR;יc_ky(%\b_W.`~__%W] vEu)WxCLTgS|Uc?CqLc^Gwy;31S đEqͳrR\;&o@qu}]Jvyc;Y_ 57}G_EGߟ,pjg}@M^wF?}f>zQXgZַXaF1I)+bR_8N/Z'Bov&K7E @ZO_GJH'dsV)WS_X7>mֽzYᏊWj*úT6?8{{?dl3]>_G%sc-t/;_Gj)Av/~+>qz/M(qU{?~k9䡻'᪓QW=+uӴyND^׍_K~y[|9xOp/I꽁󳌯yP?<ԍbR>~פ$kWWiY_3Omؿlh9ÿշ'r,=X_௲xk坉/--ܐuxmjIX|%gS]Ѫ|"t~q*dg6gS#]U䙿%!yuʳ_8'̃V]#`7`y 5o q8(-q~7Ƴz1>棩h~aWWG牯̃70nc~`£x?و˦?.};E2.x3 _y>qׯSՈ;~[qn_u_aG #3k\w~L1m~`{cu[_g?;3L1F_C>`ߵUE꯰n+-+ :{b_'}8vu®7"[ ~"w؟WF'P2xtKS~zkMds,볗|ñƾU~ys̮57o//w:g65U_QJR寢>pŕT~5x -ơ3wb'U}o%Y }Z8@Vx?T9@E|=`@y:uWóߑW௲s1ΓuӼoحT}C'k)L=-Qy[!:ƘʗWW3_ {!u>tNԷ0^'*݇ǜb.~FUgWcg/{ey#C:_[lxJ)-@볨mpn<}ԗYW ]؟;ė7׬Zf߮cCk/?-=+.qp;C.6tt߮G eJE-uKC¿9~4:};S쓣&4LLQۧ6mPÏ%Jk٭+:^-'O-^ ~#B~`3,W}%WGS;gfM=;_/My ='^E}iWbV?&}vx@Z/o__Ոmˣ.p>ondIzĕWU>5/IB_R@!?w6SeMca-mO7Yf®?寈O)qd⯌ۖe]i~_p^T>}d<6+̯Z!&^.W{善3tԗl9_O3'`툯ۘEY?)y-W+%j3~)1NzK*M`Y^wCi&!~`12}C7T8n[?~0qe<xb;)(xM(Nޅ=vr R^&au$'>8Q8zw;8[-x(>D\]<3U :r>}m)?P|93OzANǃ?,8o1נ`>{zvu>vWa׎_(Q%{ %ԭ:(m^`oǿv 9N,L|n^X^U*U'ݧ[_=wx8䯴+>ǩ⿺ovxy1>ٿO%+U>}o>}أK}iC|\W͹Vַԏ#Z7;N՝|GuMAp:ko_8oTGQr}KgcߣNQ)>9Я ?:Iԉ&+^/goDb B|{/\g6[os|>/r9[ crΫ`|x8aY?P|e~yYA3_/X;1_݌ XS |ݴ_We|5 /.|QoNlbd>7|+yw]BJu<_uԗ0/ sZ_z/^{*R5'~=y5믺kP9?P|<x :_Ȟ/ D!ߑu^sA~_;''9ג>;0_ W":VW{NP^i/ƾ[O\ZƯ^K3wMe@t?'ֽڿUwy ~H}LW]S5-UGT '0Zw_2\߬Βa ?/Wvis*nsrROZ:א߇+#7} y|N#ߴ+/yBD qU<ß1?Ks؃en- )^#89?e|%>]'>]Py_, (MiIvi;@Ss?W=믬3|M815΋~/B*ɻ^WoDv \9XfkԷA=[gy=VU@L#q Kh~_Y?0:xŸN4{~S78GRS}IU=c_ż4&s9'/%Ug?n\?_eW\Q?x`sl+Oc<_s5ear?!_ } OR/w.5xy1F;=oysҿߊ8dﳎR?y+a1 Ku./oU?d}|~`0zVUxRLuzao7t2Y?{K8_r].IM|:+h=}SOa'ݟ28Sh\ϖ_? TcC2Eܖ%xA>G$>2TgY?+y+܄ݹz ybJ=y/߉-Rg>JK-௲G}W諑Ý߈{qN|=orNSD_;jdު%]| eΑb>ܯ_/_2^K#Ϋ~mq ӳ~ubLnJv<߄3ğ?s-3-ItTgY,!$scC4?~|_Yes.e~~+Jn~`?La%ΗޗQ| >I~MsKW3\}>/eԧQ|qK u|_+Gk _oaݕ*'xu=]hğ+-?ǹxKk.cyxUjU_3=ۤ Wjf%?گ%\_-2aC'{zUXe|5"^_uW-k #}{K>]? YmS R}cu3)?Pc,P]gNljie4?ޑS1gT#At gUjGj/I*OYl~`ͺq>_eOe_meد;W-˶8?C IGʸ%} iԷ"h2agY*:<φS} j h=_?ڭ>?~ez&y '{q,"?07[{>Ɲ'&|ey$-#G߄_~#g>U3hu`_pGw[&%?-h {W-滬oQ¾`]wp=ߟo},'z*]ìMן?n<+[XGts>>mvN} Ÿ<W6_/g_Y-e^xk$R]S}{M곫o^q7uW}6oĺA_Aj\x@-DI}7O-+ 6B%{xJu?LqI3_eggYdރx(ߔ>pqYJ1N9yMq,]9Y"Gu\1WY|ۜc{yKdߊO5v:ϒ~}C{K%wo~`Qkoʫ䯆'~DZu_c{%j3?TԎ1KP?xIH^eJ{#d6v>Ph|+=7z*U_zs.G9vz|_ſ(+6}d<ϊu~6{uq?̷9_.yqN]4 ڇruW-#gþ4j _*^ּA1z+W;{wFՏ_S}tүf땈[W~1mpZ&!~:᫕[y}W&khU ƼY?[Y5-&o:M=u:/~4oɥ>_e} !8CoNWp{#^Rt5<8_ca/x] n'jn$teލtSN^`.+tcܲ ;; ~ :.m'.1p[I?0{瑿*H}\d'+$~ϳW:J<|>a3IN8實ƕ]_/W?p ;]9:S(2~X/,oO_ϺfQNqC̿u~} U|199ktO*Q{Ǡ9:Y KqǸm<̼XU3)>9Ĺ.swtb?m?p&ɀ}:c<ߍK{n?3ꮦ~yFjDG/{Sޖ3ޑzWaO/1?P}q렧x%/}I[.o>M]u_x;gZ0!S+v_w_pO=:tS'.!cFu@WU&鳗 q^?>|/ ._ D^'O7} x|]k Y >f\<؅.am Ow{$/+ܫoWwr22?j|O?Ա_+XCh~D|e:3?x/y%f_aga<{#~g'rZ_v2ށ?IIlWÜOW7Ч ݫ;Gq>z ᧏ͷ:Uc}ħG2`g ~Wb=;;]|7ϐvY|elycM@`-%3퓩Z2m~frqXϵpY?9*e*׍3䟯p^}>4I罤w;V-c^JUҫU?U9VwA'8k.M~Oҷ>ؓ_1?pܕhqR㹆CW2?>v>'c=Dҧ탑U288̼~yqo{-֯9gW_F|%} ;} ԗi=_b筓+0O@j񗿲*tFWvѼJ~!~~=1eW3;Oz)NロƏ3~}zɎY=};9i?;yk d>QG7cg_4+_}21?3Eȇx;<& T_xF$~B]W:xeޭ/'-[yO\V%6q0}v剙o#W=>/-]qUΡ5!qz _gZ<3q&꯲NJ,2s5O*;>qQ"||טg_8GǕ++:1HU5qv>ye87s)`'TW-g+߈xy2K1?W-II6F%Q//aw寶eJi |eo?fCyINJٷY} y'K+H3}>Ԙ`b#kPW%͘x}bX_s2UC ;$_9敫n}|)?n48WWUCj˹Nԭ _ak.7 Aƿ|q:3?xk3 _8<Ɣy(ƁS%vL|2Nf°W'HYgݩSy?w>{d u"Н]?+}WWpVüw9?P^ j|.񣌷?!T^Z:ϞnN|K9KmA]6}Ginꇂ{XuywR~:޿yd޻T>ɹٹGôY9'^4+s_o!S]= a_m$97 oFg[r&7Eo:iYJ'Hqk G:{ /o(W%.5&1/_Qwy3-Jj qIyT3~u pj_9Yg)bG;v8i9%>q~ _YU/l6j@\˾p~oQ~4ְC9cSoq=yf#k8VbK%-5d[7/XSoyCWgxϣw-߫>W[gϛ<2d? u}곂p<,R'8A @S૤϶4{-+5~PO{mcGScs]se_lWĻӵ;8/?UyvũM~9Mݤoa~ Us/:n׹+'  S\\>xb^6_nG }~2Fqd_%~"8{4qͰ8*zg݈fM7yR~`~8B=st2?pqY~['y"ֱuE8eI13{2΋JW n_oAѼE7إ>c}{ _Ye̲_ʸ~4շN&v_Y&?dޡW˙J7dīOx{v8SxW[}1M2z=~Euyg+G{_9}6*|͏ӷjs|==o~y|ʾ{sQ]@yg_$ 9?{G[_wwy9v|7_9n'a'NcJ8j$_xN'{~Xߔ*&F= [؁3_#׵zQ>MW5{>8wx8ՈR?pԷ<|_N,c,_џ(W -+7oh_EL~&6Ք|LjuvC_YzۇהRTCUJ|5¯mTҷPͺ/+7UkK֍}uٟ?Nb߮n]8>{շcf2 egS/wpm|_`N|e_:3ѷHucKk$g' 4?UE#^Ee/_^TBhԯ6k<~+W_E߇2}v"_ԏ@Sg`'f eI?>SpcԷP?T'oĸvg27Q?*?"ꏂ40W}?=BmUb_nU}v瀷 eO:9?VCOIy%Sm _mK 뭬XNeV}srUs<W r]`ȹ}3FĹtWNN?nSJi=_ا}>>◴ᣒ:5?WQG| }gz-ΥX7IU@~,o_Ͼ:.[tK~w>I}kp/~>g^e>_apWC}%\:5{'i6_هM|֊xZWÿ㾻WsWRg="%?Wؼ\,j+WSa&~|_þ AW֥UOl8++ΥE[?DSjƸ*~*r5xDY׉/B)88\%?8 Ry,'[+ߛ'.7Ǵ/U 3{+9?=}Ͼ?lr_7['8f8؇M\+u4m?c7.ӷ}.ETmj?g?Q믚UH|~,*;(1ʺdbc]R;]%|eޚHiq*+'(a̻}(ޯx*:)?P GR_AFVOCl^s2{:pOGn/[gCr~-Kկss.^2|ψ|!;+<~yzl'ɻYE:1:w_ ͚}:>=~sg_&Ny2׷C͇~*i"5os $iKۼ:W\Oɾ][IWW/WqG|~;U:iD,{ӹι:3IF=ƛcKj0_X}(֡:Aإ:i=^T?\c]Wg8:/2C_U<1|Gn: _/Q9>XULJ Y&Nz{ _XM}:QGܧ_ʸb^gO\/WQ|u͗++"OJ>Bʼ߁aW3ςҞn?*^]!X#^ջ ynHE4w/+4z_}~jDe/YˇR~.m<@uॲ/3+NVطWg_i_[aW7d}[g|f t#>r~u>W->? ?_'sՋ_^'^"{_?"}oW8Wg^}zWf_NKi:$zeK CU2E!B`>^lYVؽ=03+M9 09m2&XC]xN9ڝT^\'o{;s~szfcbcR}hs2&-g[ڑ6l[͍Fƻr|N٭e'N/9v{g[.}Xqr dمIcFӹ#Krfmn]I2'=1iwA*SW^b8l?6d0YkIIiY6mԵQFH4 i-iHӐ!MC4 m4ihЦMC6 m4iXӰaMÚ5 k4iX(M44J(M44J(M44jӨM64jӨM64jF4ѵ6sf]k3mܷ}47iMoӦ1mӦ1mӦ1mӦ1mӦ1]jq8P8TajM6ڄjM6ڄjM&T ՄjB5PM&T)ՔjJ5RMTS)ՔjF5QͨfT3ՌjF5ZZZZZZZZZZZZZZZZZZZZZGj:uTQZGj=zTSZOj=zM6ڔjSM6ڔjSMF/zK^"D%B/zK^"D%B/zK^"D%B/zK^"D%B/zK^"D%B/zK^"D%B/zK^"D%B/zK^"D%B/zK"4k]CB5V!h^N ?AB ?AB?(AJP?(D1AJP?(AJP?(AJP?(AJP?(AJP?(AJP?(AJPYCiJP>k(]CJP5|P@|PzK^(D%J/QzK^(D%J/QzK^b%F/1zK^b%F/1zK^b%F/1zK^b%F/1zK^b%F/1zK^b$<>6oyh}lp 7|'ssN\y&:+8ǟgg{spc< ޟ <{wva~l|vn98n>(t|}7ew%ˏ{&>8r|sM[/h|;T?"Mgu0hl/^]C?Sπ?Kீ[O=?">,ು>͋|vԡTOh bC[ɛ~20|Urhgx#`hZ2_o ?~;U7xK`VO#xGwxW A Pxp,wx.pLN!`H |>6| >x) '|2)|$QG|,q r.!r.!r.!ңr'!wr'!wr'!w1!1!1!1!1!r1!r1} |LCM"? ?L˄L/ y y y 9A'~瀟~%_^5ׁ~ mw^4GfjFfhFfhrU? F_?w:x}'>2#>2#62j#2*2*>ʨ|+ȨȨȨȨʷϨɨɨɨʨʨʨk#~2'~2'~2'?}P4 _ _ՌȨ:ɨʨʨʨ>>>>_ 3|>2*232j+N34N3j2&3j2&3j2&3j23j83j8&3j.2j.2j363j363j363/2j2&3j2Kkŋ&w?w>Y]>Zеq \KˋyZ< SuNT%,[²%,[²%,[²%,[/[/[VTnꗭaaae/S< VO;O{O2/2-,2-,2-] w//VTn/ee/.T=5Oe+Th,6Ѹh܏mZkmtxR^xwL1u+ϬXu:wszwwǦؔ7XrO-Z[%xxԇ%>bXii碑K6JF (a%lmuyZ< Sue3T%s \>%s \>e5KWBW?]izy]}U_FՇQ}ՇQ}ՇQ}nu;yv^nu{{ݾ4mƯFLuw3՝̱]g:sw]qw]qUw]uUw(S x<.kx >y JW!\ JWB•pp5!\ׇp5!\ jWCaz ZBµ8_Bm?d]WJHҮ+!JHn|OSx<=uˮʫ0IaTFaTF緻 ݅vwa;nbzT= 'Oa<ٻ=ws`f7Y"aXX?bSNO:=uz3gNϜ9S(N8S(AaӫN:ӫNo(+Oܘo?F~lᵈSO z#c~Fv>mtY/7v޸t> yxO.7~6~5^L^{U:Z/ݫ޽qOݲnKot^:>+]CwnZaykonكwW~Cwzfozow=zQ׫qtt{fiم3^[͋_3x#|!_3ؘ/Ο_RD}iuGoTjG.?";-:ǿE']ߢ77/}7#y`e9.v;ۛǞ8=U:~wuwWo]=uf1Gvv{ÃǙJfdestiny/demo/0000755000175200017520000000000014516010071014172 5ustar00biocbuildbiocbuilddestiny/demo/00Index0000644000175200017520000000003014516010071015315 0ustar00biocbuildbiocbuilddestiny General usage destiny/demo/destiny.r0000644000175200017520000000140714516010071016036 0ustar00biocbuildbiocbuildlibrary(destiny) data(guo) Dark2 <- scales::brewer_pal(palette = 'Dark2') palette(Dark2(8L)) dm_guo <- DiffusionMap(guo, verbose = FALSE, censor_val = 10, censor_range = c(10, 40)) plot(dm_guo, col = guo$num_cells, pch = 20) sigmas <- find_sigmas(guo, verbose = FALSE, censor_val = 10, censor_range = c(10, 40)) par(lwd = 3) plot(sigmas, col = palette()[[1]], col_highlight = palette()[[4]], col_line = palette()[[6]]) dm_guo_global <- DiffusionMap(guo, sigmas, verbose = FALSE, censor_val = 10, censor_range = c(10, 40)) plot(dm_guo_global, col = guo$num_cells, pch = 20) #library(rgl) #plot3d(eigenvectors(dm_guo)[, 1:3], col = guo$num_cells) destiny/docs/0000755000175200017520000000000014516030526014205 5ustar00biocbuildbiocbuilddestiny/inst/0000755000175200017520000000000014516030526014232 5ustar00biocbuildbiocbuilddestiny/inst/CITATION0000644000175200017520000000161314516010071015361 0ustar00biocbuildbiocbuildauthors <- ( if ('Authors' %in% names(meta)) meta$Authors else eval(parse(text = meta$`Authors@R`)) ) year <- 2015L title <- 'destiny: diffusion maps for large-scale single-cell data in R' organization <- 'Helmholtz-Zentrum München' url <- 'http://bioinformatics.oxfordjournals.org/content/32/8/1241' bibentry('Article', sprintf( '%s %s et al. (%s): %s. %s. URL: <%s>.', authors[[1]]$given, authors[[1]]$family, year, title, organization, url), title = title, volume = 32L, number = 8L, url = url, doi = '10.1093/bioinformatics/btv715', journal = 'Bioinformatics', author = authors, pages = 1241:1243, organization = organization, address = 'Ingolstädter Landstraße 1, Neuherberg, Germany', year = year, note = 'More information at ') destiny/inst/doc/0000755000175200017520000000000014516030526014777 5ustar00biocbuildbiocbuilddestiny/inst/doc/DPT.R0000644000175200017520000000311014516030051015535 0ustar00biocbuildbiocbuild## ----------------------------------------------------------------------------- set.seed(1) ## ----------------------------------------------------------------------------- library(destiny) # load destiny… data(guo) # …and sample data library(gridExtra) # Also we need grid.arrange ## ----------------------------------------------------------------------------- par(mar = rep(0, 4)) graph <- igraph::graph_from_literal( data -+ 'transition probabilities' -+ DiffusionMap, 'transition probabilities' -+ DPT) plot( graph, layout = igraph::layout_as_tree, vertex.size = 50, vertex.color = 'transparent', vertex.frame.color = 'transparent', vertex.label.color = 'black') ## ----------------------------------------------------------------------------- dm <- DiffusionMap(guo) dpt <- DPT(dm) ## ----------------------------------------------------------------------------- set.seed(4) dpt_random <- DPT(dm, tips = sample(ncol(guo), 3L)) ## ----------------------------------------------------------------------------- grid.arrange(plot(dpt), plot(dpt_random), ncol = 2) ## ----------------------------------------------------------------------------- grid.arrange( plot(dpt, col_by = 'DPT3'), plot(dpt, col_by = 'Gata4', pal = viridis::magma), ncol = 2 ) ## ----------------------------------------------------------------------------- plot(dpt, root = 2, paths_to = c(1,3), col_by = 'branch') ## ----------------------------------------------------------------------------- plot(dpt, col_by = 'branch', divide = 3, dcs = c(-1,-3,2), pch = 20) destiny/inst/doc/DPT.Rmd0000644000175200017520000000510114516010071016060 0ustar00biocbuildbiocbuild--- title: destiny 2.0 brought the Diffusion Pseudo Time (DPT) class output: rmarkdown::html_vignette bibliography: bibliography.bib vignette: > %\VignetteIndexEntry{destiny 2.0 brought the Diffusion Pseudo Time (DPT) class} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} --- ```{r} set.seed(1) ``` Diffusion Pseudo Time (DPT) is a pseudo time metric based on the transition probability of a diffusion process [@haghverdi_diffusion_2016]. *destiny* supports `DPT` in addition to its primary function of creating `DiffusionMap`s from data. ```{r} library(destiny) # load destiny… data(guo) # …and sample data library(gridExtra) # Also we need grid.arrange ``` `DPT` is in practice independent of Diffusion Maps: ```{r} par(mar = rep(0, 4)) graph <- igraph::graph_from_literal( data -+ 'transition probabilities' -+ DiffusionMap, 'transition probabilities' -+ DPT) plot( graph, layout = igraph::layout_as_tree, vertex.size = 50, vertex.color = 'transparent', vertex.frame.color = 'transparent', vertex.label.color = 'black') ``` However in order not to overcomplicate things, in *destiny*, you have to create `DPT` objects from `DiffusionMap` objects. (If you really only need the DPT, skip Diffusion Component creation by specifying `n_eigs = 0`) ```{r} dm <- DiffusionMap(guo) dpt <- DPT(dm) ``` The resulting object of a call like this will have three automatically chosen tip cells. You can also specify tip cells: ```{r} set.seed(4) dpt_random <- DPT(dm, tips = sample(ncol(guo), 3L)) ``` Plotting without parameters results in the DPT of the first root cell: TODO: wide plot ```{r} grid.arrange(plot(dpt), plot(dpt_random), ncol = 2) ``` Other possibilities include the DPT from the other tips or everything supported by `plot.DiffusionMap`: TODO: wide plot ```{r} grid.arrange( plot(dpt, col_by = 'DPT3'), plot(dpt, col_by = 'Gata4', pal = viridis::magma), ncol = 2 ) ``` The `DPT` object also contains a clustering based on the tip cells and DPT, and you can specify where to draw paths from and to: ```{r} plot(dpt, root = 2, paths_to = c(1,3), col_by = 'branch') ``` You can further divide branches. First simply plot branch colors like we did above, then identify the number of the branch you intend to plot, and then specify it in a subsequent `plot` call. In order to see the new branches best, we specify a `dcs` argument that visually spreads out out all four branches. ```{r} plot(dpt, col_by = 'branch', divide = 3, dcs = c(-1,-3,2), pch = 20) ``` References ==========
destiny/inst/doc/DPT.html0000644000175200017520000022340014516030051016306 0ustar00biocbuildbiocbuild destiny 2.0 brought the Diffusion Pseudo Time (DPT) class

destiny 2.0 brought the Diffusion Pseudo Time (DPT) class

set.seed(1)

Diffusion Pseudo Time (DPT) is a pseudo time metric based on the transition probability of a diffusion process (Haghverdi et al. 2016).

destiny supports DPT in addition to its primary function of creating DiffusionMaps from data.

library(destiny)    # load destiny…
data(guo)           # …and sample data
library(gridExtra)  # Also we need grid.arrange

DPT is in practice independent of Diffusion Maps:

par(mar = rep(0, 4))
graph <- igraph::graph_from_literal(
    data -+ 'transition probabilities' -+ DiffusionMap,
    'transition probabilities' -+ DPT)
plot(
    graph, layout = igraph::layout_as_tree,
    vertex.size = 50,
    vertex.color = 'transparent',
    vertex.frame.color = 'transparent',
    vertex.label.color = 'black')

However in order not to overcomplicate things, in destiny, you have to create DPT objects from DiffusionMap objects.
(If you really only need the DPT, skip Diffusion Component creation by specifying n_eigs = 0)

dm <- DiffusionMap(guo)
## Warning: 'as(<dsCMatrix>, "dsTMatrix")' is deprecated.
## Use 'as(., "TsparseMatrix")' instead.
## See help("Deprecated") and help("Matrix-deprecated").
dpt <- DPT(dm)

The resulting object of a call like this will have three automatically chosen tip cells. You can also specify tip cells:

set.seed(4)
dpt_random <- DPT(dm, tips = sample(ncol(guo), 3L))

Plotting without parameters results in the DPT of the first root cell:

TODO: wide plot

grid.arrange(plot(dpt), plot(dpt_random), ncol = 2)

Other possibilities include the DPT from the other tips or everything supported by plot.DiffusionMap:

TODO: wide plot

grid.arrange(
    plot(dpt, col_by = 'DPT3'),
    plot(dpt, col_by = 'Gata4', pal = viridis::magma),
    ncol = 2
)

The DPT object also contains a clustering based on the tip cells and DPT, and you can specify where to draw paths from and to:

plot(dpt, root = 2, paths_to = c(1,3), col_by = 'branch')

You can further divide branches. First simply plot branch colors like we did above, then identify the number of the branch you intend to plot, and then specify it in a subsequent plot call. In order to see the new branches best, we specify a dcs argument that visually spreads out out all four branches.

plot(dpt, col_by = 'branch', divide = 3, dcs = c(-1,-3,2), pch = 20)

References

Haghverdi, Laleh, Maren Büttner, F Alexander Wolf, Florian Buettner, and Fabian J Theis. 2016. “Diffusion Pseudotime Robustly Reconstructs Lineage Branching.” Nature Methods, August. https://doi.org/10.1038/nmeth.3971.

destiny/inst/doc/Diffusion-Map-recap.R0000644000175200017520000000110114516030052020636 0ustar00biocbuildbiocbuild## ----------------------------------------------------------------------------- library(destiny) data(guo) ## ----------------------------------------------------------------------------- dm_guo <- DiffusionMap(guo, verbose = FALSE, censor_val = 15, censor_range = c(15, 40)) dm_guo ## ----------------------------------------------------------------------------- plot(dm_guo) ## ----------------------------------------------------------------------------- palette(cube_helix(6)) plot(dm_guo, col_by = 'num_cells', legend_main = 'Cell stage') destiny/inst/doc/Diffusion-Map-recap.Rmd0000644000175200017520000000214514516010071021167 0ustar00biocbuildbiocbuild--- title: Reproduce the Diffusion Map vignette with the supplied data() output: rmarkdown::html_vignette vignette: > %\VignetteIndexEntry{Reproduce the Diffusion Map vignette with the supplied data()} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} --- Quickstart ========== A short version to achive the above is by using the preprocessed version of the dataset provided with this package. `data(guo)` is already preprocessed (using the method first mentioned), has its threshold set to a constant 15 and is ready to use. Since the platform’s maximum amplification cycles are 40, that number can be used as upper border of the uncertainty range. ```{r} library(destiny) data(guo) ``` It can be used directly for diffusion map creation: ```{r} dm_guo <- DiffusionMap(guo, verbose = FALSE, censor_val = 15, censor_range = c(15, 40)) dm_guo ``` ```{r} plot(dm_guo) ``` using the annotation shows that the approximation worked ```{r} palette(cube_helix(6)) plot(dm_guo, col_by = 'num_cells', legend_main = 'Cell stage') ``` References ==========
destiny/inst/doc/Diffusion-Map-recap.html0000644000175200017520000011357314516030052021422 0ustar00biocbuildbiocbuild Reproduce the Diffusion Map vignette with the supplied data()

Reproduce the Diffusion Map vignette with the supplied data()

Quickstart

A short version to achive the above is by using the preprocessed version of the dataset provided with this package. data(guo) is already preprocessed (using the method first mentioned), has its threshold set to a constant 15 and is ready to use. Since the platform’s maximum amplification cycles are 40, that number can be used as upper border of the uncertainty range.

library(destiny)
data(guo)

It can be used directly for diffusion map creation:

dm_guo <- DiffusionMap(guo, verbose = FALSE,
                       censor_val = 15, censor_range = c(15, 40))
dm_guo
## DiffusionMap (20 Diffusion components and 428 observations)
## eigenvalues:    Named num [1:20] 0.954 0.846 0.798 0.776 0.703 ...
##  - attr(*, "names")= chr [1:20] "DC1" "DC2" "DC3" "DC4" ...
## eigenvectors:   num [1:428, 1:20] -0.0576 -0.0574 -0.0495 -0.0495 -0.0511 ...
##   ..colnames:   chr [1:20] "DC1" "DC2" "DC3" "DC4" ...
## optimal_sigma:  Named num [1:428] 7.69 7.63 9.19 6.76 6.35 ...
##  - attr(*, "names")= chr [1:428] "10" "11" "12" "13" ...
## distance:       chr "euclidean"
plot(dm_guo)

using the annotation shows that the approximation worked

palette(cube_helix(6))
plot(dm_guo, col_by = 'num_cells',
     legend_main = 'Cell stage')

References

destiny/inst/doc/Diffusion-Maps.R0000644000175200017520000001407314516030061017745 0ustar00biocbuildbiocbuild## ----------------------------------------------------------------------------- library(base64enc) library(ggplot2) # would shadow Biobase::exprs suppressPackageStartupMessages({ library(readxl) library(destiny) library(Biobase) }) #setHook('on.rgl.close', function(...) { # name <- tempfile() # par3d(windowRect = c(0, 0, 1200, 1200)) # Sys.sleep(1) # # rgl.snapshot( filename = paste0(name, '.png')) # #rgl.postscript(filename = paste0(name, '.pdf'), fmt='pdf') # doesn’t work with spheres # # publish_mimebundle(list( # 'image/png' = base64encode(paste0(name, '.png')) # #, 'application/pdf' = base64encode(paste0(name, '.pdf')) # )) #}, 'replace') ## ----------------------------------------------------------------------------- library(readxl) raw_ct <- read_xls('mmc4.xls', 'Sheet1') raw_ct[1:9, 1:9] #preview of a few rows and columns ## ----------------------------------------------------------------------------- library(destiny) library(Biobase) # as.data.frame because ExpressionSets # do not support readxl’s “tibbles” ct <- as.ExpressionSet(as.data.frame(raw_ct)) ct ## ----------------------------------------------------------------------------- num_cells <- gsub('^(\\d+)C.*$', '\\1', ct$Cell) ct$num_cells <- as.integer(num_cells) ## ----------------------------------------------------------------------------- # cells from 2+ cell embryos have_duplications <- ct$num_cells > 1 # cells with values <= 28 normal_vals <- apply(exprs(ct), 2, function(smp) all(smp <= 28)) ## ----------------------------------------------------------------------------- cleaned_ct <- ct[, have_duplications & normal_vals] ## ----------------------------------------------------------------------------- housekeepers <- c('Actb', 'Gapdh') # houskeeper gene names normalizations <- colMeans(exprs(cleaned_ct)[housekeepers, ]) guo_norm <- cleaned_ct exprs(guo_norm) <- exprs(guo_norm) - normalizations ## ----------------------------------------------------------------------------- library(destiny) #data(guo_norm) dm <- DiffusionMap(guo_norm) ## ----------------------------------------------------------------------------- plot(dm) ## ----------------------------------------------------------------------------- palette(cube_helix(6)) # configure color palette plot(dm, pch = 20, # pch for prettier points col_by = 'num_cells', # or “col” with a vector or one color legend_main = 'Cell stage') ## ----------------------------------------------------------------------------- plot(dm, 1:2, col_by = 'num_cells', legend_main = 'Cell stage') ## ----------------------------------------------------------------------------- library(rgl) plot3d( eigenvectors(dm)[, 1:3], col = log2(guo_norm$num_cells), type = 's', radius = .01) view3d(theta = 10, phi = 30, zoom = .8) # now use your mouse to rotate the plot in the window rgl.close() ## ----------------------------------------------------------------------------- library(ggplot2) qplot(DC1, DC2, data = dm, colour = factor(num_cells)) + scale_color_cube_helix() # or alternatively: #ggplot(dif, aes(DC1, DC2, colour = factor(num.cells))) + ... ## ----------------------------------------------------------------------------- qplot(y = eigenvalues(dm)) + theme_minimal() + labs(x = 'Diffusion component (DC)', y = 'Eigenvalue') ## ----------------------------------------------------------------------------- plot(dm, 3:4, col_by = 'num_cells', draw_legend = FALSE) plot(dm, 19:20, col_by = 'num_cells', draw_legend = FALSE) ## ----------------------------------------------------------------------------- hist(exprs(cleaned_ct)['Aqp3', ], breaks = 20, xlab = 'Ct of Aqp3', main = 'Histogram of Aqp3 Ct', col = palette()[[4]], border = 'white') ## ----------------------------------------------------------------------------- dilutions <- read_xls('mmc6.xls', 1L) dilutions$Cell <- NULL # remove annotation column get_lod <- function(gene) gene[[max(which(gene != 28))]] lods <- apply(dilutions, 2, get_lod) lod <- ceiling(median(lods)) lod ## ----------------------------------------------------------------------------- lod_norm <- ceiling(median(lods) - mean(normalizations)) max_cycles_norm <- ceiling(40 - mean(normalizations)) list(lod_norm = lod_norm, max_cycles_norm = max_cycles_norm) ## ----------------------------------------------------------------------------- guo <- guo_norm exprs(guo)[exprs(cleaned_ct) >= 28] <- lod_norm ## ----------------------------------------------------------------------------- thresh_dm <- DiffusionMap(guo, censor_val = lod_norm, censor_range = c(lod_norm, max_cycles_norm), verbose = FALSE) plot(thresh_dm, 1:2, col_by = 'num_cells', legend_main = 'Cell stage') ## ----------------------------------------------------------------------------- # remove rows with divisionless cells ct_w_missing <- ct[, ct$num_cells > 1L] # and replace values larger than the baseline exprs(ct_w_missing)[exprs(ct_w_missing) > 28] <- NA ## ----------------------------------------------------------------------------- housekeep <- colMeans( exprs(ct_w_missing)[housekeepers, ], na.rm = TRUE) w_missing <- ct_w_missing exprs(w_missing) <- exprs(w_missing) - housekeep exprs(w_missing)[is.na(exprs(ct_w_missing))] <- lod_norm ## ----------------------------------------------------------------------------- dif_w_missing <- DiffusionMap(w_missing, censor_val = lod_norm, censor_range = c(lod_norm, max_cycles_norm), missing_range = c(1, 40), verbose = FALSE) plot(dif_w_missing, 1:2, col_by = 'num_cells', legend_main = 'Cell stage') ## ----------------------------------------------------------------------------- ct64 <- guo[, guo$num_cells == 64] dm64 <- DiffusionMap(ct64) ## ----------------------------------------------------------------------------- ct32 <- guo[, guo$num_cells == 32] pred32 <- dm_predict(dm64, ct32) ## ----------------------------------------------------------------------------- plot(dm64, 1:2, col = palette()[[6]], new_dcs = pred32, col_new = palette()[[4]]) destiny/inst/doc/Diffusion-Maps.Rmd0000644000175200017520000004660214516010071020270 0ustar00biocbuildbiocbuild--- title: 'destiny main vignette: Start here!' output: rmarkdown::html_vignette bibliography: bibliography.bib vignette: > %\VignetteIndexEntry{destiny main vignette: Start here!} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} --- ```{r} library(base64enc) library(ggplot2) # would shadow Biobase::exprs suppressPackageStartupMessages({ library(readxl) library(destiny) library(Biobase) }) #setHook('on.rgl.close', function(...) { # name <- tempfile() # par3d(windowRect = c(0, 0, 1200, 1200)) # Sys.sleep(1) # # rgl.snapshot( filename = paste0(name, '.png')) # #rgl.postscript(filename = paste0(name, '.pdf'), fmt='pdf') # doesn’t work with spheres # # publish_mimebundle(list( # 'image/png' = base64encode(paste0(name, '.png')) # #, 'application/pdf' = base64encode(paste0(name, '.pdf')) # )) #}, 'replace') ``` Diffusion maps are spectral method for non-linear dimension reduction introduced by @coifman_geometric_2005. Diffusion maps are based on a distance metric (diffusion distance) which is conceptually relevant to how differentiating cells follow noisy diffusion-like dynamics, moving from a pluripotent state towards more differentiated states. The R package **destiny** implements the formulation of diffusion maps presented in @haghverdi_diffusion_2015 which is especially suited for analyzing single-cell gene expression data from time-course experiments. It implicitly arranges cells along their developmental path, with bifurcations where differentiation events occur. In particular we follow @haghverdi_diffusion_2015 and present an implementation of diffusion maps in R that is less affected by sampling density heterogeneities and thus capable of identifying both abundant and rare cell populations. In addition, **destiny** implements complex noise models reflecting zero-inflation/censoring due to drop-out events in single-cell qPCR data and allows for missing values. Finally, we further improve on the implementation from @haghverdi_diffusion_2015, and implement a nearest neighbour approximation capable of handling very large data sets of up to 300.000 cells. For those familiar with R, and data preprocessing, we recommend the section [Plotting](#Plotting). All code in this vignette is accessible via `edit(vignette('destiny'))` Preprocessing of single qPCR data ================================= As an example, we present in the following the preprocessing of data from @guo_resolution_2010. This dataset was produced by the Biomark RT-qPCR system and contains Ct values for 48 genes of 442 mouse embryonic stem cells at 7 different developmental time points, from the zygote to blastocyst. Starting at the totipotent 1-cell stage, cells transition smoothly in the transcriptional landscape towards either the trophoectoderm lineage or the inner cell mass. Subsequently, cells transition from the inner cell mass either towards the endoderm or epiblast lineage. This smooth transition from one developmental state to another, including two bifurcation events, is reflected in the expression profiles of the cells and can be visualized using **destiny**. Import ------ Downloading the table S4 from the [publication website](http://www.sciencedirect.com/science/article/pii/S1534580710001103) will give you a spreadsheet “mmc4.xls”, from which the data can be loaded: ```{r} library(readxl) raw_ct <- read_xls('mmc4.xls', 'Sheet1') raw_ct[1:9, 1:9] #preview of a few rows and columns ``` The value 28 is the assumed background expression of 28 cycle times. In order to easily clean and normalize the data without mangling the annotations, we convert the `data.frame` into a Bioconductor `ExpressionSet` using the `as.ExpressionSet` function from the **destiny** package, and assign it to the name `ct`: ```{r} library(destiny) library(Biobase) # as.data.frame because ExpressionSets # do not support readxl’s “tibbles” ct <- as.ExpressionSet(as.data.frame(raw_ct)) ct ``` The advantage of `ExpressionSet` over `data.frame` is that tasks like normalizing the expressions are both faster and do not accidentally destroy annotations by applying “normalization” to columns that are not expressions. The approach of handling a separate expression `matrix` and annotation `data.frame` requires you to be careful when adding or removing samples on both variables, while `ExpressionSet` does it internally for you. The object internally stores an expression matrix of features × samples, retrievable using `exprs(ct)`, and an annotation `data.frame` of samples × annotations as `phenoData(ct)`. Annotations can be accessed directly via `ct$column` and `ct[['column']]`. Note that the expression matrix is transposed compared to the usual samples × features `data.frame`. Data cleaning ------------- We remove all cells that have a value bigger than the background expression, indicating data points not available (`NA`). Also we remove cells from the 1 cell stage embryos, since they were treated systematically different [@guo_resolution_2010]. For this, we add an annotation column containing the embryonic cell stage for each sample by extracting the number of cells from the “Cell” annotation column: ```{r} num_cells <- gsub('^(\\d+)C.*$', '\\1', ct$Cell) ct$num_cells <- as.integer(num_cells) ``` We then use the new annotation column to create two filters: ```{r} # cells from 2+ cell embryos have_duplications <- ct$num_cells > 1 # cells with values <= 28 normal_vals <- apply(exprs(ct), 2, function(smp) all(smp <= 28)) ``` We can use the combination of both filters to exclude both non-divided cells and such containing Ct values higher than the baseline, and store the result as `cleaned_ct`: ```{r} cleaned_ct <- ct[, have_duplications & normal_vals] ``` Normalization ------------- Finally we follow @guo_resolution_2010 and normalize each cell using the endogenous controls Actb and Gapdh by subtracting their average expression for each cell. Note that it is not clear how to normalise sc-qPCR data as the expression of housekeeping genes is also stochastic. Consequently, if such housekeeping normalisation is performed, it is crucial to take the mean of several genes. ```{r} housekeepers <- c('Actb', 'Gapdh') # houskeeper gene names normalizations <- colMeans(exprs(cleaned_ct)[housekeepers, ]) guo_norm <- cleaned_ct exprs(guo_norm) <- exprs(guo_norm) - normalizations ``` The resulting `ExpressionSet` contains the normalized Ct values of all cells retained after cleaning. Plotting ======== The data necessary to create a diffusion map with our package is a a cell×gene `matrix` or `data.frame`, or alternatively an `ExpressionSet` (which has a gene×cell `exprs` matrix). In order to create a `DiffusionMap` object, you just need to supply one of those formats as first parameter to the `DiffusionMap` function. In the case of a `data.frame`, each floating point column is interpreted as expression levels, and columns of different type (e.g. `factor`, `character` or `integer`) are assumed to be annotations and ignored. Note that single-cell RNA-seq count data should be transformed using a variance-stabilizing transformation (e.g. log or rlog); the Ct scale for qPCR data is logarithmic already (an increase in 1 Ct corresponds to a doubling of transcripts). In order to create a diffusion map to plot, you have to call `DiffusionMap`, optionally with parameters. If the number of cells is small enough (< ~1000), you do not need to specify approximations like `k` (for k nearest neighbors). If you started reading here, execute `data(guo.norm)` to load the dataset that was created in the previous section. ```{r} library(destiny) #data(guo_norm) dm <- DiffusionMap(guo_norm) ``` Simply calling `plot` on the resulting object `dif` will visualize the diffusion components: ```{r} plot(dm) ``` The diffusion map nicely illustrates a branching during the first days of embryonic development. The annotation column containing the cell stage can be used to annotate our diffusion map. Using the annotation as `col` parameter will automatically color the map using the current R color palette. Use `palette(colors)` to configure it globally or `plot(..., pal = colors)` for one plot. ```{r} palette(cube_helix(6)) # configure color palette plot(dm, pch = 20, # pch for prettier points col_by = 'num_cells', # or “col” with a vector or one color legend_main = 'Cell stage') ``` Three branches appear in the map, with a bifurcation occurring the 16 cell stage and the 32 cell stage. The diffusion map is able to arrange cells according to their expression profile: Cells that divided the most and the least appear at the tips of the different branches. In order to display a 2D plot we supply a vector containing two diffusion component numbers (here 1 & 2) as second argument. ```{r} plot(dm, 1:2, col_by = 'num_cells', legend_main = 'Cell stage') ``` Alternative visualizations -------------------------- Diffusion maps consist of eigenvectors called Diffusion Components (DCs) and corresponding eigenvalues. Per default, the first 20 are returned. You are also able to use packages for interative plots like `rgl` in a similar fashion, by directly subsetting the DCs using `eigenvectors(dif)`: ```{r} library(rgl) plot3d( eigenvectors(dm)[, 1:3], col = log2(guo_norm$num_cells), type = 's', radius = .01) view3d(theta = 10, phi = 30, zoom = .8) # now use your mouse to rotate the plot in the window rgl.close() ``` For the popular `ggplot2` package, there is built in support in the form of a `fortify.DiffusionMap` method, which allows to use DiffusionMap objects as `data` parameter in the `ggplot` and `qplot` functions. But the regular `plot` function already returns a `ggplot` object anyway. ```{r} library(ggplot2) qplot(DC1, DC2, data = dm, colour = factor(num_cells)) + scale_color_cube_helix() # or alternatively: #ggplot(dif, aes(DC1, DC2, colour = factor(num.cells))) + ... ``` As aesthetics, all diffusion components, gene expressions, and annotations are available. If you plan to make many plots, create a `data.frame` first by using `as.data.frame(dif)` or `fortify(dif)`, assign it to a variable name, and use it for plotting. Parameter selection =================== The most important parameter for the visualization, `dims`, is described in the following section. An important parameter in v1, $\sigma$, is explained in its own vignette “Global Sigma”. [Other parameters](#Other-parameters) are explained at the end of this section. Dimensions `dims` ----------------- Diffusion maps consist of the eigenvectors (which we refer to as diffusion components) and corresponding eigenvalues of the diffusion distance matrix. The latter indicate the diffusion components’ importance, i.e. how well the eigenvectors approximate the data. The eigenvectors are decreasingly meaningful. ```{r} qplot(y = eigenvalues(dm)) + theme_minimal() + labs(x = 'Diffusion component (DC)', y = 'Eigenvalue') ``` The later DCs often become noisy and less useful: TODO: wide plot ```{r} plot(dm, 3:4, col_by = 'num_cells', draw_legend = FALSE) plot(dm, 19:20, col_by = 'num_cells', draw_legend = FALSE) ``` Other parameters ---------------- If the automatic exclusion of categorical and integral features for data frames is not enough, you can also supply a vector of variable names or indices to use with the `vars` parameter. If you find that calculation time or used memory is too large, the parameter `k` allows you to decrease the quality/runtime+memory ratio by limiting the number of transitions calculated and stored. It is typically not needed if you have less than few thousand cells. The `n.eigs` parameter specifies the number of diffusion components returned. For more information, consult `help(DiffusionMap)`. Missing and uncertain values ============================ **destiny** is particularly well suited for gene expression data due to its ability to cope with missing and uncertain data. Censored values --------------- Platforms such as RT-qPCR cannot detect expression values below a certain threshold. To cope with this, **destiny** allows to censor specific values. In the case of @guo_resolution_2010, only up to 28 qPCR cycles were counted. All transcripts that would need more than 28 cycles are grouped together under this value. This is illustrated by gene Aqp3: ```{r} hist(exprs(cleaned_ct)['Aqp3', ], breaks = 20, xlab = 'Ct of Aqp3', main = 'Histogram of Aqp3 Ct', col = palette()[[4]], border = 'white') ``` For our censoring noise model we need to identify the limit of detection (LoD). While most researchers use a global LoD of 28, reflecting the overall sensitivity of the qPCR machine, different strategies to quantitatively establish this gene-dependent LoD exist. For example, dilution series of bulk data can be used to establish an LoD such that a qPCR reaction will be detected with a specified probability if the Ct value is below the LoD. Here, we use such dilution series provided by Guo et al. and first determine a gene-wise LoD as the largest Ct value smaller than 28. We then follow the manual [Application Guidance: Single-Cell Data Analysis](https://www.bioke.com/Product%20Support/Manuals%20%26%20Downloads/?webshop_supplier=15&webshop_downloadtype=10&webshop_application=199&q=) of the popular Biomarks system and determine a global LoD as the median over the gene-wise LoDs. We use the dilution series from table S7 (`mmc6.xls`). If you have problems with the speed of `read.xlsx`, consider storing your data in tab separated value format and using `read.delim` or `read.ExpressionSet`. ```{r} dilutions <- read_xls('mmc6.xls', 1L) dilutions$Cell <- NULL # remove annotation column get_lod <- function(gene) gene[[max(which(gene != 28))]] lods <- apply(dilutions, 2, get_lod) lod <- ceiling(median(lods)) lod ``` This LoD of 25 and the maximum number of cycles the platform can perform (40), defines the uncertainty range that denotes the possible range of censored values in the censoring model. Using the mean of the normalization vector, we can adjust the uncertainty range and censoring value to be more similar to the other values in order to improve distance measures between data points: ```{r} lod_norm <- ceiling(median(lods) - mean(normalizations)) max_cycles_norm <- ceiling(40 - mean(normalizations)) list(lod_norm = lod_norm, max_cycles_norm = max_cycles_norm) ``` We then also need to set the normalized values that should be censored – namely all data points were no expression was detected after the LoD – to this special value, because the values at the cycle threshold were changed due to normalization. ```{r} guo <- guo_norm exprs(guo)[exprs(cleaned_ct) >= 28] <- lod_norm ``` This version of the dataset is avaliable as `data(guo)` from the **destiny** package. Now we call the the `DiffusionMap` function using the censoring model: ```{r} thresh_dm <- DiffusionMap(guo, censor_val = lod_norm, censor_range = c(lod_norm, max_cycles_norm), verbose = FALSE) plot(thresh_dm, 1:2, col_by = 'num_cells', legend_main = 'Cell stage') ``` Compared to the diffusion map created without censoring model, this map looks more homogeneous since it contains more data points. Missing values -------------- Gene expression experiments may fail to produce some data points, conventionally denoted as “not available” (`NA`). By calling `DiffusionMap(..., missings = c(total.minimum, total.maximum))`, you can specify the parameters for the missing value model. As in the data from @guo_resolution_2010 no missing values occurred, we illustrate the capacity of **destiny** to handle missing values by artificially treating ct values of 999 (i. e. data points were no expression was detected after 40 cycles) as missing. This is purely for illustrative purposes and in practice these values should be treated as censored as illustrated in the previous section. ```{r} # remove rows with divisionless cells ct_w_missing <- ct[, ct$num_cells > 1L] # and replace values larger than the baseline exprs(ct_w_missing)[exprs(ct_w_missing) > 28] <- NA ``` We then perform normalization on this version of the data: ```{r} housekeep <- colMeans( exprs(ct_w_missing)[housekeepers, ], na.rm = TRUE) w_missing <- ct_w_missing exprs(w_missing) <- exprs(w_missing) - housekeep exprs(w_missing)[is.na(exprs(ct_w_missing))] <- lod_norm ``` Finally, we create a diffusion map with both missing value model and the censoring model from before: ```{r} dif_w_missing <- DiffusionMap(w_missing, censor_val = lod_norm, censor_range = c(lod_norm, max_cycles_norm), missing_range = c(1, 40), verbose = FALSE) plot(dif_w_missing, 1:2, col_by = 'num_cells', legend_main = 'Cell stage') ``` This result looks very similar to our previous diffusion map since only six additional data points have been added. However if your platform creates more missing values, including missing values will be more useful. Prediction ========== In order to project cells into an existing diffusion map, for example to compare two experiments measured by the same platform or to add new data to an existing map, we implemented `dm.predict`. It calculates the transition probabilities between datapoints in old and new data and projects cells into the diffusion map using the existing diffusion components. As an example we assume that we created a diffusion map from one experiment on 64 cell stage embryos: ```{r} ct64 <- guo[, guo$num_cells == 64] dm64 <- DiffusionMap(ct64) ``` Let us compare the expressions from the 32 cell state embryos to the existing map. We use `dm.predict` to create the diffusion components for the new cells using the existing diffusion components from the old data: ```{r} ct32 <- guo[, guo$num_cells == 32] pred32 <- dm_predict(dm64, ct32) ``` By providing the `more` and `col.more` parameters of the `plot` function, we show the first two DCs for both old and new data: ```{r} plot(dm64, 1:2, col = palette()[[6]], new_dcs = pred32, col_new = palette()[[4]]) ``` Clearly, the 32 and 64 cell state embryos occupy similar regions in the map, while the cells from the 64 cell state are developed further. Troubleshooting =============== There are several properties of data that can yield subpar results. This section explains a few strategies of dealing with them: **Preprocessing**: if there is a strong dependency of the variance on the mean in your data (as for scRNA-Seq count data), use a variance stabilizing transformation such as the square root or a (regularized) logarithm before running **destiny**. **Outliers**: If a Diffusion Component strongly separates some outliers from the remaining cells such that there is a much greater distance between them than within the rest of the cells (i. e. almost two discrete values), consider removing those outliers and recalculating the map, or simply select different Diffusion Components. It may also a be a good idea to check whether the outliers are also present in a PCA plot to make sure they are not biologically relevant. **Large datasets**: If memory is not sufficient and no machine with more RAM is available, the `k` parameter could be decreased. In addition (particularly for >500,000 cells), you can also downsample the data (possibly in a density dependent fashion). **“Large-p-small-n” data**: E.g. for scRNA-Seq, it is may be necessary to first perform a Principal Component Analysis (PCA) on the data (e.g. using `prcomp` or `princomp`) and to calculate the Diffusion Components from the Principal Components (typically using the top 50 components yields good results). References ==========
destiny/inst/doc/Diffusion-Maps.html0000644000175200017520000046456514516030062020530 0ustar00biocbuildbiocbuild destiny main vignette: Start here!

destiny main vignette: Start here!

library(base64enc)
library(ggplot2)  # would shadow Biobase::exprs

suppressPackageStartupMessages({
    library(readxl)
    library(destiny)
    library(Biobase)
})

#setHook('on.rgl.close', function(...) {
#    name <- tempfile()
#    par3d(windowRect = c(0, 0, 1200, 1200))
#    Sys.sleep(1)
#    
#    rgl.snapshot(  filename = paste0(name, '.png'))
#   #rgl.postscript(filename = paste0(name, '.pdf'), fmt='pdf')  # doesn’t work with spheres
#    
#    publish_mimebundle(list(
#        'image/png'       = base64encode(paste0(name, '.png'))
#     #, 'application/pdf' = base64encode(paste0(name, '.pdf'))
#    ))
#}, 'replace')

Diffusion maps are spectral method for non-linear dimension reduction introduced by Coifman et al. (2005). Diffusion maps are based on a distance metric (diffusion distance) which is conceptually relevant to how differentiating cells follow noisy diffusion-like dynamics, moving from a pluripotent state towards more differentiated states.

The R package destiny implements the formulation of diffusion maps presented in Haghverdi, Buettner, and Theis (2015) which is especially suited for analyzing single-cell gene expression data from time-course experiments. It implicitly arranges cells along their developmental path, with bifurcations where differentiation events occur.

In particular we follow Haghverdi, Buettner, and Theis (2015) and present an implementation of diffusion maps in R that is less affected by sampling density heterogeneities and thus capable of identifying both abundant and rare cell populations. In addition, destiny implements complex noise models reflecting zero-inflation/censoring due to drop-out events in single-cell qPCR data and allows for missing values. Finally, we further improve on the implementation from Haghverdi, Buettner, and Theis (2015), and implement a nearest neighbour approximation capable of handling very large data sets of up to 300.000 cells.

For those familiar with R, and data preprocessing, we recommend the section Plotting.

All code in this vignette is accessible via edit(vignette('destiny'))

Preprocessing of single qPCR data

As an example, we present in the following the preprocessing of data from Guo et al. (2010). This dataset was produced by the Biomark RT-qPCR system and contains Ct values for 48 genes of 442 mouse embryonic stem cells at 7 different developmental time points, from the zygote to blastocyst.

Starting at the totipotent 1-cell stage, cells transition smoothly in the transcriptional landscape towards either the trophoectoderm lineage or the inner cell mass. Subsequently, cells transition from the inner cell mass either towards the endoderm or epiblast lineage. This smooth transition from one developmental state to another, including two bifurcation events, is reflected in the expression profiles of the cells and can be visualized using destiny.

Import

Downloading the table S4 from the publication website will give you a spreadsheet “mmc4.xls”, from which the data can be loaded:

library(readxl)
raw_ct <- read_xls('mmc4.xls', 'Sheet1')

raw_ct[1:9, 1:9]  #preview of a few rows and columns
## # A tibble: 9 × 9
##   Cell   Actb  Ahcy  Aqp3 Atp12a  Bmp4  Cdx2 Creb312 Cebpa
##   <chr> <dbl> <dbl> <dbl>  <dbl> <dbl> <dbl>   <dbl> <dbl>
## 1 1C 1   14.0  19.3  23.9     28    28  21.3    20.8  28  
## 2 1C 2   13.7  18.6  28       28    28  23.4    20.9  28  
## 3 1C 3   13.4  18.2  26.2     28    28  22.9    19.6  28  
## 4 1C 4   13.7  18.6  28       28    28  23.3    20.7  28  
## 5 1C 5   13.5  18.6  24.2     28    28  24.2    21.8  23.7
## 6 1C 6   12.9  17.4  25.5     28    28  21.9    21.3  28  
## 7 1C 7   13.0  17.4  23.9     28    28  22.7    21.1  28  
## 8 1C 8   12.8  18.4  23.7     28    28  24.1    19.8  28  
## 9 1C 9   13.3  18.3  28       28    28  21.9    21.2  28

The value 28 is the assumed background expression of 28 cycle times.

In order to easily clean and normalize the data without mangling the annotations, we convert the data.frame into a Bioconductor ExpressionSet using the as.ExpressionSet function from the destiny package, and assign it to the name ct:

library(destiny)
library(Biobase)

# as.data.frame because ExpressionSets
# do not support readxl’s “tibbles”
ct <- as.ExpressionSet(as.data.frame(raw_ct))
ct
## ExpressionSet (storageMode: lockedEnvironment)
## assayData: 48 features, 442 samples 
##   element names: exprs 
## protocolData: none
## phenoData
##   sampleNames: 1 2 ... 442 (442 total)
##   varLabels: Cell
##   varMetadata: labelDescription
## featureData: none
## experimentData: use 'experimentData(object)'
## Annotation:

The advantage of ExpressionSet over data.frame is that tasks like normalizing the expressions are both faster and do not accidentally destroy annotations by applying “normalization” to columns that are not expressions. The approach of handling a separate expression matrix and annotation data.frame requires you to be careful when adding or removing samples on both variables, while ExpressionSet does it internally for you.

The object internally stores an expression matrix of features × samples, retrievable using exprs(ct), and an annotation data.frame of samples × annotations as phenoData(ct). Annotations can be accessed directly via ct$column and ct[['column']]. Note that the expression matrix is transposed compared to the usual samples × features data.frame.

Data cleaning

We remove all cells that have a value bigger than the background expression, indicating data points not available (NA). Also we remove cells from the 1 cell stage embryos, since they were treated systematically different (Guo et al. 2010).

For this, we add an annotation column containing the embryonic cell stage for each sample by extracting the number of cells from the “Cell” annotation column:

num_cells <- gsub('^(\\d+)C.*$', '\\1', ct$Cell)
ct$num_cells <- as.integer(num_cells)

We then use the new annotation column to create two filters:

# cells from 2+ cell embryos
have_duplications <- ct$num_cells > 1
# cells with values <= 28
normal_vals <- apply(exprs(ct), 2, function(smp) all(smp <= 28))

We can use the combination of both filters to exclude both non-divided cells and such containing Ct values higher than the baseline, and store the result as cleaned_ct:

cleaned_ct <- ct[, have_duplications & normal_vals]

Normalization

Finally we follow Guo et al. (2010) and normalize each cell using the endogenous controls Actb and Gapdh by subtracting their average expression for each cell. Note that it is not clear how to normalise sc-qPCR data as the expression of housekeeping genes is also stochastic. Consequently, if such housekeeping normalisation is performed, it is crucial to take the mean of several genes.

housekeepers <- c('Actb', 'Gapdh')  # houskeeper gene names

normalizations <- colMeans(exprs(cleaned_ct)[housekeepers, ])

guo_norm <- cleaned_ct
exprs(guo_norm) <- exprs(guo_norm) - normalizations

The resulting ExpressionSet contains the normalized Ct values of all cells retained after cleaning.

Plotting

The data necessary to create a diffusion map with our package is a a cell×gene matrix or data.frame, or alternatively an ExpressionSet (which has a gene×cell exprs matrix). In order to create a DiffusionMap object, you just need to supply one of those formats as first parameter to the DiffusionMap function. In the case of a data.frame, each floating point column is interpreted as expression levels, and columns of different type (e.g. factor, character or integer) are assumed to be annotations and ignored. Note that single-cell RNA-seq count data should be transformed using a variance-stabilizing transformation (e.g. log or rlog); the Ct scale for qPCR data is logarithmic already (an increase in 1 Ct corresponds to a doubling of transcripts).

In order to create a diffusion map to plot, you have to call DiffusionMap, optionally with parameters. If the number of cells is small enough (< ~1000), you do not need to specify approximations like k (for k nearest neighbors).

If you started reading here, execute data(guo.norm) to load the dataset that was created in the previous section.

library(destiny)
#data(guo_norm)
dm <- DiffusionMap(guo_norm)

Simply calling plot on the resulting object dif will visualize the diffusion components:

plot(dm)

The diffusion map nicely illustrates a branching during the first days of embryonic development.

The annotation column containing the cell stage can be used to annotate our diffusion map. Using the annotation as col parameter will automatically color the map using the current R color palette. Use palette(colors) to configure it globally or plot(..., pal = colors) for one plot.

palette(cube_helix(6)) # configure color palette

plot(dm,
    pch = 20,             # pch for prettier points
    col_by = 'num_cells', # or “col” with a vector or one color
    legend_main = 'Cell stage')

Three branches appear in the map, with a bifurcation occurring the 16 cell stage and the 32 cell stage. The diffusion map is able to arrange cells according to their expression profile: Cells that divided the most and the least appear at the tips of the different branches.

In order to display a 2D plot we supply a vector containing two diffusion component numbers (here 1 & 2) as second argument.

plot(dm, 1:2,
    col_by = 'num_cells',
    legend_main = 'Cell stage')

Alternative visualizations

Diffusion maps consist of eigenvectors called Diffusion Components (DCs) and corresponding eigenvalues. Per default, the first 20 are returned.

You are also able to use packages for interative plots like rgl in a similar fashion, by directly subsetting the DCs using eigenvectors(dif):

library(rgl)
plot3d(
    eigenvectors(dm)[, 1:3],
    col = log2(guo_norm$num_cells),
    type = 's', radius = .01)
view3d(theta = 10, phi = 30, zoom = .8)
# now use your mouse to rotate the plot in the window
rgl.close()
## Warning: 'rgl.close' is deprecated.
## Use 'close3d' instead.
## See help("Deprecated")

For the popular ggplot2 package, there is built in support in the form of a fortify.DiffusionMap method, which allows to use DiffusionMap objects as data parameter in the ggplot and qplot functions. But the regular plot function already returns a ggplot object anyway.

library(ggplot2)
qplot(DC1, DC2, data = dm, colour = factor(num_cells)) +
    scale_color_cube_helix()
## Warning: `qplot()` was deprecated in ggplot2 3.4.0.
## This warning is displayed once every 8 hours.
## Call `lifecycle::last_lifecycle_warnings()` to see where this warning was
## generated.

# or alternatively:
#ggplot(dif, aes(DC1, DC2, colour = factor(num.cells))) + ...

As aesthetics, all diffusion components, gene expressions, and annotations are available. If you plan to make many plots, create a data.frame first by using as.data.frame(dif) or fortify(dif), assign it to a variable name, and use it for plotting.

Parameter selection

The most important parameter for the visualization, dims, is described in the following section. An important parameter in v1, \(\sigma\), is explained in its own vignette “Global Sigma”.

Other parameters are explained at the end of this section.

Dimensions dims

Diffusion maps consist of the eigenvectors (which we refer to as diffusion components) and corresponding eigenvalues of the diffusion distance matrix. The latter indicate the diffusion components’ importance, i.e. how well the eigenvectors approximate the data. The eigenvectors are decreasingly meaningful.

qplot(y = eigenvalues(dm)) + theme_minimal() +
    labs(x = 'Diffusion component (DC)', y = 'Eigenvalue')

The later DCs often become noisy and less useful:

TODO: wide plot

plot(dm, 3:4,   col_by = 'num_cells', draw_legend = FALSE)

plot(dm, 19:20, col_by = 'num_cells', draw_legend = FALSE)

Other parameters

If the automatic exclusion of categorical and integral features for data frames is not enough, you can also supply a vector of variable names or indices to use with the vars parameter. If you find that calculation time or used memory is too large, the parameter k allows you to decrease the quality/runtime+memory ratio by limiting the number of transitions calculated and stored. It is typically not needed if you have less than few thousand cells. The n.eigs parameter specifies the number of diffusion components returned.

For more information, consult help(DiffusionMap).

Missing and uncertain values

destiny is particularly well suited for gene expression data due to its ability to cope with missing and uncertain data.

Censored values

Platforms such as RT-qPCR cannot detect expression values below a certain threshold. To cope with this, destiny allows to censor specific values. In the case of Guo et al. (2010), only up to 28 qPCR cycles were counted. All transcripts that would need more than 28 cycles are grouped together under this value. This is illustrated by gene Aqp3:

hist(exprs(cleaned_ct)['Aqp3', ], breaks = 20,
     xlab = 'Ct of Aqp3', main = 'Histogram of Aqp3 Ct',
     col = palette()[[4]], border = 'white')

For our censoring noise model we need to identify the limit of detection (LoD). While most researchers use a global LoD of 28, reflecting the overall sensitivity of the qPCR machine, different strategies to quantitatively establish this gene-dependent LoD exist. For example, dilution series of bulk data can be used to establish an LoD such that a qPCR reaction will be detected with a specified probability if the Ct value is below the LoD. Here, we use such dilution series provided by Guo et al. and first determine a gene-wise LoD as the largest Ct value smaller than 28. We then follow the manual Application Guidance: Single-Cell Data Analysis of the popular Biomarks system and determine a global LoD as the median over the gene-wise LoDs. We use the dilution series from table S7 (mmc6.xls). If you have problems with the speed of read.xlsx, consider storing your data in tab separated value format and using read.delim or read.ExpressionSet.

dilutions <- read_xls('mmc6.xls', 1L)
dilutions$Cell <- NULL  # remove annotation column

get_lod <- function(gene) gene[[max(which(gene != 28))]]

lods <- apply(dilutions, 2, get_lod)
lod <- ceiling(median(lods))
lod
## [1] 25

This LoD of 25 and the maximum number of cycles the platform can perform (40), defines the uncertainty range that denotes the possible range of censored values in the censoring model. Using the mean of the normalization vector, we can adjust the uncertainty range and censoring value to be more similar to the other values in order to improve distance measures between data points:

lod_norm <- ceiling(median(lods) - mean(normalizations))
max_cycles_norm <- ceiling(40 - mean(normalizations))

list(lod_norm = lod_norm, max_cycles_norm = max_cycles_norm)
## $lod_norm
## [1] 10
## 
## $max_cycles_norm
## [1] 25

We then also need to set the normalized values that should be censored – namely all data points were no expression was detected after the LoD – to this special value, because the values at the cycle threshold were changed due to normalization.

guo <- guo_norm
exprs(guo)[exprs(cleaned_ct) >= 28] <- lod_norm

This version of the dataset is avaliable as data(guo) from the destiny package.

Now we call the the DiffusionMap function using the censoring model:

thresh_dm <- DiffusionMap(guo,
    censor_val = lod_norm,
    censor_range = c(lod_norm, max_cycles_norm),
    verbose = FALSE)

plot(thresh_dm, 1:2, col_by = 'num_cells',
     legend_main = 'Cell stage')

Compared to the diffusion map created without censoring model, this map looks more homogeneous since it contains more data points.

Missing values

Gene expression experiments may fail to produce some data points, conventionally denoted as “not available” (NA). By calling DiffusionMap(..., missings = c(total.minimum, total.maximum)), you can specify the parameters for the missing value model.

As in the data from Guo et al. (2010) no missing values occurred, we illustrate the capacity of destiny to handle missing values by artificially treating ct values of 999 (i. e. data points were no expression was detected after 40 cycles) as missing. This is purely for illustrative purposes and in practice these values should be treated as censored as illustrated in the previous section.

# remove rows with divisionless cells
ct_w_missing <- ct[, ct$num_cells > 1L]
# and replace values larger than the baseline
exprs(ct_w_missing)[exprs(ct_w_missing) > 28] <- NA

We then perform normalization on this version of the data:

housekeep <- colMeans(
    exprs(ct_w_missing)[housekeepers, ],
    na.rm = TRUE)

w_missing <- ct_w_missing
exprs(w_missing) <- exprs(w_missing) - housekeep

exprs(w_missing)[is.na(exprs(ct_w_missing))] <- lod_norm

Finally, we create a diffusion map with both missing value model and the censoring model from before:

dif_w_missing <- DiffusionMap(w_missing,
    censor_val = lod_norm,
    censor_range = c(lod_norm, max_cycles_norm),
    missing_range = c(1, 40),
    verbose = FALSE)

plot(dif_w_missing, 1:2, col_by = 'num_cells',
     legend_main = 'Cell stage')

This result looks very similar to our previous diffusion map since only six additional data points have been added. However if your platform creates more missing values, including missing values will be more useful.

Prediction

In order to project cells into an existing diffusion map, for example to compare two experiments measured by the same platform or to add new data to an existing map, we implemented dm.predict. It calculates the transition probabilities between datapoints in old and new data and projects cells into the diffusion map using the existing diffusion components.

As an example we assume that we created a diffusion map from one experiment on 64 cell stage embryos:

ct64 <- guo[, guo$num_cells == 64]
dm64 <- DiffusionMap(ct64)

Let us compare the expressions from the 32 cell state embryos to the existing map. We use dm.predict to create the diffusion components for the new cells using the existing diffusion components from the old data:

ct32 <- guo[, guo$num_cells == 32]
pred32 <- dm_predict(dm64, ct32)

By providing the more and col.more parameters of the plot function, we show the first two DCs for both old and new data:

plot(dm64,    1:2,     col     = palette()[[6]],
     new_dcs = pred32, col_new = palette()[[4]])

Clearly, the 32 and 64 cell state embryos occupy similar regions in the map, while the cells from the 64 cell state are developed further.

Troubleshooting

There are several properties of data that can yield subpar results. This section explains a few strategies of dealing with them:

Preprocessing: if there is a strong dependency of the variance on the mean in your data (as for scRNA-Seq count data), use a variance stabilizing transformation such as the square root or a (regularized) logarithm before running destiny.

Outliers: If a Diffusion Component strongly separates some outliers from the remaining cells such that there is a much greater distance between them than within the rest of the cells (i. e. almost two discrete values), consider removing those outliers and recalculating the map, or simply select different Diffusion Components. It may also a be a good idea to check whether the outliers are also present in a PCA plot to make sure they are not biologically relevant.

Large datasets: If memory is not sufficient and no machine with more RAM is available, the k parameter could be decreased. In addition (particularly for >500,000 cells), you can also downsample the data (possibly in a density dependent fashion).

“Large-p-small-n” data: E.g. for scRNA-Seq, it is may be necessary to first perform a Principal Component Analysis (PCA) on the data (e.g. using prcomp or princomp) and to calculate the Diffusion Components from the Principal Components (typically using the top 50 components yields good results).

References

Coifman, R. R., S. Lafon, A. B. Lee, M. Maggioni, B. Nadler, F. Warner, and S. W. Zucker. 2005. “Geometric Diffusions as a Tool for Harmonic Analysis and Structure Definition of Data: Diffusion Maps.” PNAS. http://www.pnas.org/content/102/21/7426.long.

Guo, Guoji, Mikael Huss, Guo Qing Tong, Chaoyang Wang, Li Li Sun, Neil D. Clarke, and Paul Robson. 2010. “Resolution of Cell Fate Decisions Revealed by Single-Cell Gene Expression Analysis from Zygote to Blastocyst.” Developmental Cell 18 (4): 675–85. https://doi.org/10.1016/j.devcel.2010.02.012.

Haghverdi, Laleh, Florian Buettner, and Fabian J. Theis. 2015. “Diffusion Maps for High-Dimensional Single-Cell Analysis of Differentiation Data.” Bioinformatics, no. in revision.

destiny/inst/doc/Gene-Relevance.R0000644000175200017520000000627014516030513017703 0ustar00biocbuildbiocbuild## ----------------------------------------------------------------------------- library(conflicted) library(destiny) suppressPackageStartupMessages(library(scran)) library(purrr) library(ggplot2) library(SingleCellExperiment) ## ----------------------------------------------------------------------------- # The parts of the help we’re interested in help('scRNAseq-package', package = 'scRNAseq') %>% repr::repr_html() %>% stringr::str_extract_all(stringr::regex('

The dataset.*?

', dotall = TRUE)) %>% unlist() %>% paste(collapse = '') %>% knitr::raw_html() ## ----------------------------------------------------------------------------- allen <- scRNAseq::ReprocessedAllenData() ## ----------------------------------------------------------------------------- rowData(allen)$Symbol <- rownames(allen) rowData(allen)$EntrezID <- AnnotationDbi::mapIds(org.Mm.eg.db::org.Mm.eg.db, rownames(allen), 'ENTREZID', 'ALIAS') rowData(allen)$Uniprot <- AnnotationDbi::mapIds(org.Mm.eg.db::org.Mm.eg.db, rownames(allen), 'UNIPROT', 'ALIAS', multiVals = 'list') assayNames(allen)[assayNames(allen) == 'rsem_counts'] <- 'counts' assayNames(altExp(allen, 'ERCC'))[assayNames(altExp(allen, 'ERCC')) == 'rsem_counts'] <- 'counts' allen ## ----------------------------------------------------------------------------- allen <- computeSpikeFactors(allen, 'ERCC') allen <- logNormCounts(allen) allen ## ----------------------------------------------------------------------------- decomp <- modelGeneVarWithSpikes(allen, 'ERCC') rowData(allen)$hvg_order <- order(decomp$bio, decreasing = TRUE) ## ----------------------------------------------------------------------------- allen_hvg <- subset(allen, hvg_order <= 5000L) ## ----------------------------------------------------------------------------- #reducedDim(allen_hvg, 'pca') <- irlba::prcomp_irlba(t(assay(allen, 'logcounts')), 50)$x ## ----------------------------------------------------------------------------- set.seed(1) dms <- c('euclidean', 'cosine', 'rankcor') %>% #, 'l2' set_names() %>% map(~ DiffusionMap(allen_hvg, distance = ., knn_params = list(method = 'covertree'))) ## ----------------------------------------------------------------------------- dms %>% imap(function(dm, dist) plot(dm, 1:2, col_by = 'driver_1_s') + ggtitle(dist)) %>% cowplot::plot_grid(plotlist = ., nrow = 1) ## ----------------------------------------------------------------------------- grs <- map(dms, gene_relevance) ## ----------------------------------------------------------------------------- gms <- imap(grs, function(gr, dist) plot(gr, iter_smooth = 0) + ggtitle(dist)) cowplot::plot_grid(plotlist = gms, nrow = 1) ## ----------------------------------------------------------------------------- gms[-1] %>% map(~ .$ids[1:10]) %>% purrr::reduce(intersect) %>% cat(sep = ' ') ## ----------------------------------------------------------------------------- httr::GET('https://www.uniprot.org/uniprot/', query = list( columns = 'id,genes,comment(TISSUE SPECIFICITY)', format = 'tab', query = rowData(allen)$Uniprot[gms$cosine$ids[1:6]] %>% unlist() %>% paste(collapse = ' or ') )) %>% httr::content(type = 'text/tab-separated-values', encoding = 'utf-8', ) destiny/inst/doc/Gene-Relevance.Rmd0000644000175200017520000001054214516010071020216 0ustar00biocbuildbiocbuild--- title: detecting relevant genes with destiny 3 output: rmarkdown::html_vignette vignette: > %\VignetteIndexEntry{detecting relevant genes with destiny 3} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} --- Single Cell RNA-Sequencing data and gene relevance ================================================== Libraries --------- We need of course destiny, scran for preprocessing, and some tidyverse niceties. ```{r} library(conflicted) library(destiny) suppressPackageStartupMessages(library(scran)) library(purrr) library(ggplot2) library(SingleCellExperiment) ``` Data ---- Let’s use data from the `scRNAseq`[1] package. If necessary, install it via `BiocManager::install('scRNAseq')`. [1] Risso D, Cole M (2019). [scRNAseq: A Collection of Public Single-Cell RNA-Seq Datasets](https://bioconductor.org/packages/scRNAseq/). ```{r} # The parts of the help we’re interested in help('scRNAseq-package', package = 'scRNAseq') %>% repr::repr_html() %>% stringr::str_extract_all(stringr::regex('

The dataset.*?

', dotall = TRUE)) %>% unlist() %>% paste(collapse = '') %>% knitr::raw_html() ``` 379 cells seems sufficient to see something! ```{r} allen <- scRNAseq::ReprocessedAllenData() ``` Preprocessing ------------- We’ll mostly stick to the [scran vignette][] here. Let’s add basic information to the data and choose what to work with. As `scran` expects the raw counts in the `counts` assay, we rename the more accurate RSEM counts to `counts`. Our data has ERCC spike-ins in an `altExp` slot: [scran vignette]: https://bioconductor.org/packages/devel/bioc/vignettes/scran/inst/doc/scran.html ```{r} rowData(allen)$Symbol <- rownames(allen) rowData(allen)$EntrezID <- AnnotationDbi::mapIds(org.Mm.eg.db::org.Mm.eg.db, rownames(allen), 'ENTREZID', 'ALIAS') rowData(allen)$Uniprot <- AnnotationDbi::mapIds(org.Mm.eg.db::org.Mm.eg.db, rownames(allen), 'UNIPROT', 'ALIAS', multiVals = 'list') assayNames(allen)[assayNames(allen) == 'rsem_counts'] <- 'counts' assayNames(altExp(allen, 'ERCC'))[assayNames(altExp(allen, 'ERCC')) == 'rsem_counts'] <- 'counts' allen ``` Now we can use it to renormalize the data. We normalize the `counts` using the spike-in size factors and logarithmize them into `logcounts`. ```{r} allen <- computeSpikeFactors(allen, 'ERCC') allen <- logNormCounts(allen) allen ``` We also use the spike-ins to detect highly variable genes more accurately: ```{r} decomp <- modelGeneVarWithSpikes(allen, 'ERCC') rowData(allen)$hvg_order <- order(decomp$bio, decreasing = TRUE) ``` We create a subset of the data containing only rasonably highly variable genes: ```{r} allen_hvg <- subset(allen, hvg_order <= 5000L) ``` Let’s create a Diffusion map. For rapid results, people often create a PCA first, which can be stored in your `SingleCellExperiment` before creating the Diffusion map or simply created implicitly using `DiffusionMap(..., n_pcs = )`. However, even with many more principal components than necessary to get a nicely resolved Diffusion Map, the close spatial correspondence between diffusion components and genes are lost. ```{r} #reducedDim(allen_hvg, 'pca') <- irlba::prcomp_irlba(t(assay(allen, 'logcounts')), 50)$x ``` The chosen distance metric has big implications on your results, you should try at least cosine and rankcor. ```{r} set.seed(1) dms <- c('euclidean', 'cosine', 'rankcor') %>% #, 'l2' set_names() %>% map(~ DiffusionMap(allen_hvg, distance = ., knn_params = list(method = 'covertree'))) ``` TODO: wide plot ```{r} dms %>% imap(function(dm, dist) plot(dm, 1:2, col_by = 'driver_1_s') + ggtitle(dist)) %>% cowplot::plot_grid(plotlist = ., nrow = 1) ``` ```{r} grs <- map(dms, gene_relevance) ``` TODO: wide plot ```{r} gms <- imap(grs, function(gr, dist) plot(gr, iter_smooth = 0) + ggtitle(dist)) cowplot::plot_grid(plotlist = gms, nrow = 1) ``` As you can see, despite the quite different embedding, the rankcor and Cosine diffusion Maps display a number of the same driving genes. ```{r} gms[-1] %>% map(~ .$ids[1:10]) %>% purrr::reduce(intersect) %>% cat(sep = ' ') ``` ```{r} httr::GET('https://www.uniprot.org/uniprot/', query = list( columns = 'id,genes,comment(TISSUE SPECIFICITY)', format = 'tab', query = rowData(allen)$Uniprot[gms$cosine$ids[1:6]] %>% unlist() %>% paste(collapse = ' or ') )) %>% httr::content(type = 'text/tab-separated-values', encoding = 'utf-8', ) ``` destiny/inst/doc/Gene-Relevance.html0000644000175200017520000016324414516030513020453 0ustar00biocbuildbiocbuild detecting relevant genes with destiny 3

detecting relevant genes with destiny 3

Single Cell RNA-Sequencing data and gene relevance

Libraries

We need of course destiny, scran for preprocessing, and some tidyverse niceties.

library(conflicted)
library(destiny)
suppressPackageStartupMessages(library(scran))
library(purrr)
library(ggplot2)
library(SingleCellExperiment)

Data

Let’s use data from the scRNAseq[1] package. If necessary, install it via BiocManager::install('scRNAseq').

[1] Risso D, Cole M (2019). scRNAseq: A Collection of Public Single-Cell RNA-Seq Datasets.

# The parts of the help we’re interested in
help('scRNAseq-package', package = 'scRNAseq') %>% repr::repr_html() %>%
    stringr::str_extract_all(stringr::regex('<p>The dataset.*?</p>', dotall = TRUE)) %>% unlist() %>%
    paste(collapse = '') %>% knitr::raw_html()

The dataset fluidigm contains 65 cells from Pollen et al. (2014), each sequenced at high and low coverage.

The dataset th2 contains 96 T helper cells from Mahata et al. (2014).

The dataset allen contains 379 cells from the mouse visual cortex. This is a subset of the data published in Tasic et al. (2016).

379 cells seems sufficient to see something!

allen <- scRNAseq::ReprocessedAllenData()
## see ?scRNAseq and browseVignettes('scRNAseq') for documentation
## loading from cache
## see ?scRNAseq and browseVignettes('scRNAseq') for documentation
## loading from cache
## see ?scRNAseq and browseVignettes('scRNAseq') for documentation
## loading from cache
## see ?scRNAseq and browseVignettes('scRNAseq') for documentation
## loading from cache
## see ?scRNAseq and browseVignettes('scRNAseq') for documentation
## loading from cache
## see ?scRNAseq and browseVignettes('scRNAseq') for documentation
## loading from cache

Preprocessing

We’ll mostly stick to the scran vignette here. Let’s add basic information to the data and choose what to work with.

As scran expects the raw counts in the counts assay, we rename the more accurate RSEM counts to counts. Our data has ERCC spike-ins in an altExp slot:

rowData(allen)$Symbol <- rownames(allen)
rowData(allen)$EntrezID <- AnnotationDbi::mapIds(org.Mm.eg.db::org.Mm.eg.db, rownames(allen), 'ENTREZID', 'ALIAS')
## 
## 'select()' returned 1:many mapping between keys and columns
rowData(allen)$Uniprot <- AnnotationDbi::mapIds(org.Mm.eg.db::org.Mm.eg.db, rownames(allen), 'UNIPROT', 'ALIAS', multiVals = 'list')
## 'select()' returned 1:many mapping between keys and columns
assayNames(allen)[assayNames(allen) == 'rsem_counts'] <- 'counts'
assayNames(altExp(allen, 'ERCC'))[assayNames(altExp(allen, 'ERCC')) == 'rsem_counts'] <- 'counts'
allen
## class: SingleCellExperiment 
## dim: 20816 379 
## metadata(2): SuppInfo which_qc
## assays(4): tophat_counts cufflinks_fpkm counts rsem_tpm
## rownames(20816): 0610007P14Rik 0610009B22Rik ... Zzef1 Zzz3
## rowData names(3): Symbol EntrezID Uniprot
## colnames(379): SRR2140028 SRR2140022 ... SRR2139341 SRR2139336
## colData names(22): NREADS NALIGNED ... Animal.ID passes_qc_checks_s
## reducedDimNames(0):
## mainExpName: endogenous
## altExpNames(1): ERCC

Now we can use it to renormalize the data. We normalize the counts using the spike-in size factors and logarithmize them into logcounts.

allen <- computeSpikeFactors(allen, 'ERCC')
allen <- logNormCounts(allen)
allen
## class: SingleCellExperiment 
## dim: 20816 379 
## metadata(2): SuppInfo which_qc
## assays(5): tophat_counts cufflinks_fpkm counts rsem_tpm logcounts
## rownames(20816): 0610007P14Rik 0610009B22Rik ... Zzef1 Zzz3
## rowData names(3): Symbol EntrezID Uniprot
## colnames(379): SRR2140028 SRR2140022 ... SRR2139341 SRR2139336
## colData names(23): NREADS NALIGNED ... passes_qc_checks_s sizeFactor
## reducedDimNames(0):
## mainExpName: endogenous
## altExpNames(1): ERCC

We also use the spike-ins to detect highly variable genes more accurately:

decomp <- modelGeneVarWithSpikes(allen, 'ERCC')
rowData(allen)$hvg_order <- order(decomp$bio, decreasing = TRUE)

We create a subset of the data containing only rasonably highly variable genes:

allen_hvg <- subset(allen, hvg_order <= 5000L)

Let’s create a Diffusion map. For rapid results, people often create a PCA first, which can be stored in your SingleCellExperiment before creating the Diffusion map or simply created implicitly using DiffusionMap(..., n_pcs = <number>).

However, even with many more principal components than necessary to get a nicely resolved Diffusion Map, the close spatial correspondence between diffusion components and genes are lost.

#reducedDim(allen_hvg, 'pca') <- irlba::prcomp_irlba(t(assay(allen, 'logcounts')), 50)$x

The chosen distance metric has big implications on your results, you should try at least cosine and rankcor.

set.seed(1)
dms <- c('euclidean', 'cosine', 'rankcor') %>% #, 'l2'
    set_names() %>%
    map(~ DiffusionMap(allen_hvg, distance = ., knn_params = list(method = 'covertree')))
## Warning in DiffusionMap(allen_hvg, distance = ., knn_params = list(method =
## "covertree")): You have 5000 genes. Consider passing e.g. n_pcs = 50 to speed
## up computation.

## Warning in DiffusionMap(allen_hvg, distance = ., knn_params = list(method =
## "covertree")): You have 5000 genes. Consider passing e.g. n_pcs = 50 to speed
## up computation.

## Warning in DiffusionMap(allen_hvg, distance = ., knn_params = list(method =
## "covertree")): You have 5000 genes. Consider passing e.g. n_pcs = 50 to speed
## up computation.

TODO: wide plot

dms %>%
    imap(function(dm, dist) plot(dm, 1:2, col_by = 'driver_1_s') + ggtitle(dist)) %>%
    cowplot::plot_grid(plotlist = ., nrow = 1)

grs <- map(dms, gene_relevance)

TODO: wide plot

gms <- imap(grs, function(gr, dist) plot(gr, iter_smooth = 0) + ggtitle(dist))
cowplot::plot_grid(plotlist = gms, nrow = 1)

As you can see, despite the quite different embedding, the rankcor and Cosine diffusion Maps display a number of the same driving genes.

gms[-1] %>% map(~ .$ids[1:10]) %>% purrr::reduce(intersect) %>% cat(sep = ' ')
httr::GET('https://www.uniprot.org/uniprot/', query = list(
    columns = 'id,genes,comment(TISSUE SPECIFICITY)',
    format = 'tab',
    query = rowData(allen)$Uniprot[gms$cosine$ids[1:6]] %>% unlist() %>% paste(collapse = ' or ')
)) %>% httr::content(type = 'text/tab-separated-values', encoding = 'utf-8', )
## Rows: 0 Columns: 1
## ── Column specification ────────────────────────────────────────────────────────
## Delimiter: "\t"
## chr (1): {"timestamp":"2023-10-24T21:04:11.123+00:00","status":500,"error":"...
## 
## ℹ Use `spec()` to retrieve the full column specification for this data.
## ℹ Specify the column types or set `show_col_types = FALSE` to quiet this message.
## # A tibble: 0 × 1
## # ℹ 1 variable:
## #   {"timestamp":"2023-10-24T21:04:11.123+00:00","status":500,"error":"Internal Server Error","message":"","path":"/uniprotkb/columns=id,genes,comment(TISSUE%20SPECIFICITY)&format=tab&query=Q8K2G4%20or%20Q922E6%20or%20Q8QZR0%20or%20Q505Q3%20or%20Q99KR8%20or%20Q923G2%20or%20P62254%20or%20Q5F239"} <chr>
destiny/inst/doc/Global-Sigma.R0000644000175200017520000000122714516030516017361 0ustar00biocbuildbiocbuild## ----------------------------------------------------------------------------- library(destiny) data(guo_norm) ## ----------------------------------------------------------------------------- sigmas <- find_sigmas(guo_norm, verbose = FALSE) optimal_sigma(sigmas) ## ----------------------------------------------------------------------------- palette(cube_helix(6)) plots <- lapply( list('local', 5, round(optimal_sigma(sigmas), 2), 100), function(sigma) plot( DiffusionMap(guo_norm, sigma), 1:2, main = paste('σ =', sigma), col_by = 'num_cells', draw_legend = FALSE)) do.call(gridExtra::grid.arrange, c(plots, ncol = 2)) destiny/inst/doc/Global-Sigma.Rmd0000644000175200017520000000424414516010071017676 0ustar00biocbuildbiocbuild--- title: The effects of a global vs. local kernel output: rmarkdown::html_vignette bibliography: bibliography.bib vignette: > %\VignetteIndexEntry{The effects of a global vs. local kernel} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} --- Gaussian kernel width `sigma` ============================= The other important parameter for `DiffusionMap` is the Gaussian kernel width `sigma` ($\sigma$) that determines the transition probability between data points. The default call of **destiny** – `DiffusionMap(data)` aka `DiffusionMap(data, 'local')`) – uses a local `sigma` per cell, derived from a local density estimate around each cell. Using the 1.0 default, `sigma = 'global'`, estimates sigma using a heuristic. It is also possible to specify this parameter manually to tweak the result. The eigenvector plot explained above will show a continuous decline instead of sharp drops if either the dataset is too big or the `sigma` is chosen too small. The sigma estimation algorithm is explained in detail in @haghverdi_diffusion_2015. In brief, it works by finding a maximum in the slope of the log-log plot of local density versus `sigma`. ```{r} library(destiny) data(guo_norm) ``` Using find_sigmas ----------------- An efficient variant of that procedure is provided by `find_sigmas`. This function determines the optimal sigma for a subset of the given data and provides the default sigma for a `DiffusionMap` call. Due to a different starting point, the resulting sigma is different from above: ```{r} sigmas <- find_sigmas(guo_norm, verbose = FALSE) optimal_sigma(sigmas) ``` The resulting diffusion map’s approximation depends on the chosen sigma. Note that the sigma estimation heuristic only finds local optima and even the global optimum of the heuristic might not be ideal for your data. ```{r} palette(cube_helix(6)) plots <- lapply( list('local', 5, round(optimal_sigma(sigmas), 2), 100), function(sigma) plot( DiffusionMap(guo_norm, sigma), 1:2, main = paste('σ =', sigma), col_by = 'num_cells', draw_legend = FALSE)) do.call(gridExtra::grid.arrange, c(plots, ncol = 2)) ``` References ==========
destiny/inst/doc/Global-Sigma.html0000644000175200017520000005257414516030517020140 0ustar00biocbuildbiocbuild The effects of a global vs. local kernel

The effects of a global vs. local kernel

Gaussian kernel width sigma

The other important parameter for DiffusionMap is the Gaussian kernel width sigma (\(\sigma\)) that determines the transition probability between data points. The default call of destinyDiffusionMap(data) aka DiffusionMap(data, 'local')) – uses a local sigma per cell, derived from a local density estimate around each cell.

Using the 1.0 default, sigma = 'global', estimates sigma using a heuristic. It is also possible to specify this parameter manually to tweak the result. The eigenvector plot explained above will show a continuous decline instead of sharp drops if either the dataset is too big or the sigma is chosen too small.

The sigma estimation algorithm is explained in detail in Haghverdi, Buettner, and Theis (2015). In brief, it works by finding a maximum in the slope of the log-log plot of local density versus sigma.

library(destiny)
data(guo_norm)

Using find_sigmas

An efficient variant of that procedure is provided by find_sigmas. This function determines the optimal sigma for a subset of the given data and provides the default sigma for a DiffusionMap call. Due to a different starting point, the resulting sigma is different from above:

sigmas <- find_sigmas(guo_norm, verbose = FALSE)
optimal_sigma(sigmas)
## [1] 10.8946

The resulting diffusion map’s approximation depends on the chosen sigma. Note that the sigma estimation heuristic only finds local optima and even the global optimum of the heuristic might not be ideal for your data.

palette(cube_helix(6))

plots <- lapply(
    list('local', 5, round(optimal_sigma(sigmas), 2), 100),
    function(sigma) plot(
        DiffusionMap(guo_norm, sigma), 1:2,
        main = paste('σ =', sigma),
        col_by = 'num_cells', draw_legend = FALSE))

do.call(gridExtra::grid.arrange, c(plots, ncol = 2))

References

Haghverdi, Laleh, Florian Buettner, and Fabian J. Theis. 2015. “Diffusion Maps for High-Dimensional Single-Cell Analysis of Differentiation Data.” Bioinformatics, no. in revision.

destiny/inst/doc/bibliography.bib0000644000175200017520000001062714516010071020127 0ustar00biocbuildbiocbuild@article{coifman_geometric_2005, title = {Geometric diffusions as a tool for harmonic analysis and structure definition of data: {Diffusion} maps}, url = {http://www.pnas.org/content/102/21/7426.long}, journal = {PNAS}, author = {Coifman, R. R. and Lafon, S. and Lee, A. B. and Maggioni, M. and Nadler, B. and Warner, F. and Zucker, S. W.}, year = {2005}, keywords = {diffusionmap}, file = {Coifman et al_2005_Geometric diffusions as a tool for harmonic analysis and structure definition.pdf:/home/angerer/.mozilla/firefox/6e2r9n55.default/zotero/storage/JJ3J5GKE/Coifman et al_2005_Geometric diffusions as a tool for harmonic analysis and structure definition.pdf:application/pdf} } @article{haghverdi_diffusion_2015, title = {Diffusion maps for high-dimensional single-cell analysis of differentiation data}, number = {in revision}, journal = {Bioinformatics}, author = {Haghverdi, Laleh and Buettner, Florian and Theis, Fabian J.}, year = {2015}, keywords = {diffusionmap}, file = {Haghverdi et al_2014_Diffusion maps for high-dimensional single-cell analysis of differentiation data.pdf:/home/angerer/.mozilla/firefox/6e2r9n55.default/zotero/storage/WHMAVF8P/Haghverdi et al_2014_Diffusion maps for high-dimensional single-cell analysis of differentiation data.pdf:application/pdf;Haghverdi et al_2015_Diffusion maps for high-dimensional single-cell analysis of differentiation data.pdf:/home/angerer/.mozilla/firefox/6e2r9n55.default/zotero/storage/MP8B6VAE/Haghverdi et al_2015_Diffusion maps for high-dimensional single-cell analysis of differentiation data.pdf:application/pdf} } @article{guo_resolution_2010, title = {Resolution of cell fate decisions revealed by single-cell gene expression analysis from zygote to blastocyst}, volume = {18}, issn = {1878-1551}, url = {http://www.sciencedirect.com/science/article/pii/S1534580710001103}, doi = {10.1016/j.devcel.2010.02.012}, abstract = {Three distinct cell types are present within the 64-cell stage mouse blastocyst. We have investigated cellular development up to this stage using single-cell expression analysis of more than 500 cells. The 48 genes analyzed were selected in part based on a whole-embryo analysis of more than 800 transcription factors. We show that in the morula, blastomeres coexpress transcription factors specific to different lineages, but by the 64-cell stage three cell types can be clearly distinguished according to their quantitative expression profiles. We identify Id2 and Sox2 as the earliest markers of outer and inner cells, respectively. This is followed by an inverse correlation in expression for the receptor-ligand pair Fgfr2/Fgf4 in the early inner cell mass. Position and signaling events appear to precede the maturation of the transcriptional program. These results illustrate the power of single-cell expression analysis to provide insight into developmental mechanisms. The technique should be widely applicable to other biological systems.}, language = {eng}, number = {4}, journal = {Developmental Cell}, author = {Guo, Guoji and Huss, Mikael and Tong, Guo Qing and Wang, Chaoyang and Li Sun, Li and Clarke, Neil D. and Robson, Paul}, month = apr, year = {2010}, pmid = {20412781}, keywords = {Animals, Blastocyst, Cell Cycle, Cell Differentiation, Cell Lineage, Developmental Biology, Female, Gene Expression Profiling, Gene Expression Regulation, Developmental, Male, Mice, Signal Transduction, Transcriptional Activation, Transcription, Genetic, Zygote}, pages = {675--685}, file = {Guo et al_2010_Resolution of cell fate decisions revealed by single-cell gene expression.pdf:/home/angerer/.mozilla/firefox/6e2r9n55.default/zotero/storage/P9ZJIHJQ/Guo et al_2010_Resolution of cell fate decisions revealed by single-cell gene expression.pdf:application/pdf} } @article{haghverdi_diffusion_2016, title = {Diffusion pseudotime robustly reconstructs lineage branching}, issn = {1548-7091, 1548-7105}, url = {http://www.nature.com/doifinder/10.1038/nmeth.3971}, doi = {10.1038/nmeth.3971}, journal = {Nature Methods}, author = {Haghverdi, Laleh and Büttner, Maren and Wolf, F Alexander and Buettner, Florian and Theis, Fabian J}, urldate = {2016-09-26}, date = {2016-08-29}, year = {2016}, file = {Haghverdi et al. - 2016 - Diffusion pseudotime robustly reconstructs lineage.pdf:/home/angerer/.mozilla/firefox/6e2r9n55.default/zotero/storage/2FZK7BSS/Haghverdi et al. - 2016 - Diffusion pseudotime robustly reconstructs lineage.pdf:application/pdf} } destiny/inst/doc/tidyverse.R0000644000175200017520000000365614516030524017150 0ustar00biocbuildbiocbuild## ----------------------------------------------------------------------------- suppressPackageStartupMessages({ library(destiny) library(tidyverse) library(forcats) # not in the default tidyverse loadout }) ## ----------------------------------------------------------------------------- scale_colour_continuous <- scale_color_viridis_c ## ----------------------------------------------------------------------------- theme_set(theme_gray() + theme( axis.ticks = element_blank(), axis.text = element_blank())) ## ----------------------------------------------------------------------------- data(guo_norm) ## ----------------------------------------------------------------------------- guo_norm %>% as('data.frame') %>% gather(Gene, Expression, one_of(featureNames(guo_norm))) ## ----------------------------------------------------------------------------- dm <- DiffusionMap(guo_norm) ## ----------------------------------------------------------------------------- names(dm) # namely: Diffusion Components, Genes, and Covariates ## ----------------------------------------------------------------------------- ggplot(dm, aes(DC1, DC2, colour = Klf2)) + geom_point() ## ----------------------------------------------------------------------------- fortify(dm) %>% mutate( EmbryoState = factor(num_cells) %>% lvls_revalue(paste(levels(.), 'cell state')) ) %>% ggplot(aes(DC1, DC2, colour = EmbryoState)) + geom_point() ## ----------------------------------------------------------------------------- fortify(dm) %>% gather(DC, OtherDC, num_range('DC', 2:5)) %>% ggplot(aes(DC1, OtherDC, colour = factor(num_cells))) + geom_point() + facet_wrap(~ DC) ## ----------------------------------------------------------------------------- fortify(dm) %>% sample_frac() %>% ggplot(aes(DC1, DC2, colour = factor(num_cells))) + geom_point(alpha = .3) destiny/inst/doc/tidyverse.Rmd0000644000175200017520000000631414516010071017456 0ustar00biocbuildbiocbuild--- title: tidyverse and ggplot integration with destiny output: rmarkdown::html_vignette vignette: > %\VignetteIndexEntry{tidyverse and ggplot integration with destiny} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} --- Interaction with the tidyverse and ggplot2 ========================================== The [tidyverse](https://www.tidyverse.org/), [ggplot2](http://ggplot2.tidyverse.org/), and destiny are a great fit! ```{r} suppressPackageStartupMessages({ library(destiny) library(tidyverse) library(forcats) # not in the default tidyverse loadout }) ``` ggplot has a peculiar method to set default scales: You just have to define certain variables. ```{r} scale_colour_continuous <- scale_color_viridis_c ``` When working mainly with dimension reductions, I suggest to hide the (useless) ticks: ```{r} theme_set(theme_gray() + theme( axis.ticks = element_blank(), axis.text = element_blank())) ``` Let’s load our dataset ```{r} data(guo_norm) ``` Of course you could use [tidyr](http://tidyr.tidyverse.org/)::[gather()](https://rdrr.io/cran/tidyr/man/gather.html) to tidy or transform the data now, but the data is already in the right form for destiny, and [R for Data Science](http://r4ds.had.co.nz/tidy-data.html) is a better resource for it than this vignette. The long form of a single cell `ExpressionSet` would look like: ```{r} guo_norm %>% as('data.frame') %>% gather(Gene, Expression, one_of(featureNames(guo_norm))) ``` But destiny doesn’t use long form data as input, since all single cell data has always a more compact structure of genes×cells, with a certain number of per-sample covariates (The structure of `ExpressionSet`). ```{r} dm <- DiffusionMap(guo_norm) ``` `names(dm)` shows what names can be used in `dm$`, `as.data.frame(dm)$`, or `ggplot(dm, aes())`: ```{r} names(dm) # namely: Diffusion Components, Genes, and Covariates ``` Due to the `fortify` method (which here just means `as.data.frame`) being defined on `DiffusionMap` objects, `ggplot` directly accepts `DiffusionMap` objects: ```{r} ggplot(dm, aes(DC1, DC2, colour = Klf2)) + geom_point() ``` When you want to use a Diffusion Map in a dplyr pipeline, you need to call `fortify`/`as.data.frame` directly: ```{r} fortify(dm) %>% mutate( EmbryoState = factor(num_cells) %>% lvls_revalue(paste(levels(.), 'cell state')) ) %>% ggplot(aes(DC1, DC2, colour = EmbryoState)) + geom_point() ``` The Diffusion Components of a converted Diffusion Map, similar to the genes in the input `ExpressionSet`, are individual variables instead of two columns in a long-form data frame, but sometimes it can be useful to “tidy” them: ```{r} fortify(dm) %>% gather(DC, OtherDC, num_range('DC', 2:5)) %>% ggplot(aes(DC1, OtherDC, colour = factor(num_cells))) + geom_point() + facet_wrap(~ DC) ``` Another tip: To reduce overplotting, use `sample_frac(., 1.0, replace = FALSE)` (the default) in a pipeline. Adding a constant `alpha` improves this even more, and also helps you see density: ```{r} fortify(dm) %>% sample_frac() %>% ggplot(aes(DC1, DC2, colour = factor(num_cells))) + geom_point(alpha = .3) ``` destiny/inst/doc/tidyverse.html0000644000175200017520000410370314516030526017713 0ustar00biocbuildbiocbuild tidyverse and ggplot integration with destiny

tidyverse and ggplot integration with destiny

Interaction with the tidyverse and ggplot2

The tidyverse, ggplot2, and destiny are a great fit!

suppressPackageStartupMessages({
    library(destiny)
    library(tidyverse)
    library(forcats)  # not in the default tidyverse loadout
})

ggplot has a peculiar method to set default scales: You just have to define certain variables.

scale_colour_continuous <- scale_color_viridis_c

When working mainly with dimension reductions, I suggest to hide the (useless) ticks:

theme_set(theme_gray() + theme(
    axis.ticks = element_blank(),
    axis.text  = element_blank()))

Let’s load our dataset

data(guo_norm)

Of course you could use tidyr::gather() to tidy or transform the data now, but the data is already in the right form for destiny, and R for Data Science is a better resource for it than this vignette. The long form of a single cell ExpressionSet would look like:

guo_norm %>%
    as('data.frame') %>%
    gather(Gene, Expression, one_of(featureNames(guo_norm)))
##           Cell num_cells    Gene Expression
## 1       2C 1.1         2    Actb    -0.5750
## 2       2C 1.2         2    Actb    -0.4350
## 3       2C 2.1         2    Actb     0.4600
## 4       2C 2.2         2    Actb     0.6100
## 5       2C 3.1         2    Actb     1.9700
## 6       2C 3.2         2    Actb     2.2850
## 7       2C 4.1         2    Actb     1.7850
## 8       2C 5.1         2    Actb     1.4950
## 9       2C 5.2         2    Actb     1.9350
## 10      2C 6.1         2    Actb    -0.8200
## 11      2C 6.2         2    Actb    -1.3350
## 12      2C 7.1         2    Actb    -0.5950
## 13      2C 7.2         2    Actb    -0.6000
## 14      2C 8.1         2    Actb     2.6600
## 15      2C 8.2         2    Actb     1.2050
## 16      2C 9.1         2    Actb     1.4250
## 17      2C 9.2         2    Actb     0.8150
## 18     2C 10.1         2    Actb     2.0750
## 19     2C 10.2         2    Actb    -0.5200
## 20      4C 1.1         4    Actb    -4.2450
## 21      4C 1.2         4    Actb     0.5700
## 22      4C 1.3         4    Actb    -0.0850
## 23      4C 1.4         4    Actb     2.7850
## 24      4C 2.1         4    Actb     1.8800
## 25      4C 2.2         4    Actb     2.1700
## 26      4C 2.3         4    Actb     1.3900
## 27      4C 3.1         4    Actb     1.2600
## 28      4C 3.2         4    Actb     0.8350
## 29      4C 3.3         4    Actb    -0.7450
## 30      4C 3.4         4    Actb    -0.2800
## 31      4C 4.1         4    Actb     0.8050
## 32      4C 4.2         4    Actb     2.6150
## 33      4C 4.3         4    Actb     3.5875
## 34      4C 4.4         4    Actb     1.9700
## 35      4C 5.1         4    Actb     1.3850
## 36      4C 5.2         4    Actb     0.9300
## 37      4C 5.3         4    Actb    -0.2200
## 38      4C 5.4         4    Actb    -1.0250
## 39      4C 6.1         4    Actb    -0.3800
## 40      4C 6.2         4    Actb     0.8650
## 41      4C 6.3         4    Actb     0.6000
## 42      4C 6.4         4    Actb    -0.9675
## 43      8C 1.1         8    Actb     3.0050
## 44      8C 1.2         8    Actb    -0.8750
## 45      8C 1.3         8    Actb    -0.3350
## 46      8C 1.4         8    Actb    -3.1350
## 47      8C 1.5         8    Actb    -1.4300
## 48      8C 2.1         8    Actb    -2.4750
## 49      8C 2.2         8    Actb    -1.1950
## 50      8C 2.3         8    Actb     0.9050
## 51      8C 2.4         8    Actb     3.4650
## 52      8C 2.5         8    Actb    -0.1650
## 53      8C 2.6         8    Actb    -3.1200
## 54      8C 2.7         8    Actb    -2.6650
## 55      8C 2.8         8    Actb    -2.6700
## 56      8C 3.1         8    Actb     0.2350
## 57      8C 3.2         8    Actb     1.2850
## 58      8C 3.3         8    Actb     0.9300
## 59      8C 3.4         8    Actb     0.8550
## 60      8C 3.5         8    Actb     0.0550
## 61      8C 3.6         8    Actb     0.5350
## 62      8C 3.7         8    Actb    -0.7950
## 63      8C 3.8         8    Actb    -0.5700
## 64      8C 4.2         8    Actb     1.3450
## 65      8C 4.3         8    Actb    -2.0850
## 66      8C 4.4         8    Actb    -0.2350
## 67      8C 4.5         8    Actb     3.2200
## 68      8C 4.6         8    Actb     0.3550
## 69      8C 4.7         8    Actb    -0.7600
## 70      8C 5.1         8    Actb     1.2200
## 71      8C 5.2         8    Actb     0.3950
## 72      8C 5.3         8    Actb    -0.6550
## 73      8C 5.4         8    Actb    -3.2100
## 74      8C 5.5         8    Actb    -2.3400
## 75      8C 5.6         8    Actb    -2.2450
## 76      8C 5.7         8    Actb     0.3000
## 77      8C 5.8         8    Actb     1.3150
## 78      8C 6.1         8    Actb     0.2250
## 79      8C 6.2         8    Actb     2.6050
## 80      8C 6.3         8    Actb     1.9850
## 81      8C 6.4         8    Actb    -1.2850
## 82      8C 6.5         8    Actb    -1.8600
## 83      8C 6.6         8    Actb    -1.3000
## 84      8C 6.7         8    Actb    -0.9050
## 85      8C 6.8         8    Actb     0.6950
## 86     16C 1.1        16    Actb     3.3550
## 87     16C 1.2        16    Actb    -1.6650
## 88     16C 1.3        16    Actb    -1.7150
## 89     16C 1.4        16    Actb    -0.2000
## 90     16C 1.5        16    Actb    -2.8500
## 91     16C 1.6        16    Actb    -2.8050
## 92     16C 1.7        16    Actb    -2.4550
## 93     16C 1.8        16    Actb    -3.5300
## 94     16C 1.9        16    Actb    -0.1000
## 95    16C 1.10        16    Actb    -1.0550
## 96    16C 1.11        16    Actb    -1.8400
## 97    16C 1.12        16    Actb    -0.2400
## 98    16C 1.13        16    Actb    -1.9650
## 99    16C 1.14        16    Actb    -1.9200
## 100   16C 1.15        16    Actb    -2.5700
## 101   16C 1.16        16    Actb    -2.2550
## 102    16C 2.1        16    Actb    -1.0700
## 103    16C 2.2        16    Actb    -1.3900
## 104    16C 2.3        16    Actb    -0.5500
## 105    16C 2.4        16    Actb    -1.4000
## 106    16C 2.5        16    Actb    -1.9300
## 107    16C 2.6        16    Actb    -2.2000
## 108    16C 2.7        16    Actb    -1.5550
## 109    16C 2.8        16    Actb    -2.7050
## 110    16C 2.9        16    Actb    -2.0400
## 111   16C 2.10        16    Actb    -2.9500
## 112   16C 2.11        16    Actb    -0.1300
## 113   16C 2.12        16    Actb     0.0650
## 114   16C 2.13        16    Actb    -0.9550
## 115   16C 2.14        16    Actb    -0.7850
## 116   16C 2.15        16    Actb     0.3950
## 117   16C 2.16        16    Actb    -2.3400
## 118    16C 3.1        16    Actb    -0.9250
## 119    16C 3.2        16    Actb    -1.3150
## 120    16C 3.3        16    Actb    -2.0800
## 121    16C 3.4        16    Actb     2.1000
## 122    16C 3.5        16    Actb     0.1250
## 123    16C 3.6        16    Actb    -0.2750
## 124    16C 3.7        16    Actb    -0.0950
## 125    16C 3.8        16    Actb     2.2650
## 126    16C 3.9        16    Actb    -0.7800
## 127   16C 3.10        16    Actb    -5.8350
## 128   16C 3.11        16    Actb     0.0700
## 129   16C 3.12        16    Actb    -1.6950
## 130   16C 3.13        16    Actb     0.5250
## 131   16C 3.14        16    Actb    -0.1700
## 132   16C 3.15        16    Actb     1.0300
## 133    16C 4.1        16    Actb     0.4700
## 134    16C 4.2        16    Actb    -0.7200
## 135    16C 4.3        16    Actb    -0.4050
## 136    16C 4.4        16    Actb    -2.3450
## 137    16C 4.5        16    Actb    -2.7300
## 138    16C 4.6        16    Actb    -1.7850
## 139    16C 4.7        16    Actb     0.8350
## 140    16C 4.8        16    Actb     0.9175
## 141    16C 4.9        16    Actb     1.2500
## 142   16C 4.10        16    Actb    -0.2750
## 143   16C 4.11        16    Actb    -0.9200
## 144   16C 4.12        16    Actb    -1.6600
## 145   16C 4.13        16    Actb    -2.7350
## 146   16C 4.14        16    Actb    -2.0500
## 147   16C 4.15        16    Actb     0.2350
## 148   16C 4.16        16    Actb    -0.6700
## 149    16C 5.1        16    Actb    -1.5075
## 150    16C 5.2        16    Actb     0.4250
## 151    16C 5.3        16    Actb    -1.9050
## 152    16C 5.4        16    Actb    -1.8950
## 153    16C 5.5        16    Actb    -3.9950
## 154    16C 5.6        16    Actb    -0.9800
## 155    16C 5.7        16    Actb    -3.2150
## 156    16C 5.8        16    Actb    -1.2950
## 157    16C 5.9        16    Actb    -0.0050
## 158   16C 5.10        16    Actb    -0.6550
## 159   16C 5.11        16    Actb    -1.2850
## 160   16C 5.12        16    Actb    -2.7700
## 161    32C 1.1        32    Actb    -4.4550
## 162    32C 1.2        32    Actb    -3.4700
## 163    32C 1.3        32    Actb    -3.7750
## 164    32C 1.4        32    Actb    -4.8850
## 165    32C 1.5        32    Actb    -0.9600
## 166    32C 1.6        32    Actb    -0.8850
## 167    32C 1.7        32    Actb    -2.1250
## 168    32C 1.8        32    Actb    -0.7650
## 169    32C 1.9        32    Actb    -2.2550
## 170   32C 1.10        32    Actb    -1.9700
## 171   32C 1.11        32    Actb    -4.7550
## 172   32C 1.12        32    Actb    -4.3750
## 173   32C 1.13        32    Actb    -3.7950
## 174   32C 1.14        32    Actb    -3.6200
## 175   32C 1.15        32    Actb    -1.1750
## 176   32C 1.16        32    Actb    -1.4000
## 177   32C 1.17        32    Actb    -0.1900
## 178   32C 1.18        32    Actb    -0.9650
## 179   32C 1.19        32    Actb    -0.5550
## 180   32C 1.20        32    Actb    -3.9800
## 181   32C 1.21        32    Actb    -2.9200
## 182    32C 2.1        32    Actb    -5.5650
## 183    32C 2.2        32    Actb    -1.4500
## 184    32C 2.3        32    Actb    -2.6850
## 185    32C 2.4        32    Actb    -3.0950
## 186    32C 2.5        32    Actb    -0.6650
## 187    32C 2.6        32    Actb    -0.2450
## 188    32C 2.7        32    Actb    -4.8250
## 189    32C 2.8        32    Actb    -3.4800
## 190    32C 2.9        32    Actb    -3.4500
## 191   32C 2.10        32    Actb    -4.3450
## 192   32C 2.11        32    Actb    -1.2150
## 193   32C 2.12        32    Actb    -0.0150
## 194   32C 2.13        32    Actb    -1.6650
## 195   32C 2.14        32    Actb    -2.1050
## 196   32C 2.15        32    Actb    -1.0500
## 197   32C 2.16        32    Actb    -3.6600
## 198    32C 3.1        32    Actb    -4.6350
## 199    32C 3.2        32    Actb    -3.4150
## 200    32C 3.3        32    Actb    -4.0500
## 201    32C 3.4        32    Actb    -1.9400
## 202    32C 3.5        32    Actb    -1.3550
## 203    32C 3.6        32    Actb    -2.7100
## 204    32C 3.7        32    Actb    -0.8300
## 205    32C 3.8        32    Actb    -2.3750
## 206    32C 4.1        32    Actb    -2.4400
## 207    32C 4.2        32    Actb    -3.1200
## 208    32C 4.3        32    Actb    -1.8850
## 209    32C 4.4        32    Actb    -2.7000
## 210    32C 4.5        32    Actb    -0.3500
## 211    32C 4.6        32    Actb    -0.5900
## 212    32C 4.7        32    Actb    -0.7500
## 213    32C 4.8        32    Actb    -2.9200
## 214   32C 4.10        32    Actb    -2.3000
## 215   32C 4.11        32    Actb    -2.9050
## 216   32C 4.12        32    Actb    -3.9450
## 217   32C 4.13        32    Actb    -3.1000
## 218   32C 4.14        32    Actb    -3.6100
## 219   32C 4.15        32    Actb    -0.9900
## 220   32C 4.16        32    Actb    -0.5150
## 221   32C 4.17        32    Actb    -1.4150
## 222   32C 4.18        32    Actb    -1.6050
## 223   32C 4.19        32    Actb    -0.9950
## 224   32C 4.20        32    Actb    -2.5700
## 225   32C 4.21        32    Actb    -2.2650
## 226   32C 4.22        32    Actb    -3.0750
## 227   32C 4.23        32    Actb    -3.5500
## 228   32C 4.24        32    Actb    -0.2600
## 229    32C 5.1        32    Actb    -3.9750
## 230    32C 5.2        32    Actb    -2.6450
## 231    32C 5.3        32    Actb    -1.0750
## 232    32C 5.4        32    Actb    -1.4350
## 233    32C 5.5        32    Actb    -3.2800
## 234    32C 5.6        32    Actb    -7.3150
## 235    32C 5.7        32    Actb    -3.1200
## 236    32C 5.8        32    Actb    -2.0450
## 237    32C 5.9        32    Actb    -0.5050
## 238   32C 5.10        32    Actb    -0.1000
## 239   32C 5.11        32    Actb    -0.4000
## 240   32C 5.12        32    Actb    -0.8800
## 241   32C 5.13        32    Actb    -2.8700
## 242   32C 5.14        32    Actb    -3.1850
## 243   32C 5.15        32    Actb    -4.5250
## 244   32C 5.16        32    Actb    -3.1200
## 245   32C 5.17        32    Actb    -2.5750
## 246   32C 5.18        32    Actb    -1.1350
## 247   32C 5.19        32    Actb     0.4175
## 248   32C 5.20        32    Actb     0.4500
## 249   32C 5.21        32    Actb    -1.8550
## 250   32C 5.22        32    Actb    -2.8500
## 251   32C 5.23        32    Actb    -3.4800
## 252    32C 6.1        32    Actb    -4.3800
## 253    32C 6.2        32    Actb    -4.7950
## 254    32C 6.3        32    Actb    -2.8550
## 255    32C 6.4        32    Actb    -0.7700
## 256    32C 6.6        32    Actb    -3.7975
## 257    32C 6.7        32    Actb    -0.1200
## 258    32C 7.1        32    Actb    -3.9800
## 259    32C 7.2        32    Actb    -1.3050
## 260    32C 7.3        32    Actb    -5.1400
## 261    32C 7.4        32    Actb    -3.0600
## 262    32C 7.5        32    Actb    -2.4900
## 263    32C 7.6        32    Actb    -1.2250
## 264    32C 7.8        32    Actb    -0.8550
## 265    32C 8.1        32    Actb    -1.2000
## 266    32C 8.2        32    Actb    -1.2500
## 267    32C 8.4        32    Actb    -3.3900
## 268    32C 8.5        32    Actb    -2.5500
## 269    32C 8.6        32    Actb    -4.4250
## 270    64C 1.1        64    Actb    -2.2750
## 271    64C 1.2        64    Actb    -4.6550
## 272    64C 1.3        64    Actb     0.4700
## 273    64C 1.4        64    Actb     0.1350
## 274    64C 1.5        64    Actb    -0.6450
## 275    64C 1.6        64    Actb     0.1550
## 276    64C 1.7        64    Actb    -1.3350
## 277    64C 1.8        64    Actb    -0.8300
## 278    64C 1.9        64    Actb    -3.2650
## 279   64C 1.10        64    Actb    -3.8250
## 280   64C 1.11        64    Actb    -2.9350
## 281   64C 1.12        64    Actb    -1.9000
## 282   64C 1.13        64    Actb     0.8950
## 283   64C 1.14        64    Actb    -1.3000
## 284   64C 1.15        64    Actb    -0.0400
## 285   64C 1.16        64    Actb    -1.9650
## 286   64C 1.17        64    Actb    -2.4350
## 287   64C 1.18        64    Actb    -5.4000
## 288   64C 1.19        64    Actb    -3.5100
## 289   64C 1.20        64    Actb    -3.2550
## 290   64C 1.21        64    Actb     0.5700
## 291   64C 1.22        64    Actb     1.3750
## 292   64C 1.23        64    Actb     0.5250
## 293   64C 1.24        64    Actb    -1.3350
## 294   64C 1.25        64    Actb    -1.2350
## 295   64C 1.26        64    Actb    -1.9450
## 296   64C 1.27        64    Actb    -5.4000
## 297   64C 1.28        64    Actb    -4.6100
## 298   64C 1.29        64    Actb    -3.5750
## 299   64C 1.30        64    Actb    -1.7050
## 300   64C 1.31        64    Actb    -1.0150
## 301   64C 1.32        64    Actb    -3.6550
## 302   64C 1.33        64    Actb    -3.2850
## 303   64C 1.34        64    Actb    -0.1600
## 304   64C 1.35        64    Actb    -5.1500
## 305   64C 1.36        64    Actb    -4.7850
## 306   64C 1.37        64    Actb    -3.5550
## 307   64C 1.38        64    Actb    -4.9600
## 308   64C 1.39        64    Actb    -1.2400
## 309   64C 1.40        64    Actb    -0.3150
## 310   64C 1.41        64    Actb    -1.1000
## 311   64C 1.42        64    Actb     0.0900
## 312   64C 1.43        64    Actb     0.1850
## 313   64C 1.44        64    Actb    -1.0100
## 314   64C 1.45        64    Actb    -2.8700
## 315   64C 1.46        64    Actb    -3.6550
## 316   64C 1.47        64    Actb    -4.8300
## 317   64C 1.48        64    Actb    -2.7600
## 318    64C 2.1        64    Actb    -2.4700
## 319    64C 2.2        64    Actb    -3.5300
## 320    64C 2.3        64    Actb    -3.2900
## 321    64C 2.4        64    Actb    -3.2900
## 322    64C 2.5        64    Actb    -2.5550
## 323    64C 2.6        64    Actb    -3.7450
## 324    64C 2.7        64    Actb    -1.6700
## 325    64C 2.8        64    Actb    -1.8600
## 326    64C 2.9        64    Actb    -2.9000
## 327   64C 2.10        64    Actb    -2.0350
## 328   64C 2.11        64    Actb    -2.3450
## 329   64C 2.12        64    Actb    -2.4150
## 330   64C 2.13        64    Actb    -1.0150
## 331   64C 2.14        64    Actb    -2.4600
## 332   64C 2.15        64    Actb    -4.2150
## 333   64C 2.16        64    Actb    -1.6550
## 334   64C 2.17        64    Actb     0.5200
## 335   64C 2.18        64    Actb    -3.5100
## 336   64C 2.19        64    Actb    -3.2450
## 337   64C 2.20        64    Actb    -1.9550
## 338   64C 2.21        64    Actb    -1.4250
## 339   64C 2.22        64    Actb    -1.4850
## 340   64C 2.23        64    Actb    -4.3300
## 341   64C 2.24        64    Actb    -7.2550
## 342   64C 2.25        64    Actb    -3.7800
## 343    64C 3.1        64    Actb    -3.9550
## 344    64C 3.2        64    Actb    -0.3450
## 345    64C 3.3        64    Actb    -1.5600
## 346    64C 3.4        64    Actb    -1.1600
## 347    64C 3.5        64    Actb    -1.2600
## 348    64C 3.6        64    Actb    -1.5000
## 349    64C 3.7        64    Actb    -2.8550
## 350    64C 3.8        64    Actb    -3.8750
## 351    64C 4.1        64    Actb    -1.3400
## 352   64C 4.1b        64    Actb    -0.2750
## 353    64C 4.2        64    Actb     2.0450
## 354    64C 4.3        64    Actb     2.1675
## 355    64C 4.4        64    Actb     0.8700
## 356    64C 4.5        64    Actb     1.3950
## 357    64C 4.6        64    Actb     1.0400
## 358    64C 4.7        64    Actb    -3.5500
## 359    64C 4.8        64    Actb    -0.9950
## 360    64C 4.9        64    Actb    -2.1900
## 361   64C 4.10        64    Actb     0.5850
## 362   64C 4.11        64    Actb     0.9700
## 363   64C 4.12        64    Actb    -1.7175
## 364   64C 4.13        64    Actb    -0.1350
## 365   64C 4.14        64    Actb    -2.9350
## 366   64C 4.15        64    Actb    -1.6550
## 367   64C 4.16        64    Actb    -4.7250
## 368   64C 4.17        64    Actb    -2.7900
## 369   64C 4.18        64    Actb    -4.7450
## 370   64C 4.19        64    Actb    -3.6750
## 371   64C 4.20        64    Actb    -0.9050
## 372   64C 4.21        64    Actb    -2.4350
## 373   64C 4.22        64    Actb    -2.6750
## 374   64C 4.23        64    Actb    -3.6400
## 375   64C 4.24        64    Actb    -3.8150
## 376   64C 4.25        64    Actb    -3.8700
## 377   64C 4.26        64    Actb    -2.4950
## 378   64C 4.27        64    Actb    -4.8550
## 379   64C 4.28        64    Actb    -0.8500
## 380   64C 4.29        64    Actb    -2.1650
## 381   64C 4.30        64    Actb    -1.2950
## 382   64C 4.31        64    Actb    -1.6750
## 383   64C 4.32        64    Actb    -1.0150
## 384   64C 4.33        64    Actb    -3.0700
## 385   64C 4.34        64    Actb    -5.7450
## 386   64C 4.35        64    Actb    -3.2350
## 387   64C 4.36        64    Actb    -6.4450
## 388   64C 4.37        64    Actb    -3.7700
## 389   64C 4.38        64    Actb    -2.4550
## 390   64C 4.39        64    Actb    -1.9500
## 391    64C 5.1        64    Actb    -0.7100
## 392    64C 5.2        64    Actb    -0.6450
## 393    64C 5.3        64    Actb    -1.4250
## 394    64C 5.4        64    Actb    -5.4800
## 395    64C 5.5        64    Actb    -2.3600
## 396    64C 5.6        64    Actb    -1.5250
## 397    64C 5.7        64    Actb     0.5100
## 398    64C 5.8        64    Actb     0.4150
## 399    64C 5.9        64    Actb    -0.7650
## 400   64C 5.10        64    Actb     0.1350
## 401   64C 5.11        64    Actb    -0.0850
## 402   64C 5.12        64    Actb    -4.1450
## 403   64C 5.13        64    Actb    -4.2100
## 404   64C 5.14        64    Actb    -2.6000
## 405   64C 5.15        64    Actb    -0.5550
## 406   64C 5.16        64    Actb     2.7350
## 407    64C 6.1        64    Actb     1.7850
## 408    64C 6.2        64    Actb    -0.8850
## 409    64C 6.3        64    Actb    -0.5250
## 410    64C 6.4        64    Actb     1.3700
## 411    64C 6.5        64    Actb    -0.3400
## 412    64C 6.6        64    Actb    -1.9950
## 413    64C 6.7        64    Actb    -1.8450
## 414    64C 6.8        64    Actb    -1.9000
## 415    64C 7.1        64    Actb     5.2100
## 416    64C 7.2        64    Actb    -0.1250
## 417    64C 7.3        64    Actb     0.7100
## 418    64C 7.4        64    Actb     1.1300
## 419    64C 7.5        64    Actb    -0.1050
## 420    64C 7.6        64    Actb    -0.1800
## 421    64C 7.7        64    Actb    -1.2600
## 422    64C 7.8        64    Actb     0.2950
## 423    64C 7.9        64    Actb    -1.7400
## 424   64C 7.10        64    Actb    -0.9000
## 425   64C 7.11        64    Actb    -1.1700
## 426   64C 7.12        64    Actb    -1.3000
## 427   64C 7.13        64    Actb    -1.7700
## 428   64C 7.14        64    Actb    -1.1000
## 429     2C 1.1         2    Ahcy    11.5150
## 430     2C 1.2         2    Ahcy     7.3550
## 431     2C 2.1         2    Ahcy     8.8200
## 432     2C 2.2         2    Ahcy     8.3000
## 433     2C 3.1         2    Ahcy     9.7150
## 434     2C 3.2         2    Ahcy    13.8250
## 435     2C 4.1         2    Ahcy    12.7650
## 436     2C 5.1         2    Ahcy    11.1000
## 437     2C 5.2         2    Ahcy    11.7650
## 438     2C 6.1         2    Ahcy     8.0050
## 439     2C 6.2         2    Ahcy     6.7300
## 440     2C 7.1         2    Ahcy     7.2000
## 441     2C 7.2         2    Ahcy    11.2450
## 442     2C 8.1         2    Ahcy    10.8650
## 443     2C 8.2         2    Ahcy     9.5300
## 444     2C 9.1         2    Ahcy    13.3900
## 445     2C 9.2         2    Ahcy    11.4500
## 446    2C 10.1         2    Ahcy    10.2900
## 447    2C 10.2         2    Ahcy     9.0850
## 448     4C 1.1         4    Ahcy     6.8650
## 449     4C 1.2         4    Ahcy    12.1450
## 450     4C 1.3         4    Ahcy     5.8950
## 451     4C 1.4         4    Ahcy    10.1350
## 452     4C 2.1         4    Ahcy     9.7350
## 453     4C 2.2         4    Ahcy    11.3200
## 454     4C 2.3         4    Ahcy     8.5250
## 455     4C 3.1         4    Ahcy     8.5300
## 456     4C 3.2         4    Ahcy     6.4100
## 457     4C 3.3         4    Ahcy     5.8450
## 458     4C 3.4         4    Ahcy     6.6000
## 459     4C 4.1         4    Ahcy     6.1700
## 460     4C 4.2         4    Ahcy    10.7100
## 461     4C 4.3         4    Ahcy    12.4250
## 462     4C 4.4         4    Ahcy     9.2900
## 463     4C 5.1         4    Ahcy     8.9600
## 464     4C 5.2         4    Ahcy     7.2400
## 465     4C 5.3         4    Ahcy     6.6550
## 466     4C 5.4         4    Ahcy     4.9350
## 467     4C 6.1         4    Ahcy     7.6900
## 468     4C 6.2         4    Ahcy     7.8600
## 469     4C 6.3         4    Ahcy     8.9250
## 470     4C 6.4         4    Ahcy    13.6125
## 471     8C 1.1         8    Ahcy    10.4100
## 472     8C 1.2         8    Ahcy     5.0300
## 473     8C 1.3         8    Ahcy     5.3250
## 474     8C 1.4         8    Ahcy     3.8850
## 475     8C 1.5         8    Ahcy     6.2450
## 476     8C 2.1         8    Ahcy     5.4800
## 477     8C 2.2         8    Ahcy    10.8600
## 478     8C 2.3         8    Ahcy     8.8650
## 479     8C 2.4         8    Ahcy     8.5500
## 480     8C 2.5         8    Ahcy     9.6700
## 481     8C 2.6         8    Ahcy     9.5750
## 482     8C 2.7         8    Ahcy     5.2750
## 483     8C 2.8         8    Ahcy     8.6450
## 484     8C 3.1         8    Ahcy     7.7050
## 485     8C 3.2         8    Ahcy     9.4300
## 486     8C 3.3         8    Ahcy     9.9700
## 487     8C 3.4         8    Ahcy     7.0700
## 488     8C 3.5         8    Ahcy     7.0500
## 489     8C 3.6         8    Ahcy     7.8800
## 490     8C 3.7         8    Ahcy     5.6250
## 491     8C 3.8         8    Ahcy     6.1400
## 492     8C 4.2         8    Ahcy     9.5050
## 493     8C 4.3         8    Ahcy     4.8850
## 494     8C 4.4         8    Ahcy     4.6900
## 495     8C 4.5         8    Ahcy    10.6750
## 496     8C 4.6         8    Ahcy     7.3000
## 497     8C 4.7         8    Ahcy     5.6800
## 498     8C 5.1         8    Ahcy     8.9700
## 499     8C 5.2         8    Ahcy     6.4750
## 500     8C 5.3         8    Ahcy     6.2200
## 501     8C 5.4         8    Ahcy     3.5100
## 502     8C 5.5         8    Ahcy     5.3550
## 503     8C 5.6         8    Ahcy     4.8650
## 504     8C 5.7         8    Ahcy     7.4700
## 505     8C 5.8         8    Ahcy     9.3350
## 506     8C 6.1         8    Ahcy     7.4000
## 507     8C 6.2         8    Ahcy     7.8650
## 508     8C 6.3         8    Ahcy     7.6100
## 509     8C 6.4         8    Ahcy     8.3450
## 510     8C 6.5         8    Ahcy     4.6750
## 511     8C 6.6         8    Ahcy     5.4550
## 512     8C 6.7         8    Ahcy     5.5850
## 513     8C 6.8         8    Ahcy     9.4850
## 514    16C 1.1        16    Ahcy    11.0350
## 515    16C 1.2        16    Ahcy     7.5350
## 516    16C 1.3        16    Ahcy     8.6000
## 517    16C 1.4        16    Ahcy     6.0050
## 518    16C 1.5        16    Ahcy     6.8250
## 519    16C 1.6        16    Ahcy     6.0350
## 520    16C 1.7        16    Ahcy     5.4000
## 521    16C 1.8        16    Ahcy     5.7950
## 522    16C 1.9        16    Ahcy     5.6100
## 523   16C 1.10        16    Ahcy     5.6500
## 524   16C 1.11        16    Ahcy     4.4500
## 525   16C 1.12        16    Ahcy     7.1600
## 526   16C 1.13        16    Ahcy     6.6900
## 527   16C 1.14        16    Ahcy     5.7750
## 528   16C 1.15        16    Ahcy     5.5350
## 529   16C 1.16        16    Ahcy     5.8050
## 530    16C 2.1        16    Ahcy     6.1150
## 531    16C 2.2        16    Ahcy     6.4100
## 532    16C 2.3        16    Ahcy     6.4050
## 533    16C 2.4        16    Ahcy     7.6350
## 534    16C 2.5        16    Ahcy     2.6800
## 535    16C 2.6        16    Ahcy     5.5400
## 536    16C 2.7        16    Ahcy     5.0550
## 537    16C 2.8        16    Ahcy     4.6550
## 538    16C 2.9        16    Ahcy     5.9000
## 539   16C 2.10        16    Ahcy     4.9200
## 540   16C 2.11        16    Ahcy     6.2950
## 541   16C 2.12        16    Ahcy     6.8050
## 542   16C 2.13        16    Ahcy     6.4050
## 543   16C 2.14        16    Ahcy     5.9900
## 544   16C 2.15        16    Ahcy     7.0850
## 545   16C 2.16        16    Ahcy     5.0050
## 546    16C 3.1        16    Ahcy     3.9400
## 547    16C 3.2        16    Ahcy     5.0800
## 548    16C 3.3        16    Ahcy     4.6450
## 549    16C 3.4        16    Ahcy     8.7550
## 550    16C 3.5        16    Ahcy     8.3300
## 551    16C 3.6        16    Ahcy     6.0700
## 552    16C 3.7        16    Ahcy     8.0800
## 553    16C 3.8        16    Ahcy     9.2500
## 554    16C 3.9        16    Ahcy     6.6850
## 555   16C 3.10        16    Ahcy     3.8550
## 556   16C 3.11        16    Ahcy     6.0850
## 557   16C 3.12        16    Ahcy     4.4050
## 558   16C 3.13        16    Ahcy     7.7950
## 559   16C 3.14        16    Ahcy     8.4650
## 560   16C 3.15        16    Ahcy     7.2200
## 561    16C 4.1        16    Ahcy     6.7650
## 562    16C 4.2        16    Ahcy     5.1700
## 563    16C 4.3        16    Ahcy     4.8400
## 564    16C 4.4        16    Ahcy     4.6450
## 565    16C 4.5        16    Ahcy     4.4800
## 566    16C 4.6        16    Ahcy     3.8600
## 567    16C 4.7        16    Ahcy     7.9200
## 568    16C 4.8        16    Ahcy     7.7350
## 569    16C 4.9        16    Ahcy     6.2000
## 570   16C 4.10        16    Ahcy     5.4100
## 571   16C 4.11        16    Ahcy     4.7700
## 572   16C 4.12        16    Ahcy     2.8150
## 573   16C 4.13        16    Ahcy     3.3350
## 574   16C 4.14        16    Ahcy     5.7600
## 575   16C 4.15        16    Ahcy     5.5500
## 576   16C 4.16        16    Ahcy     6.2950
## 577    16C 5.1        16    Ahcy     8.3825
## 578    16C 5.2        16    Ahcy     5.7800
## 579    16C 5.3        16    Ahcy     5.4300
## 580    16C 5.4        16    Ahcy     4.2950
## 581    16C 5.5        16    Ahcy     2.4750
## 582    16C 5.6        16    Ahcy     4.1350
## 583    16C 5.7        16    Ahcy     2.7900
## 584    16C 5.8        16    Ahcy     6.5800
## 585    16C 5.9        16    Ahcy     6.0750
## 586   16C 5.10        16    Ahcy     5.3600
## 587   16C 5.11        16    Ahcy     4.7100
## 588   16C 5.12        16    Ahcy     5.6450
## 589    32C 1.1        32    Ahcy     2.6650
## 590    32C 1.2        32    Ahcy     0.6150
## 591    32C 1.3        32    Ahcy     6.1750
## 592    32C 1.4        32    Ahcy     4.1300
## 593    32C 1.5        32    Ahcy     4.8500
## 594    32C 1.6        32    Ahcy     5.4500
## 595    32C 1.7        32    Ahcy     6.4300
## 596    32C 1.8        32    Ahcy     4.3200
## 597    32C 1.9        32    Ahcy     2.5550
## 598   32C 1.10        32    Ahcy     4.0500
## 599   32C 1.11        32    Ahcy     2.7850
## 600   32C 1.12        32    Ahcy     4.7850
## 601   32C 1.13        32    Ahcy     1.6300
## 602   32C 1.14        32    Ahcy     7.5250
## 603   32C 1.15        32    Ahcy     4.7000
## 604   32C 1.16        32    Ahcy     4.8500
## 605   32C 1.17        32    Ahcy     6.1800
## 606   32C 1.18        32    Ahcy     4.4450
## 607   32C 1.19        32    Ahcy     4.0400
## 608   32C 1.20        32    Ahcy     1.0000
## 609   32C 1.21        32    Ahcy     2.3650
## 610    32C 2.1        32    Ahcy     3.1050
## 611    32C 2.2        32    Ahcy     6.0300
## 612    32C 2.3        32    Ahcy     6.4450
## 613    32C 2.4        32    Ahcy     3.9000
## 614    32C 2.5        32    Ahcy     5.1850
## 615    32C 2.6        32    Ahcy     7.2800
## 616    32C 2.7        32    Ahcy     3.4550
## 617    32C 2.8        32    Ahcy     2.1050
## 618    32C 2.9        32    Ahcy     2.1750
## 619   32C 2.10        32    Ahcy     3.8350
## 620   32C 2.11        32    Ahcy     7.0750
## 621   32C 2.12        32    Ahcy     7.1550
## 622   32C 2.13        32    Ahcy     4.8350
## 623   32C 2.14        32    Ahcy     5.8700
## 624   32C 2.15        32    Ahcy     4.1550
## 625   32C 2.16        32    Ahcy     4.6050
## 626    32C 3.1        32    Ahcy     4.2150
## 627    32C 3.2        32    Ahcy     6.9800
## 628    32C 3.3        32    Ahcy     5.8150
## 629    32C 3.4        32    Ahcy     6.1400
## 630    32C 3.5        32    Ahcy     8.9700
## 631    32C 3.6        32    Ahcy     3.5600
## 632    32C 3.7        32    Ahcy     6.2900
## 633    32C 3.8        32    Ahcy     5.0400
## 634    32C 4.1        32    Ahcy     5.1950
## 635    32C 4.2        32    Ahcy     4.7050
## 636    32C 4.3        32    Ahcy     3.2550
## 637    32C 4.4        32    Ahcy     2.6650
## 638    32C 4.5        32    Ahcy     6.3100
## 639    32C 4.6        32    Ahcy     3.9750
## 640    32C 4.7        32    Ahcy     6.6750
## 641    32C 4.8        32    Ahcy     3.1500
## 642   32C 4.10        32    Ahcy     5.8100
## 643   32C 4.11        32    Ahcy     3.2350
## 644   32C 4.12        32    Ahcy     4.3650
## 645   32C 4.13        32    Ahcy     6.1700
## 646   32C 4.14        32    Ahcy     3.0200
## 647   32C 4.15        32    Ahcy     4.6550
## 648   32C 4.16        32    Ahcy     5.7650
## 649   32C 4.17        32    Ahcy     7.2750
## 650   32C 4.18        32    Ahcy     5.9500
## 651   32C 4.19        32    Ahcy     6.3150
## 652   32C 4.20        32    Ahcy     3.2850
## 653   32C 4.21        32    Ahcy     2.8200
## 654   32C 4.22        32    Ahcy     1.7600
## 655   32C 4.23        32    Ahcy     4.2650
## 656   32C 4.24        32    Ahcy     6.4750
## 657    32C 5.1        32    Ahcy     6.0800
## 658    32C 5.2        32    Ahcy     5.9700
## 659    32C 5.3        32    Ahcy     6.3400
## 660    32C 5.4        32    Ahcy     5.8800
## 661    32C 5.5        32    Ahcy     6.1950
## 662    32C 5.6        32    Ahcy     4.0550
## 663    32C 5.7        32    Ahcy     5.8050
## 664    32C 5.8        32    Ahcy     2.7050
## 665    32C 5.9        32    Ahcy     6.4050
## 666   32C 5.10        32    Ahcy     7.5950
## 667   32C 5.11        32    Ahcy     8.2100
## 668   32C 5.12        32    Ahcy     5.6950
## 669   32C 5.13        32    Ahcy     5.4600
## 670   32C 5.14        32    Ahcy     4.2700
## 671   32C 5.15        32    Ahcy     4.1550
## 672   32C 5.16        32    Ahcy     5.9200
## 673   32C 5.17        32    Ahcy     6.0600
## 674   32C 5.18        32    Ahcy     7.6800
## 675   32C 5.19        32    Ahcy     5.4050
## 676   32C 5.20        32    Ahcy     8.6400
## 677   32C 5.21        32    Ahcy     7.1100
## 678   32C 5.22        32    Ahcy     6.1200
## 679   32C 5.23        32    Ahcy     3.8550
## 680    32C 6.1        32    Ahcy     0.9800
## 681    32C 6.2        32    Ahcy     4.4750
## 682    32C 6.3        32    Ahcy     5.9650
## 683    32C 6.4        32    Ahcy     5.5300
## 684    32C 6.6        32    Ahcy     6.6375
## 685    32C 6.7        32    Ahcy     8.0050
## 686    32C 7.1        32    Ahcy     5.9650
## 687    32C 7.2        32    Ahcy     5.4250
## 688    32C 7.3        32    Ahcy     5.7250
## 689    32C 7.4        32    Ahcy     5.3000
## 690    32C 7.5        32    Ahcy     3.4800
## 691    32C 7.6        32    Ahcy     5.6450
## 692    32C 7.8        32    Ahcy     6.9650
## 693    32C 8.1        32    Ahcy     5.9600
## 694    32C 8.2        32    Ahcy     8.9650
## 695    32C 8.4        32    Ahcy     7.0250
## 696    32C 8.5        32    Ahcy     1.7250
## 697    32C 8.6        32    Ahcy     4.8250
## 698    64C 1.1        64    Ahcy     5.8650
## 699    64C 1.2        64    Ahcy     6.6900
## 700    64C 1.3        64    Ahcy     5.2900
## 701    64C 1.4        64    Ahcy     6.4500
## 702    64C 1.5        64    Ahcy     5.1700
## 703    64C 1.6        64    Ahcy     5.6600
## 704    64C 1.7        64    Ahcy     5.0550
## 705    64C 1.8        64    Ahcy     7.7400
## 706    64C 1.9        64    Ahcy     2.5450
## 707   64C 1.10        64    Ahcy     6.9550
## 708   64C 1.11        64    Ahcy     2.8700
## 709   64C 1.12        64    Ahcy     9.8850
## 710   64C 1.13        64    Ahcy     6.6800
## 711   64C 1.14        64    Ahcy     8.5800
## 712   64C 1.15        64    Ahcy     8.7900
## 713   64C 1.16        64    Ahcy     9.7850
## 714   64C 1.17        64    Ahcy     8.1400
## 715   64C 1.18        64    Ahcy     4.8800
## 716   64C 1.19        64    Ahcy     6.1350
## 717   64C 1.20        64    Ahcy     5.4450
## 718   64C 1.21        64    Ahcy     6.1500
## 719   64C 1.22        64    Ahcy     7.0150
## 720   64C 1.23        64    Ahcy     5.0200
## 721   64C 1.24        64    Ahcy     9.4550
## 722   64C 1.25        64    Ahcy    10.8900
## 723   64C 1.26        64    Ahcy     5.2750
## 724   64C 1.27        64    Ahcy     5.6450
## 725   64C 1.28        64    Ahcy     5.7450
## 726   64C 1.29        64    Ahcy     5.6050
## 727   64C 1.30        64    Ahcy    10.4950
## 728   64C 1.31        64    Ahcy     8.2950
## 729   64C 1.32        64    Ahcy     9.9650
## 730   64C 1.33        64    Ahcy    11.3200
## 731   64C 1.34        64    Ahcy    11.8350
## 732   64C 1.35        64    Ahcy     7.1150
## 733   64C 1.36        64    Ahcy     6.7950
## 734   64C 1.37        64    Ahcy     6.5200
## 735   64C 1.38        64    Ahcy     7.5950
## 736   64C 1.39        64    Ahcy     7.9400
## 737   64C 1.40        64    Ahcy     5.3400
## 738   64C 1.41        64    Ahcy     4.8300
## 739   64C 1.42        64    Ahcy     6.7200
## 740   64C 1.43        64    Ahcy     7.4500
## 741   64C 1.44        64    Ahcy     7.2650
## 742   64C 1.45        64    Ahcy     4.6750
## 743   64C 1.46        64    Ahcy     9.3250
## 744   64C 1.47        64    Ahcy     6.7050
## 745   64C 1.48        64    Ahcy     8.3400
## 746    64C 2.1        64    Ahcy     8.6950
## 747    64C 2.2        64    Ahcy     8.3350
## 748    64C 2.3        64    Ahcy     3.8100
## 749    64C 2.4        64    Ahcy     8.0700
## 750    64C 2.5        64    Ahcy     3.6150
## 751    64C 2.6        64    Ahcy     7.1550
## 752    64C 2.7        64    Ahcy     5.0800
## 753    64C 2.8        64    Ahcy     4.0600
## 754    64C 2.9        64    Ahcy     6.5950
## 755   64C 2.10        64    Ahcy     8.6850
## 756   64C 2.11        64    Ahcy     6.8450
## 757   64C 2.12        64    Ahcy     7.2200
## 758   64C 2.13        64    Ahcy     7.2450
## 759   64C 2.14        64    Ahcy     4.5650
## 760   64C 2.15        64    Ahcy     4.3100
## 761   64C 2.16        64    Ahcy     3.1800
## 762   64C 2.17        64    Ahcy     6.9850
## 763   64C 2.18        64    Ahcy     8.1150
## 764   64C 2.19        64    Ahcy     9.6300
## 765   64C 2.20        64    Ahcy     9.3500
## 766   64C 2.21        64    Ahcy    10.0800
## 767   64C 2.22        64    Ahcy     9.3500
## 768   64C 2.23        64    Ahcy     9.2750
## 769   64C 2.24        64    Ahcy     6.9150
## 770   64C 2.25        64    Ahcy     5.8750
## 771    64C 3.1        64    Ahcy     3.0150
## 772    64C 3.2        64    Ahcy     9.9450
## 773    64C 3.3        64    Ahcy     7.5850
## 774    64C 3.4        64    Ahcy     9.3400
## 775    64C 3.5        64    Ahcy     6.0150
## 776    64C 3.6        64    Ahcy     7.8700
## 777    64C 3.7        64    Ahcy     5.2400
## 778    64C 3.8        64    Ahcy     5.1950
## 779    64C 4.1        64    Ahcy     5.2800
## 780   64C 4.1b        64    Ahcy     3.9800
## 781    64C 4.2        64    Ahcy     6.5700
## 782    64C 4.3        64    Ahcy     6.7350
## 783    64C 4.4        64    Ahcy     6.9200
## 784    64C 4.5        64    Ahcy     7.1600
## 785    64C 4.6        64    Ahcy     6.5400
## 786    64C 4.7        64    Ahcy     4.7650
## 787    64C 4.8        64    Ahcy     1.5550
## 788    64C 4.9        64    Ahcy     6.6000
## 789   64C 4.10        64    Ahcy     5.2700
## 790   64C 4.11        64    Ahcy     6.2150
## 791   64C 4.12        64    Ahcy     8.9425
## 792   64C 4.13        64    Ahcy    10.4600
## 793   64C 4.14        64    Ahcy     6.7500
## 794   64C 4.15        64    Ahcy     7.4450
## 795   64C 4.16        64    Ahcy     9.9550
## 796   64C 4.17        64    Ahcy     8.2750
## 797   64C 4.18        64    Ahcy     3.7400
## 798   64C 4.19        64    Ahcy     7.8300
## 799   64C 4.20        64    Ahcy     8.6750
## 800   64C 4.21        64    Ahcy     6.4800
## 801   64C 4.22        64    Ahcy     6.9200
## 802   64C 4.23        64    Ahcy     7.8150
## 803   64C 4.24        64    Ahcy     4.0350
## 804   64C 4.25        64    Ahcy     4.5450
## 805   64C 4.26        64    Ahcy     5.6050
## 806   64C 4.27        64    Ahcy     4.5600
## 807   64C 4.28        64    Ahcy     6.2900
## 808   64C 4.29        64    Ahcy     8.1100
## 809   64C 4.30        64    Ahcy     5.4700
## 810   64C 4.31        64    Ahcy    10.6500
## 811   64C 4.32        64    Ahcy     3.5050
## 812   64C 4.33        64    Ahcy     5.7200
## 813   64C 4.34        64    Ahcy     4.0850
## 814   64C 4.35        64    Ahcy     3.3750
## 815   64C 4.36        64    Ahcy     3.8000
## 816   64C 4.37        64    Ahcy     8.5350
## 817   64C 4.38        64    Ahcy     7.3500
## 818   64C 4.39        64    Ahcy     9.6300
## 819    64C 5.1        64    Ahcy     8.6500
## 820    64C 5.2        64    Ahcy     5.7050
## 821    64C 5.3        64    Ahcy     3.5000
## 822    64C 5.4        64    Ahcy     3.1100
## 823    64C 5.5        64    Ahcy     4.7550
## 824    64C 5.6        64    Ahcy     4.1150
## 825    64C 5.7        64    Ahcy     6.1100
## 826    64C 5.8        64    Ahcy     7.2950
## 827    64C 5.9        64    Ahcy     4.9700
## 828   64C 5.10        64    Ahcy     5.7550
## 829   64C 5.11        64    Ahcy    11.1300
## 830   64C 5.12        64    Ahcy     8.7250
## 831   64C 5.13        64    Ahcy     7.0050
## 832   64C 5.14        64    Ahcy     7.5750
## 833   64C 5.15        64    Ahcy    11.5850
## 834   64C 5.16        64    Ahcy    12.9750
## 835    64C 6.1        64    Ahcy     7.2050
## 836    64C 6.2        64    Ahcy     5.0350
## 837    64C 6.3        64    Ahcy     7.2900
## 838    64C 6.4        64    Ahcy     6.3250
## 839    64C 6.5        64    Ahcy     5.6050
## 840    64C 6.6        64    Ahcy     5.8250
## 841    64C 6.7        64    Ahcy     5.2200
## 842    64C 6.8        64    Ahcy     5.7850
## 843    64C 7.1        64    Ahcy    10.6500
## 844    64C 7.2        64    Ahcy     6.5600
## 845    64C 7.3        64    Ahcy     4.8800
## 846    64C 7.4        64    Ahcy     6.6500
## 847    64C 7.5        64    Ahcy     7.9500
## 848    64C 7.6        64    Ahcy     6.5050
## 849    64C 7.7        64    Ahcy     5.1150
## 850    64C 7.8        64    Ahcy     6.5150
## 851    64C 7.9        64    Ahcy     5.2850
## 852   64C 7.10        64    Ahcy     9.4600
## 853   64C 7.11        64    Ahcy     7.9650
## 854   64C 7.12        64    Ahcy     8.1650
## 855   64C 7.13        64    Ahcy     7.2200
## 856   64C 7.14        64    Ahcy    11.3200
## 857     2C 1.1         2    Aqp3     7.1950
## 858     2C 1.2         2    Aqp3     9.5250
## 859     2C 2.1         2    Aqp3     5.3100
## 860     2C 2.2         2    Aqp3     4.4600
## 861     2C 3.1         2    Aqp3    14.0950
## 862     2C 3.2         2    Aqp3    14.0350
## 863     2C 4.1         2    Aqp3     6.7700
## 864     2C 5.1         2    Aqp3    13.7500
## 865     2C 5.2         2    Aqp3    14.7950
## 866     2C 6.1         2    Aqp3     7.8600
## 867     2C 6.2         2    Aqp3     6.5200
## 868     2C 7.1         2    Aqp3     7.6450
## 869     2C 7.2         2    Aqp3     6.4200
## 870     2C 8.1         2    Aqp3    10.0950
## 871     2C 8.2         2    Aqp3    13.7550
## 872     2C 9.1         2    Aqp3     8.6150
## 873     2C 9.2         2    Aqp3    10.2850
## 874    2C 10.1         2    Aqp3    12.9500
## 875    2C 10.2         2    Aqp3    12.4350
## 876     4C 1.1         4    Aqp3     7.1550
## 877     4C 1.2         4    Aqp3     9.6000
## 878     4C 1.3         4    Aqp3     4.7350
## 879     4C 1.4         4    Aqp3     6.8750
## 880     4C 2.1         4    Aqp3     6.5400
## 881     4C 2.2         4    Aqp3     9.0700
## 882     4C 2.3         4    Aqp3     6.6750
## 883     4C 3.1         4    Aqp3     4.7150
## 884     4C 3.2         4    Aqp3     4.7000
## 885     4C 3.3         4    Aqp3     4.1000
## 886     4C 3.4         4    Aqp3     5.0700
## 887     4C 4.1         4    Aqp3     5.5900
## 888     4C 4.2         4    Aqp3     6.3000
## 889     4C 4.3         4    Aqp3     4.3675
## 890     4C 4.4         4    Aqp3     3.8150
## 891     4C 5.1         4    Aqp3     5.8100
## 892     4C 5.2         4    Aqp3    12.1200
## 893     4C 5.3         4    Aqp3     5.7550
## 894     4C 5.4         4    Aqp3     5.7750
## 895     4C 6.1         4    Aqp3     6.6250
## 896     4C 6.2         4    Aqp3     5.6450
## 897     4C 6.3         4    Aqp3     7.5050
## 898     4C 6.4         4    Aqp3     5.7275
## 899     8C 1.1         8    Aqp3     7.9250
## 900     8C 1.2         8    Aqp3     3.0300
## 901     8C 1.3         8    Aqp3     4.4400
## 902     8C 1.4         8    Aqp3     2.6550
## 903     8C 1.5         8    Aqp3     3.3300
## 904     8C 2.1         8    Aqp3     1.9050
## 905     8C 2.2         8    Aqp3     4.4150
## 906     8C 2.3         8    Aqp3     6.5700
## 907     8C 2.4         8    Aqp3     7.9725
## 908     8C 2.5         8    Aqp3     5.0950
## 909     8C 2.6         8    Aqp3     2.6550
## 910     8C 2.7         8    Aqp3     4.5000
## 911     8C 2.8         8    Aqp3     2.9250
## 912     8C 3.1         8    Aqp3     6.9650
## 913     8C 3.2         8    Aqp3    11.6550
## 914     8C 3.3         8    Aqp3     6.0850
## 915     8C 3.4         8    Aqp3     6.3550
## 916     8C 3.5         8    Aqp3     3.4700
## 917     8C 3.6         8    Aqp3     5.3850
## 918     8C 3.7         8    Aqp3     4.7750
## 919     8C 3.8         8    Aqp3     3.1200
## 920     8C 4.2         8    Aqp3     4.5350
## 921     8C 4.3         8    Aqp3     4.6700
## 922     8C 4.4         8    Aqp3     6.3350
## 923     8C 4.5         8    Aqp3     8.4650
## 924     8C 4.6         8    Aqp3     6.2250
## 925     8C 4.7         8    Aqp3     6.6400
## 926     8C 5.1         8    Aqp3     4.8600
## 927     8C 5.2         8    Aqp3     3.9150
## 928     8C 5.3         8    Aqp3    -0.5150
## 929     8C 5.4         8    Aqp3     0.1650
## 930     8C 5.5         8    Aqp3     1.2250
## 931     8C 5.6         8    Aqp3     1.1300
## 932     8C 5.7         8    Aqp3     2.6950
## 933     8C 5.8         8    Aqp3     4.2650
## 934     8C 6.1         8    Aqp3     3.8600
## 935     8C 6.2         8    Aqp3     4.4350
## 936     8C 6.3         8    Aqp3     8.1400
## 937     8C 6.4         8    Aqp3     3.0400
## 938     8C 6.5         8    Aqp3     3.2600
## 939     8C 6.6         8    Aqp3     2.5750
## 940     8C 6.7         8    Aqp3     1.4800
## 941     8C 6.8         8    Aqp3     5.1000
## 942    16C 1.1        16    Aqp3     5.5950
## 943    16C 1.2        16    Aqp3     2.1450
## 944    16C 1.3        16    Aqp3     4.8100
## 945    16C 1.4        16    Aqp3     2.9150
## 946    16C 1.5        16    Aqp3     1.4600
## 947    16C 1.6        16    Aqp3     2.0400
## 948    16C 1.7        16    Aqp3     1.2950
## 949    16C 1.8        16    Aqp3     1.7900
## 950    16C 1.9        16    Aqp3     3.2050
## 951   16C 1.10        16    Aqp3     2.2800
## 952   16C 1.11        16    Aqp3     3.3100
## 953   16C 1.12        16    Aqp3     3.8400
## 954   16C 1.13        16    Aqp3     2.4500
## 955   16C 1.14        16    Aqp3     1.5900
## 956   16C 1.15        16    Aqp3     0.6150
## 957   16C 1.16        16    Aqp3     2.3300
## 958    16C 2.1        16    Aqp3     3.4050
## 959    16C 2.2        16    Aqp3     5.6750
## 960    16C 2.3        16    Aqp3     3.8150
## 961    16C 2.4        16    Aqp3     4.6950
## 962    16C 2.5        16    Aqp3     4.7300
## 963    16C 2.6        16    Aqp3     1.3550
## 964    16C 2.7        16    Aqp3     5.4150
## 965    16C 2.8        16    Aqp3    -0.6150
## 966    16C 2.9        16    Aqp3     5.2800
## 967   16C 2.10        16    Aqp3     1.1400
## 968   16C 2.11        16    Aqp3     3.7250
## 969   16C 2.12        16    Aqp3     4.4050
## 970   16C 2.13        16    Aqp3     2.5000
## 971   16C 2.14        16    Aqp3     3.7500
## 972   16C 2.15        16    Aqp3     5.2450
## 973   16C 2.16        16    Aqp3     1.8700
## 974    16C 3.1        16    Aqp3     3.2700
## 975    16C 3.2        16    Aqp3     4.7850
## 976    16C 3.3        16    Aqp3     2.1300
## 977    16C 3.4        16    Aqp3     6.0950
## 978    16C 3.5        16    Aqp3     4.9450
## 979    16C 3.6        16    Aqp3     2.5950
## 980    16C 3.7        16    Aqp3     4.9050
## 981    16C 3.8        16    Aqp3     2.9200
## 982    16C 3.9        16    Aqp3     5.0950
## 983   16C 3.10        16    Aqp3     2.4550
## 984   16C 3.11        16    Aqp3     6.2800
## 985   16C 3.12        16    Aqp3     3.1150
## 986   16C 3.13        16    Aqp3     5.4450
## 987   16C 3.14        16    Aqp3     3.5700
## 988   16C 3.15        16    Aqp3     6.6300
## 989    16C 4.1        16    Aqp3     4.1550
## 990    16C 4.2        16    Aqp3     1.9650
## 991    16C 4.3        16    Aqp3     2.2500
## 992    16C 4.4        16    Aqp3     2.0000
## 993    16C 4.5        16    Aqp3     1.4300
## 994    16C 4.6        16    Aqp3     2.7800
## 995    16C 4.7        16    Aqp3     3.9400
## 996    16C 4.8        16    Aqp3     1.8075
## 997    16C 4.9        16    Aqp3     3.6750
## 998   16C 4.10        16    Aqp3     3.2200
## 999   16C 4.11        16    Aqp3     2.5500
## 1000  16C 4.12        16    Aqp3     1.0450
## 1001  16C 4.13        16    Aqp3     0.0650
## 1002  16C 4.14        16    Aqp3     2.6950
## 1003  16C 4.15        16    Aqp3     3.7050
## 1004  16C 4.16        16    Aqp3     4.2150
## 1005   16C 5.1        16    Aqp3     0.6875
## 1006   16C 5.2        16    Aqp3     4.1950
## 1007   16C 5.3        16    Aqp3     3.2800
## 1008   16C 5.4        16    Aqp3     1.7700
## 1009   16C 5.5        16    Aqp3    -0.4550
## 1010   16C 5.6        16    Aqp3     2.9100
## 1011   16C 5.7        16    Aqp3    -0.1050
## 1012   16C 5.8        16    Aqp3     3.9250
## 1013   16C 5.9        16    Aqp3     2.1400
## 1014  16C 5.10        16    Aqp3     3.0125
## 1015  16C 5.11        16    Aqp3     2.8750
## 1016  16C 5.12        16    Aqp3     1.6950
## 1017   32C 1.1        32    Aqp3     4.0500
## 1018   32C 1.2        32    Aqp3    10.4750
## 1019   32C 1.3        32    Aqp3     4.3250
## 1020   32C 1.4        32    Aqp3     3.0250
## 1021   32C 1.5        32    Aqp3     6.6250
## 1022   32C 1.6        32    Aqp3     6.8550
## 1023   32C 1.7        32    Aqp3     4.5200
## 1024   32C 1.8        32    Aqp3    10.2750
## 1025   32C 1.9        32    Aqp3     6.5150
## 1026  32C 1.10        32    Aqp3     8.1500
## 1027  32C 1.11        32    Aqp3     1.0450
## 1028  32C 1.12        32    Aqp3     2.9300
## 1029  32C 1.13        32    Aqp3     3.9750
## 1030  32C 1.14        32    Aqp3     4.9650
## 1031  32C 1.15        32    Aqp3     7.0650
## 1032  32C 1.16        32    Aqp3     4.6900
## 1033  32C 1.17        32    Aqp3    11.5000
## 1034  32C 1.18        32    Aqp3     6.7250
## 1035  32C 1.19        32    Aqp3     3.2050
## 1036  32C 1.20        32    Aqp3     6.0550
## 1037  32C 1.21        32    Aqp3     6.1950
## 1038   32C 2.1        32    Aqp3     0.2800
## 1039   32C 2.2        32    Aqp3     3.6850
## 1040   32C 2.3        32    Aqp3     4.8050
## 1041   32C 2.4        32    Aqp3     2.3800
## 1042   32C 2.5        32    Aqp3     7.1750
## 1043   32C 2.6        32    Aqp3     8.7600
## 1044   32C 2.7        32    Aqp3     2.7900
## 1045   32C 2.8        32    Aqp3     4.6500
## 1046   32C 2.9        32    Aqp3     2.7950
## 1047  32C 2.10        32    Aqp3     0.1300
## 1048  32C 2.11        32    Aqp3     8.3900
## 1049  32C 2.12        32    Aqp3     4.3850
## 1050  32C 2.13        32    Aqp3     5.6150
## 1051  32C 2.14        32    Aqp3     6.5900
## 1052  32C 2.15        32    Aqp3     6.2350
## 1053  32C 2.16        32    Aqp3     5.8100
## 1054   32C 3.1        32    Aqp3     1.0800
## 1055   32C 3.2        32    Aqp3     4.5450
## 1056   32C 3.3        32    Aqp3     3.7000
## 1057   32C 3.4        32    Aqp3     2.4650
## 1058   32C 3.5        32    Aqp3     4.9100
## 1059   32C 3.6        32    Aqp3     5.9500
## 1060   32C 3.7        32    Aqp3     6.8400
## 1061   32C 3.8        32    Aqp3     5.5600
## 1062   32C 4.1        32    Aqp3     1.9400
## 1063   32C 4.2        32    Aqp3     3.1550
## 1064   32C 4.3        32    Aqp3     4.3300
## 1065   32C 4.4        32    Aqp3    10.1150
## 1066   32C 4.5        32    Aqp3    15.0050
## 1067   32C 4.6        32    Aqp3     6.2050
## 1068   32C 4.7        32    Aqp3     5.2550
## 1069   32C 4.8        32    Aqp3     6.4100
## 1070  32C 4.10        32    Aqp3     2.3250
## 1071  32C 4.11        32    Aqp3     5.7850
## 1072  32C 4.12        32    Aqp3     0.7250
## 1073  32C 4.13        32    Aqp3     4.9100
## 1074  32C 4.14        32    Aqp3     2.1400
## 1075  32C 4.15        32    Aqp3     7.2750
## 1076  32C 4.16        32    Aqp3     9.7650
## 1077  32C 4.17        32    Aqp3     2.9700
## 1078  32C 4.18        32    Aqp3     2.6700
## 1079  32C 4.19        32    Aqp3     3.7550
## 1080  32C 4.20        32    Aqp3     2.8500
## 1081  32C 4.21        32    Aqp3     7.9800
## 1082  32C 4.22        32    Aqp3     4.5950
## 1083  32C 4.23        32    Aqp3     3.1000
## 1084  32C 4.24        32    Aqp3     7.2250
## 1085   32C 5.1        32    Aqp3     2.6450
## 1086   32C 5.2        32    Aqp3     2.8050
## 1087   32C 5.3        32    Aqp3     4.7850
## 1088   32C 5.4        32    Aqp3     3.3300
## 1089   32C 5.5        32    Aqp3     3.3850
## 1090   32C 5.6        32    Aqp3     2.1850
## 1091   32C 5.7        32    Aqp3     5.8800
## 1092   32C 5.8        32    Aqp3     9.4050
## 1093   32C 5.9        32    Aqp3     3.5350
## 1094  32C 5.10        32    Aqp3     6.4900
## 1095  32C 5.11        32    Aqp3     5.7300
## 1096  32C 5.12        32    Aqp3     7.0050
## 1097  32C 5.13        32    Aqp3     3.7950
## 1098  32C 5.14        32    Aqp3     2.4400
## 1099  32C 5.15        32    Aqp3     4.7600
## 1100  32C 5.16        32    Aqp3     0.8900
## 1101  32C 5.17        32    Aqp3     1.8200
## 1102  32C 5.18        32    Aqp3     3.6000
## 1103  32C 5.19        32    Aqp3     4.1475
## 1104  32C 5.20        32    Aqp3     4.4950
## 1105  32C 5.21        32    Aqp3     2.2700
## 1106  32C 5.22        32    Aqp3     3.8000
## 1107  32C 5.23        32    Aqp3     2.5650
## 1108   32C 6.1        32    Aqp3     0.7900
## 1109   32C 6.2        32    Aqp3     2.3750
## 1110   32C 6.3        32    Aqp3     4.1550
## 1111   32C 6.4        32    Aqp3     4.3200
## 1112   32C 6.6        32    Aqp3     2.9425
## 1113   32C 6.7        32    Aqp3     6.8950
## 1114   32C 7.1        32    Aqp3     4.4500
## 1115   32C 7.2        32    Aqp3     5.3850
## 1116   32C 7.3        32    Aqp3     3.8550
## 1117   32C 7.4        32    Aqp3     7.3500
## 1118   32C 7.5        32    Aqp3     4.5700
## 1119   32C 7.6        32    Aqp3     8.3500
## 1120   32C 7.8        32    Aqp3     5.5250
## 1121   32C 8.1        32    Aqp3     5.1175
## 1122   32C 8.2        32    Aqp3     5.6950
## 1123   32C 8.4        32    Aqp3     3.3950
## 1124   32C 8.5        32    Aqp3     4.8300
## 1125   32C 8.6        32    Aqp3     4.0250
## 1126   64C 1.1        64    Aqp3    12.3650
## 1127   64C 1.2        64    Aqp3     4.4250
## 1128   64C 1.3        64    Aqp3     9.5750
## 1129   64C 1.4        64    Aqp3    13.8650
## 1130   64C 1.5        64    Aqp3    12.5000
## 1131   64C 1.6        64    Aqp3     7.2450
## 1132   64C 1.7        64    Aqp3    13.1550
## 1133   64C 1.8        64    Aqp3     3.0100
## 1134   64C 1.9        64    Aqp3     9.5850
## 1135  64C 1.10        64    Aqp3     3.4600
## 1136  64C 1.11        64    Aqp3    10.3450
## 1137  64C 1.12        64    Aqp3     4.8550
## 1138  64C 1.13        64    Aqp3    14.0950
## 1139  64C 1.14        64    Aqp3     5.2300
## 1140  64C 1.15        64    Aqp3     6.9500
## 1141  64C 1.16        64    Aqp3     4.5750
## 1142  64C 1.17        64    Aqp3     0.6350
## 1143  64C 1.18        64    Aqp3     1.1250
## 1144  64C 1.19        64    Aqp3     3.3850
## 1145  64C 1.20        64    Aqp3     2.6700
## 1146  64C 1.21        64    Aqp3    12.5350
## 1147  64C 1.22        64    Aqp3     7.5250
## 1148  64C 1.23        64    Aqp3     6.0900
## 1149  64C 1.24        64    Aqp3     5.0250
## 1150  64C 1.25        64    Aqp3     4.4200
## 1151  64C 1.26        64    Aqp3    11.9200
## 1152  64C 1.27        64    Aqp3     1.7400
## 1153  64C 1.28        64    Aqp3     1.6950
## 1154  64C 1.29        64    Aqp3     1.7300
## 1155  64C 1.30        64    Aqp3     6.8100
## 1156  64C 1.31        64    Aqp3     3.8550
## 1157  64C 1.32        64    Aqp3     2.3950
## 1158  64C 1.33        64    Aqp3     5.2900
## 1159  64C 1.34        64    Aqp3     5.8550
## 1160  64C 1.35        64    Aqp3     0.8700
## 1161  64C 1.36        64    Aqp3     1.7500
## 1162  64C 1.37        64    Aqp3     1.7150
## 1163  64C 1.38        64    Aqp3     2.4700
## 1164  64C 1.39        64    Aqp3     4.0650
## 1165  64C 1.40        64    Aqp3     7.2900
## 1166  64C 1.41        64    Aqp3     8.1800
## 1167  64C 1.42        64    Aqp3     5.3700
## 1168  64C 1.43        64    Aqp3    13.0200
## 1169  64C 1.44        64    Aqp3     4.9200
## 1170  64C 1.45        64    Aqp3     6.2350
## 1171  64C 1.46        64    Aqp3     2.9900
## 1172  64C 1.47        64    Aqp3     2.4850
## 1173  64C 1.48        64    Aqp3     4.6150
## 1174   64C 2.1        64    Aqp3     3.0850
## 1175   64C 2.2        64    Aqp3     4.6950
## 1176   64C 2.3        64    Aqp3     7.6500
## 1177   64C 2.4        64    Aqp3     5.3950
## 1178   64C 2.5        64    Aqp3    11.7950
## 1179   64C 2.6        64    Aqp3     1.6850
## 1180   64C 2.7        64    Aqp3    13.1700
## 1181   64C 2.8        64    Aqp3    11.3100
## 1182   64C 2.9        64    Aqp3     4.4650
## 1183  64C 2.10        64    Aqp3     4.2850
## 1184  64C 2.11        64    Aqp3     2.8200
## 1185  64C 2.12        64    Aqp3     4.1800
## 1186  64C 2.13        64    Aqp3     7.2750
## 1187  64C 2.14        64    Aqp3     2.6300
## 1188  64C 2.15        64    Aqp3     0.8200
## 1189  64C 2.16        64    Aqp3     8.7950
## 1190  64C 2.17        64    Aqp3    11.6700
## 1191  64C 2.18        64    Aqp3     3.2050
## 1192  64C 2.19        64    Aqp3     3.7450
## 1193  64C 2.20        64    Aqp3     4.5250
## 1194  64C 2.21        64    Aqp3     4.8950
## 1195  64C 2.22        64    Aqp3     4.5700
## 1196  64C 2.23        64    Aqp3     3.9050
## 1197  64C 2.24        64    Aqp3     1.8150
## 1198  64C 2.25        64    Aqp3     6.2000
## 1199   64C 3.1        64    Aqp3     6.2350
## 1200   64C 3.2        64    Aqp3     6.3050
## 1201   64C 3.3        64    Aqp3     5.9400
## 1202   64C 3.4        64    Aqp3     4.9800
## 1203   64C 3.5        64    Aqp3    11.3250
## 1204   64C 3.6        64    Aqp3     4.6950
## 1205   64C 3.7        64    Aqp3     4.8900
## 1206   64C 3.8        64    Aqp3     4.7000
## 1207   64C 4.1        64    Aqp3    11.6000
## 1208  64C 4.1b        64    Aqp3     6.8300
## 1209   64C 4.2        64    Aqp3     9.1900
## 1210   64C 4.3        64    Aqp3    12.2975
## 1211   64C 4.4        64    Aqp3    10.0450
## 1212   64C 4.5        64    Aqp3    12.0700
## 1213   64C 4.6        64    Aqp3    12.1200
## 1214   64C 4.7        64    Aqp3     3.0950
## 1215   64C 4.8        64    Aqp3     5.5750
## 1216   64C 4.9        64    Aqp3     4.8050
## 1217  64C 4.10        64    Aqp3     5.9950
## 1218  64C 4.11        64    Aqp3     7.4050
## 1219  64C 4.12        64    Aqp3     3.4175
## 1220  64C 4.13        64    Aqp3     5.9050
## 1221  64C 4.14        64    Aqp3     3.8800
## 1222  64C 4.15        64    Aqp3     4.9900
## 1223  64C 4.16        64    Aqp3     2.5050
## 1224  64C 4.17        64    Aqp3     4.0200
## 1225  64C 4.18        64    Aqp3     2.7050
## 1226  64C 4.19        64    Aqp3     2.7750
## 1227  64C 4.20        64    Aqp3     3.9400
## 1228  64C 4.21        64    Aqp3     3.6725
## 1229  64C 4.22        64    Aqp3     4.4250
## 1230  64C 4.23        64    Aqp3     2.4850
## 1231  64C 4.24        64    Aqp3     3.5900
## 1232  64C 4.25        64    Aqp3     1.8050
## 1233  64C 4.26        64    Aqp3    12.3650
## 1234  64C 4.27        64    Aqp3     1.1750
## 1235  64C 4.28        64    Aqp3    10.3050
## 1236  64C 4.29        64    Aqp3     4.3050
## 1237  64C 4.30        64    Aqp3    12.5000
## 1238  64C 4.31        64    Aqp3     4.9550
## 1239  64C 4.32        64    Aqp3     8.0250
## 1240  64C 4.33        64    Aqp3     2.1600
## 1241  64C 4.34        64    Aqp3    -1.2650
## 1242  64C 4.35        64    Aqp3    10.6800
## 1243  64C 4.36        64    Aqp3    -0.0150
## 1244  64C 4.37        64    Aqp3     3.1250
## 1245  64C 4.38        64    Aqp3     3.6350
## 1246  64C 4.39        64    Aqp3     4.8900
## 1247   64C 5.1        64    Aqp3     8.8400
## 1248   64C 5.2        64    Aqp3    14.0750
## 1249   64C 5.3        64    Aqp3     9.1850
## 1250   64C 5.4        64    Aqp3     3.3250
## 1251   64C 5.5        64    Aqp3    11.2950
## 1252   64C 5.6        64    Aqp3    10.8700
## 1253   64C 5.7        64    Aqp3    12.5350
## 1254   64C 5.8        64    Aqp3     7.6550
## 1255   64C 5.9        64    Aqp3     8.7400
## 1256  64C 5.10        64    Aqp3    13.1350
## 1257  64C 5.11        64    Aqp3     4.4800
## 1258  64C 5.12        64    Aqp3     3.8700
## 1259  64C 5.13        64    Aqp3     3.1200
## 1260  64C 5.14        64    Aqp3     3.2650
## 1261  64C 5.15        64    Aqp3     7.4200
## 1262  64C 5.16        64    Aqp3     9.7900
## 1263   64C 6.1        64    Aqp3    13.3150
## 1264   64C 6.2        64    Aqp3     7.1450
## 1265   64C 6.3        64    Aqp3     7.8400
## 1266   64C 6.4        64    Aqp3     7.8850
## 1267   64C 6.5        64    Aqp3    11.9400
## 1268   64C 6.6        64    Aqp3     6.1400
## 1269   64C 6.7        64    Aqp3    11.8150
## 1270   64C 6.8        64    Aqp3     4.7200
## 1271   64C 7.1        64    Aqp3    13.5550
## 1272   64C 7.2        64    Aqp3    13.5000
## 1273   64C 7.3        64    Aqp3     8.3400
## 1274   64C 7.4        64    Aqp3    14.0200
## 1275   64C 7.5        64    Aqp3    13.0200
## 1276   64C 7.6        64    Aqp3    12.1900
## 1277   64C 7.7        64    Aqp3    11.5150
## 1278   64C 7.8        64    Aqp3     6.1100
## 1279   64C 7.9        64    Aqp3     4.8750
## 1280  64C 7.10        64    Aqp3     6.7650
## 1281  64C 7.11        64    Aqp3     3.3150
## 1282  64C 7.12        64    Aqp3     5.9350
## 1283  64C 7.13        64    Aqp3     8.3100
## 1284  64C 7.14        64    Aqp3     5.5650
## 1285    2C 1.1         2  Atp12a    11.1850
## 1286    2C 1.2         2  Atp12a    11.5100
## 1287    2C 2.1         2  Atp12a    12.4300
## 1288    2C 2.2         2  Atp12a    11.7000
## 1289    2C 3.1         2  Atp12a     9.4500
## 1290    2C 3.2         2  Atp12a    10.0150
## 1291    2C 4.1         2  Atp12a    11.6700
## 1292    2C 5.1         2  Atp12a     8.7800
## 1293    2C 5.2         2  Atp12a     9.4600
## 1294    2C 6.1         2  Atp12a     5.8300
## 1295    2C 6.2         2  Atp12a     6.2150
## 1296    2C 7.1         2  Atp12a    11.7400
## 1297    2C 7.2         2  Atp12a    12.6600
## 1298    2C 8.1         2  Atp12a    12.0750
## 1299    2C 8.2         2  Atp12a    12.9600
## 1300    2C 9.1         2  Atp12a    14.3950
## 1301    2C 9.2         2  Atp12a    11.0600
## 1302   2C 10.1         2  Atp12a    12.7300
## 1303   2C 10.2         2  Atp12a    12.4350
## 1304    4C 1.1         4  Atp12a    11.5450
## 1305    4C 1.2         4  Atp12a    10.8650
## 1306    4C 1.3         4  Atp12a    10.9800
## 1307    4C 1.4         4  Atp12a    14.1900
## 1308    4C 2.1         4  Atp12a    13.0850
## 1309    4C 2.2         4  Atp12a    13.9450
## 1310    4C 2.3         4  Atp12a    13.1700
## 1311    4C 3.1         4  Atp12a    12.1000
## 1312    4C 3.2         4  Atp12a    11.5150
## 1313    4C 3.3         4  Atp12a     8.3950
## 1314    4C 3.4         4  Atp12a    11.5650
## 1315    4C 4.1         4  Atp12a    11.3750
## 1316    4C 4.2         4  Atp12a    13.6700
## 1317    4C 4.3         4  Atp12a    14.3150
## 1318    4C 4.4         4  Atp12a    15.2400
## 1319    4C 5.1         4  Atp12a    11.7400
## 1320    4C 5.2         4  Atp12a    12.2750
## 1321    4C 5.3         4  Atp12a    10.6750
## 1322    4C 5.4         4  Atp12a    11.5250
## 1323    4C 6.1         4  Atp12a    12.4650
## 1324    4C 6.2         4  Atp12a    13.3750
## 1325    4C 6.3         4  Atp12a    13.6300
## 1326    4C 6.4         4  Atp12a    13.1050
## 1327    8C 1.1         8  Atp12a    13.8700
## 1328    8C 1.2         8  Atp12a    11.2600
## 1329    8C 1.3         8  Atp12a    12.5750
## 1330    8C 1.4         8  Atp12a    10.4450
## 1331    8C 1.5         8  Atp12a    11.9650
## 1332    8C 2.1         8  Atp12a    10.7850
## 1333    8C 2.2         8  Atp12a    13.1800
## 1334    8C 2.3         8  Atp12a    13.6550
## 1335    8C 2.4         8  Atp12a    13.4025
## 1336    8C 2.5         8  Atp12a    12.2800
## 1337    8C 2.6         8  Atp12a    13.0100
## 1338    8C 2.7         8  Atp12a    12.2600
## 1339    8C 2.8         8  Atp12a    10.3100
## 1340    8C 3.1         8  Atp12a    11.8050
## 1341    8C 3.2         8  Atp12a    11.2000
## 1342    8C 3.3         8  Atp12a    13.3600
## 1343    8C 3.4         8  Atp12a    13.4950
## 1344    8C 3.5         8  Atp12a    12.0825
## 1345    8C 3.6         8  Atp12a    14.2450
## 1346    8C 3.7         8  Atp12a    13.9850
## 1347    8C 3.8         8  Atp12a    12.0950
## 1348    8C 4.2         8  Atp12a     9.4650
## 1349    8C 4.3         8  Atp12a    11.1450
## 1350    8C 4.4         8  Atp12a     9.7950
## 1351    8C 4.5         8  Atp12a    12.9200
## 1352    8C 4.6         8  Atp12a    13.7500
## 1353    8C 4.7         8  Atp12a    11.4600
## 1354    8C 5.1         8  Atp12a    13.8850
## 1355    8C 5.2         8  Atp12a    13.1300
## 1356    8C 5.3         8  Atp12a    11.7650
## 1357    8C 5.4         8  Atp12a     7.4300
## 1358    8C 5.5         8  Atp12a    11.3750
## 1359    8C 5.6         8  Atp12a    10.9100
## 1360    8C 5.7         8  Atp12a    12.5900
## 1361    8C 5.8         8  Atp12a    13.5550
## 1362    8C 6.1         8  Atp12a    12.1600
## 1363    8C 6.2         8  Atp12a     9.0650
## 1364    8C 6.3         8  Atp12a    14.0200
## 1365    8C 6.4         8  Atp12a    11.8600
## 1366    8C 6.5         8  Atp12a    11.6300
## 1367    8C 6.6         8  Atp12a    12.1650
## 1368    8C 6.7         8  Atp12a    11.1400
## 1369    8C 6.8         8  Atp12a    14.7500
## 1370   16C 1.1        16  Atp12a    14.1500
## 1371   16C 1.2        16  Atp12a    12.2850
## 1372   16C 1.3        16  Atp12a    14.0100
## 1373   16C 1.4        16  Atp12a     8.6500
## 1374   16C 1.5        16  Atp12a     8.6450
## 1375   16C 1.6        16  Atp12a    11.2900
## 1376   16C 1.7        16  Atp12a     6.0650
## 1377   16C 1.8        16  Atp12a    11.2000
## 1378   16C 1.9        16  Atp12a     9.8450
## 1379  16C 1.10        16  Atp12a     8.0400
## 1380  16C 1.11        16  Atp12a     7.6150
## 1381  16C 1.12        16  Atp12a    10.0700
## 1382  16C 1.13        16  Atp12a    10.2550
## 1383  16C 1.14        16  Atp12a     7.5950
## 1384  16C 1.15        16  Atp12a    12.1750
## 1385  16C 1.16        16  Atp12a     8.2550
## 1386   16C 2.1        16  Atp12a     7.6100
## 1387   16C 2.2        16  Atp12a    13.4600
## 1388   16C 2.3        16  Atp12a    12.9150
## 1389   16C 2.4        16  Atp12a    13.2550
## 1390   16C 2.5        16  Atp12a    14.6800
## 1391   16C 2.6        16  Atp12a    10.1950
## 1392   16C 2.7        16  Atp12a    11.1850
## 1393   16C 2.8        16  Atp12a    11.5100
## 1394   16C 2.9        16  Atp12a    12.4300
## 1395  16C 2.10        16  Atp12a    11.7000
## 1396  16C 2.11        16  Atp12a    14.3100
## 1397  16C 2.12        16  Atp12a    13.5650
## 1398  16C 2.13        16  Atp12a    11.6700
## 1399  16C 2.14        16  Atp12a    13.9200
## 1400  16C 2.15        16  Atp12a    10.1000
## 1401  16C 2.16        16  Atp12a     6.6800
## 1402   16C 3.1        16  Atp12a     4.9650
## 1403   16C 3.2        16  Atp12a     6.1600
## 1404   16C 3.3        16  Atp12a     6.1900
## 1405   16C 3.4        16  Atp12a    14.2350
## 1406   16C 3.5        16  Atp12a     8.9000
## 1407   16C 3.6        16  Atp12a    10.4350
## 1408   16C 3.7        16  Atp12a    13.2600
## 1409   16C 3.8        16  Atp12a     8.9500
## 1410   16C 3.9        16  Atp12a    12.4350
## 1411  16C 3.10        16  Atp12a     7.1950
## 1412  16C 3.11        16  Atp12a    10.8650
## 1413  16C 3.12        16  Atp12a    10.9800
## 1414  16C 3.13        16  Atp12a     9.1400
## 1415  16C 3.14        16  Atp12a    13.0850
## 1416  16C 3.15        16  Atp12a     9.6050
## 1417   16C 4.1        16  Atp12a     9.1800
## 1418   16C 4.2        16  Atp12a    12.1000
## 1419   16C 4.3        16  Atp12a    11.5150
## 1420   16C 4.4        16  Atp12a     4.5050
## 1421   16C 4.5        16  Atp12a    11.5650
## 1422   16C 4.6        16  Atp12a     5.1650
## 1423   16C 4.7        16  Atp12a     8.0000
## 1424   16C 4.8        16  Atp12a    14.3150
## 1425   16C 4.9        16  Atp12a    15.2400
## 1426  16C 4.10        16  Atp12a    11.7400
## 1427  16C 4.11        16  Atp12a    12.2750
## 1428  16C 4.12        16  Atp12a    10.6750
## 1429  16C 4.13        16  Atp12a    11.5250
## 1430  16C 4.14        16  Atp12a    12.4650
## 1431  16C 4.15        16  Atp12a    13.3750
## 1432  16C 4.16        16  Atp12a    13.6300
## 1433   16C 5.1        16  Atp12a    13.1050
## 1434   16C 5.2        16  Atp12a    13.8700
## 1435   16C 5.3        16  Atp12a    11.2600
## 1436   16C 5.4        16  Atp12a     7.3350
## 1437   16C 5.5        16  Atp12a     5.6450
## 1438   16C 5.6        16  Atp12a    11.9650
## 1439   16C 5.7        16  Atp12a    10.7850
## 1440   16C 5.8        16  Atp12a     8.8600
## 1441   16C 5.9        16  Atp12a     8.9750
## 1442  16C 5.10        16  Atp12a     9.3325
## 1443  16C 5.11        16  Atp12a     8.2300
## 1444  16C 5.12        16  Atp12a    13.0100
## 1445   32C 1.1        32  Atp12a     8.2900
## 1446   32C 1.2        32  Atp12a    10.3100
## 1447   32C 1.3        32  Atp12a     5.1050
## 1448   32C 1.4        32  Atp12a     3.0400
## 1449   32C 1.5        32  Atp12a    13.3600
## 1450   32C 1.6        32  Atp12a    13.4950
## 1451   32C 1.7        32  Atp12a     6.7125
## 1452   32C 1.8        32  Atp12a    14.2450
## 1453   32C 1.9        32  Atp12a    13.9850
## 1454  32C 1.10        32  Atp12a    12.0950
## 1455  32C 1.11        32  Atp12a     3.2450
## 1456  32C 1.12        32  Atp12a     5.0450
## 1457  32C 1.13        32  Atp12a     9.7950
## 1458  32C 1.14        32  Atp12a     5.3700
## 1459  32C 1.15        32  Atp12a    13.7500
## 1460  32C 1.16        32  Atp12a    11.4600
## 1461  32C 1.17        32  Atp12a    13.8850
## 1462  32C 1.18        32  Atp12a    13.1300
## 1463  32C 1.19        32  Atp12a    11.7650
## 1464  32C 1.20        32  Atp12a    11.2100
## 1465  32C 1.21        32  Atp12a    11.3750
## 1466   32C 2.1        32  Atp12a     4.5200
## 1467   32C 2.2        32  Atp12a     6.2400
## 1468   32C 2.3        32  Atp12a     7.3350
## 1469   32C 2.4        32  Atp12a    12.1600
## 1470   32C 2.5        32  Atp12a    13.3950
## 1471   32C 2.6        32  Atp12a     7.7400
## 1472   32C 2.7        32  Atp12a     6.5700
## 1473   32C 2.8        32  Atp12a    11.6300
## 1474   32C 2.9        32  Atp12a     4.0250
## 1475  32C 2.10        32  Atp12a     3.4500
## 1476  32C 2.11        32  Atp12a    14.7500
## 1477  32C 2.12        32  Atp12a     6.8000
## 1478  32C 2.13        32  Atp12a    12.2850
## 1479  32C 2.14        32  Atp12a    14.0100
## 1480  32C 2.15        32  Atp12a    13.3200
## 1481  32C 2.16        32  Atp12a    12.5450
## 1482   32C 3.1        32  Atp12a     3.5000
## 1483   32C 3.2        32  Atp12a     5.8250
## 1484   32C 3.3        32  Atp12a     4.9500
## 1485   32C 3.4        32  Atp12a     7.9050
## 1486   32C 3.5        32  Atp12a     7.0700
## 1487   32C 3.6        32  Atp12a    13.3850
## 1488   32C 3.7        32  Atp12a    14.8100
## 1489   32C 3.8        32  Atp12a    14.4450
## 1490   32C 4.1        32  Atp12a     5.2150
## 1491   32C 4.2        32  Atp12a     4.8450
## 1492   32C 4.3        32  Atp12a    12.4150
## 1493   32C 4.4        32  Atp12a    11.6200
## 1494   32C 4.5        32  Atp12a    13.4600
## 1495   32C 4.6        32  Atp12a    12.9150
## 1496   32C 4.7        32  Atp12a     6.1350
## 1497   32C 4.8        32  Atp12a     6.5800
## 1498  32C 4.10        32  Atp12a     6.0150
## 1499  32C 4.11        32  Atp12a    11.1850
## 1500  32C 4.12        32  Atp12a     6.7200
## 1501  32C 4.13        32  Atp12a     5.1800
## 1502  32C 4.14        32  Atp12a    11.7000
## 1503  32C 4.15        32  Atp12a    14.3100
## 1504  32C 4.16        32  Atp12a    13.5650
## 1505  32C 4.17        32  Atp12a     5.4800
## 1506  32C 4.18        32  Atp12a     5.1300
## 1507  32C 4.19        32  Atp12a     6.9300
## 1508  32C 4.20        32  Atp12a    12.0900
## 1509  32C 4.21        32  Atp12a     9.6850
## 1510  32C 4.22        32  Atp12a    11.7400
## 1511  32C 4.23        32  Atp12a     4.4700
## 1512  32C 4.24        32  Atp12a    14.2350
## 1513   32C 5.1        32  Atp12a     5.8600
## 1514   32C 5.2        32  Atp12a     9.5650
## 1515   32C 5.3        32  Atp12a    13.2600
## 1516   32C 5.4        32  Atp12a    12.7300
## 1517   32C 5.5        32  Atp12a    12.4350
## 1518   32C 5.6        32  Atp12a     6.7850
## 1519   32C 5.7        32  Atp12a     5.1350
## 1520   32C 5.8        32  Atp12a    10.9800
## 1521   32C 5.9        32  Atp12a     6.6000
## 1522  32C 5.10        32  Atp12a    13.0850
## 1523  32C 5.11        32  Atp12a     7.2650
## 1524  32C 5.12        32  Atp12a    13.1700
## 1525  32C 5.13        32  Atp12a     5.5900
## 1526  32C 5.14        32  Atp12a    11.5150
## 1527  32C 5.15        32  Atp12a     8.3950
## 1528  32C 5.16        32  Atp12a     3.2150
## 1529  32C 5.17        32  Atp12a     3.9250
## 1530  32C 5.18        32  Atp12a     8.3800
## 1531  32C 5.19        32  Atp12a    14.3150
## 1532  32C 5.20        32  Atp12a     8.8200
## 1533  32C 5.21        32  Atp12a     7.0400
## 1534  32C 5.22        32  Atp12a    12.2750
## 1535  32C 5.23        32  Atp12a     3.5450
## 1536   32C 6.1        32  Atp12a    11.5250
## 1537   32C 6.2        32  Atp12a     4.1050
## 1538   32C 6.3        32  Atp12a     7.4650
## 1539   32C 6.4        32  Atp12a    13.6300
## 1540   32C 6.6        32  Atp12a     5.8700
## 1541   32C 6.7        32  Atp12a     7.5200
## 1542   32C 7.1        32  Atp12a     3.1900
## 1543   32C 7.2        32  Atp12a    12.5750
## 1544   32C 7.3        32  Atp12a     6.7550
## 1545   32C 7.4        32  Atp12a     5.2800
## 1546   32C 7.5        32  Atp12a    10.7850
## 1547   32C 7.6        32  Atp12a    13.1800
## 1548   32C 7.8        32  Atp12a     7.3850
## 1549   32C 8.1        32  Atp12a     8.2575
## 1550   32C 8.2        32  Atp12a     5.8850
## 1551   32C 8.4        32  Atp12a     8.0550
## 1552   32C 8.5        32  Atp12a    12.2600
## 1553   32C 8.6        32  Atp12a     4.0700
## 1554   64C 1.1        64  Atp12a    11.8050
## 1555   64C 1.2        64  Atp12a     6.4400
## 1556   64C 1.3        64  Atp12a     8.9000
## 1557   64C 1.4        64  Atp12a    13.4950
## 1558   64C 1.5        64  Atp12a    12.0825
## 1559   64C 1.6        64  Atp12a    14.2450
## 1560   64C 1.7        64  Atp12a    13.9850
## 1561   64C 1.8        64  Atp12a     5.5150
## 1562   64C 1.9        64  Atp12a     9.4650
## 1563  64C 1.10        64  Atp12a     5.6250
## 1564  64C 1.11        64  Atp12a     9.7950
## 1565  64C 1.12        64  Atp12a     7.7000
## 1566  64C 1.13        64  Atp12a    13.7500
## 1567  64C 1.14        64  Atp12a     7.0300
## 1568  64C 1.15        64  Atp12a     9.2250
## 1569  64C 1.16        64  Atp12a     9.7800
## 1570  64C 1.17        64  Atp12a     5.9750
## 1571  64C 1.18        64  Atp12a     5.2200
## 1572  64C 1.19        64  Atp12a     9.2450
## 1573  64C 1.20        64  Atp12a    10.9100
## 1574  64C 1.21        64  Atp12a    12.5900
## 1575  64C 1.22        64  Atp12a    13.5550
## 1576  64C 1.23        64  Atp12a    12.1600
## 1577  64C 1.24        64  Atp12a     7.4350
## 1578  64C 1.25        64  Atp12a     8.4500
## 1579  64C 1.26        64  Atp12a    11.8600
## 1580  64C 1.27        64  Atp12a     5.6600
## 1581  64C 1.28        64  Atp12a     7.4350
## 1582  64C 1.29        64  Atp12a     6.4700
## 1583  64C 1.30        64  Atp12a    14.7500
## 1584  64C 1.31        64  Atp12a     9.0500
## 1585  64C 1.32        64  Atp12a     6.8150
## 1586  64C 1.33        64  Atp12a     9.8200
## 1587  64C 1.34        64  Atp12a    13.3200
## 1588  64C 1.35        64  Atp12a     5.4350
## 1589  64C 1.36        64  Atp12a     3.9900
## 1590  64C 1.37        64  Atp12a     6.8550
## 1591  64C 1.38        64  Atp12a     4.7400
## 1592  64C 1.39        64  Atp12a     9.0950
## 1593  64C 1.40        64  Atp12a    13.0900
## 1594  64C 1.41        64  Atp12a    13.3850
## 1595  64C 1.42        64  Atp12a    14.8100
## 1596  64C 1.43        64  Atp12a    14.4450
## 1597  64C 1.44        64  Atp12a     9.1150
## 1598  64C 1.45        64  Atp12a     7.7650
## 1599  64C 1.46        64  Atp12a     6.5950
## 1600  64C 1.47        64  Atp12a     4.6300
## 1601  64C 1.48        64  Atp12a     7.1000
## 1602   64C 2.1        64  Atp12a     5.5150
## 1603   64C 2.2        64  Atp12a     3.1250
## 1604   64C 2.3        64  Atp12a     8.3600
## 1605   64C 2.4        64  Atp12a     6.5650
## 1606   64C 2.5        64  Atp12a    11.1850
## 1607   64C 2.6        64  Atp12a     5.7700
## 1608   64C 2.7        64  Atp12a    12.4300
## 1609   64C 2.8        64  Atp12a    11.7000
## 1610   64C 2.9        64  Atp12a     7.2900
## 1611  64C 2.10        64  Atp12a     7.3550
## 1612  64C 2.11        64  Atp12a     6.1800
## 1613  64C 2.12        64  Atp12a     6.4500
## 1614  64C 2.13        64  Atp12a     8.2200
## 1615  64C 2.14        64  Atp12a     5.0300
## 1616  64C 2.15        64  Atp12a     4.4550
## 1617  64C 2.16        64  Atp12a    11.7400
## 1618  64C 2.17        64  Atp12a    12.6600
## 1619  64C 2.18        64  Atp12a     7.0350
## 1620  64C 2.19        64  Atp12a     6.6300
## 1621  64C 2.20        64  Atp12a    12.3650
## 1622  64C 2.21        64  Atp12a     6.1400
## 1623  64C 2.22        64  Atp12a     6.4800
## 1624  64C 2.23        64  Atp12a     6.4250
## 1625  64C 2.24        64  Atp12a     3.3150
## 1626  64C 2.25        64  Atp12a     3.8150
## 1627   64C 3.1        64  Atp12a     6.9200
## 1628   64C 3.2        64  Atp12a     9.8200
## 1629   64C 3.3        64  Atp12a     8.2750
## 1630   64C 3.4        64  Atp12a    10.1650
## 1631   64C 3.5        64  Atp12a    13.1700
## 1632   64C 3.6        64  Atp12a     7.7000
## 1633   64C 3.7        64  Atp12a     8.4150
## 1634   64C 3.8        64  Atp12a     8.3950
## 1635   64C 4.1        64  Atp12a    11.5650
## 1636  64C 4.1b        64  Atp12a    11.3750
## 1637   64C 4.2        64  Atp12a    13.6700
## 1638   64C 4.3        64  Atp12a    14.3150
## 1639   64C 4.4        64  Atp12a    15.2400
## 1640   64C 4.5        64  Atp12a    11.7400
## 1641   64C 4.6        64  Atp12a    12.2750
## 1642   64C 4.7        64  Atp12a     5.8350
## 1643   64C 4.8        64  Atp12a    11.5250
## 1644   64C 4.9        64  Atp12a     8.3350
## 1645  64C 4.10        64  Atp12a    13.3750
## 1646  64C 4.11        64  Atp12a    13.6300
## 1647  64C 4.12        64  Atp12a    13.1050
## 1648  64C 4.13        64  Atp12a     9.3200
## 1649  64C 4.14        64  Atp12a     6.4700
## 1650  64C 4.15        64  Atp12a     8.2350
## 1651  64C 4.16        64  Atp12a    10.4450
## 1652  64C 4.17        64  Atp12a     7.2050
## 1653  64C 4.18        64  Atp12a     4.7650
## 1654  64C 4.19        64  Atp12a     8.4700
## 1655  64C 4.20        64  Atp12a     6.8650
## 1656  64C 4.21        64  Atp12a     8.0925
## 1657  64C 4.22        64  Atp12a     7.6900
## 1658  64C 4.23        64  Atp12a     7.4100
## 1659  64C 4.24        64  Atp12a    12.2600
## 1660  64C 4.25        64  Atp12a     3.3800
## 1661  64C 4.26        64  Atp12a    11.8050
## 1662  64C 4.27        64  Atp12a     6.3600
## 1663  64C 4.28        64  Atp12a    13.3600
## 1664  64C 4.29        64  Atp12a     7.2950
## 1665  64C 4.30        64  Atp12a    12.0825
## 1666  64C 4.31        64  Atp12a     9.3150
## 1667  64C 4.32        64  Atp12a    13.9850
## 1668  64C 4.33        64  Atp12a     8.0450
## 1669  64C 4.34        64  Atp12a     2.1150
## 1670  64C 4.35        64  Atp12a    11.1450
## 1671  64C 4.36        64  Atp12a     3.4350
## 1672  64C 4.37        64  Atp12a     7.9200
## 1673  64C 4.38        64  Atp12a     7.8800
## 1674  64C 4.39        64  Atp12a    11.1500
## 1675   64C 5.1        64  Atp12a    13.8850
## 1676   64C 5.2        64  Atp12a    13.1300
## 1677   64C 5.3        64  Atp12a    11.7650
## 1678   64C 5.4        64  Atp12a     6.1700
## 1679   64C 5.5        64  Atp12a    11.3750
## 1680   64C 5.6        64  Atp12a    10.9100
## 1681   64C 5.7        64  Atp12a    12.5900
## 1682   64C 5.8        64  Atp12a    13.5550
## 1683   64C 5.9        64  Atp12a    12.1600
## 1684  64C 5.10        64  Atp12a    13.3950
## 1685  64C 5.11        64  Atp12a    11.2900
## 1686  64C 5.12        64  Atp12a     6.8600
## 1687  64C 5.13        64  Atp12a    11.6300
## 1688  64C 5.14        64  Atp12a     5.4650
## 1689  64C 5.15        64  Atp12a    11.1400
## 1690  64C 5.16        64  Atp12a    14.7500
## 1691   64C 6.1        64  Atp12a    14.1500
## 1692   64C 6.2        64  Atp12a    12.2850
## 1693   64C 6.3        64  Atp12a    14.0100
## 1694   64C 6.4        64  Atp12a    13.3200
## 1695   64C 6.5        64  Atp12a    12.5450
## 1696   64C 6.6        64  Atp12a    11.2900
## 1697   64C 6.7        64  Atp12a    11.8950
## 1698   64C 6.8        64  Atp12a    11.2000
## 1699   64C 7.1        64  Atp12a    14.7350
## 1700   64C 7.2        64  Atp12a    13.0900
## 1701   64C 7.3        64  Atp12a    13.3850
## 1702   64C 7.4        64  Atp12a    14.8100
## 1703   64C 7.5        64  Atp12a    14.4450
## 1704   64C 7.6        64  Atp12a    12.3950
## 1705   64C 7.7        64  Atp12a    12.1750
## 1706   64C 7.8        64  Atp12a    12.4150
## 1707   64C 7.9        64  Atp12a    11.6200
## 1708  64C 7.10        64  Atp12a     7.5900
## 1709  64C 7.11        64  Atp12a     6.5550
## 1710  64C 7.12        64  Atp12a    13.2550
## 1711  64C 7.13        64  Atp12a     8.8700
## 1712  64C 7.14        64  Atp12a     8.9950
## 1713    2C 1.1         2    Bmp4    11.8100
## 1714    2C 1.2         2    Bmp4    11.6050
## 1715    2C 2.1         2    Bmp4    11.8350
## 1716    2C 2.2         2    Bmp4    11.5300
## 1717    2C 3.1         2    Bmp4    14.4500
## 1718    2C 3.2         2    Bmp4    13.2950
## 1719    2C 4.1         2    Bmp4    13.6050
## 1720    2C 5.1         2    Bmp4    13.5150
## 1721    2C 5.2         2    Bmp4    14.5650
## 1722    2C 6.1         2    Bmp4    11.6400
## 1723    2C 6.2         2    Bmp4     8.0150
## 1724    2C 7.1         2    Bmp4    12.5600
## 1725    2C 7.2         2    Bmp4    10.6650
## 1726    2C 8.1         2    Bmp4    14.8450
## 1727    2C 8.2         2    Bmp4    13.7700
## 1728    2C 9.1         2    Bmp4    14.3000
## 1729    2C 9.2         2    Bmp4    13.4700
## 1730   2C 10.1         2    Bmp4    11.5800
## 1731   2C 10.2         2    Bmp4    12.3250
## 1732    4C 1.1         4    Bmp4    10.9550
## 1733    4C 1.2         4    Bmp4    11.2100
## 1734    4C 1.3         4    Bmp4    11.7950
## 1735    4C 1.4         4    Bmp4    14.3350
## 1736    4C 2.1         4    Bmp4    15.2575
## 1737    4C 2.2         4    Bmp4    13.8800
## 1738    4C 2.3         4    Bmp4    10.9550
## 1739    4C 3.1         4    Bmp4    12.6400
## 1740    4C 3.2         4    Bmp4    11.8000
## 1741    4C 3.3         4    Bmp4    11.4350
## 1742    4C 3.4         4    Bmp4    12.4900
## 1743    4C 4.1         4    Bmp4    13.5850
## 1744    4C 4.2         4    Bmp4    13.0400
## 1745    4C 4.3         4    Bmp4    12.5725
## 1746    4C 4.4         4    Bmp4    11.6750
## 1747    4C 5.1         4    Bmp4    11.9350
## 1748    4C 5.2         4    Bmp4    12.4550
## 1749    4C 5.3         4    Bmp4    10.0050
## 1750    4C 5.4         4    Bmp4    11.9300
## 1751    4C 6.1         4    Bmp4    11.3350
## 1752    4C 6.2         4    Bmp4    12.5650
## 1753    4C 6.3         4    Bmp4    14.3750
## 1754    4C 6.4         4    Bmp4    13.4050
## 1755    8C 1.1         8    Bmp4    13.1250
## 1756    8C 1.2         8    Bmp4    11.1000
## 1757    8C 1.3         8    Bmp4    10.8150
## 1758    8C 1.4         8    Bmp4    10.5100
## 1759    8C 1.5         8    Bmp4    10.5850
## 1760    8C 2.1         8    Bmp4    10.1350
## 1761    8C 2.2         8    Bmp4    12.9000
## 1762    8C 2.3         8    Bmp4    13.7550
## 1763    8C 2.4         8    Bmp4    12.7250
## 1764    8C 2.5         8    Bmp4    10.3850
## 1765    8C 2.6         8    Bmp4    11.8150
## 1766    8C 2.7         8    Bmp4    12.0500
## 1767    8C 2.8         8    Bmp4     9.8150
## 1768    8C 3.1         8    Bmp4    10.8950
## 1769    8C 3.2         8    Bmp4     9.9050
## 1770    8C 3.3         8    Bmp4    12.4600
## 1771    8C 3.4         8    Bmp4    11.9550
## 1772    8C 3.5         8    Bmp4    12.8100
## 1773    8C 3.6         8    Bmp4    12.1700
## 1774    8C 3.7         8    Bmp4    13.5050
## 1775    8C 3.8         8    Bmp4     8.9750
## 1776    8C 4.2         8    Bmp4     9.5100
## 1777    8C 4.3         8    Bmp4    11.1900
## 1778    8C 4.4         8    Bmp4    10.9850
## 1779    8C 4.5         8    Bmp4    13.7700
## 1780    8C 4.6         8    Bmp4    13.2950
## 1781    8C 4.7         8    Bmp4    11.6750
## 1782    8C 5.1         8    Bmp4    13.6850
## 1783    8C 5.2         8    Bmp4    12.2750
## 1784    8C 5.3         8    Bmp4    10.0550
## 1785    8C 5.4         8    Bmp4    10.9900
## 1786    8C 5.5         8    Bmp4    10.8400
## 1787    8C 5.6         8    Bmp4    11.7950
## 1788    8C 5.7         8    Bmp4    13.2550
## 1789    8C 5.8         8    Bmp4    14.8450
## 1790    8C 6.1         8    Bmp4     9.4550
## 1791    8C 6.2         8    Bmp4    12.4750
## 1792    8C 6.3         8    Bmp4    14.1900
## 1793    8C 6.4         8    Bmp4    11.8800
## 1794    8C 6.5         8    Bmp4    11.4450
## 1795    8C 6.6         8    Bmp4    12.2150
## 1796    8C 6.7         8    Bmp4    11.0900
## 1797    8C 6.8         8    Bmp4    14.4500
## 1798   16C 1.1        16    Bmp4    13.1050
## 1799   16C 1.2        16    Bmp4    12.5900
## 1800   16C 1.3        16    Bmp4    14.3600
## 1801   16C 1.4        16    Bmp4    13.0350
## 1802   16C 1.5        16    Bmp4    13.0500
## 1803   16C 1.6        16    Bmp4    11.7000
## 1804   16C 1.7        16    Bmp4    12.4950
## 1805   16C 1.8        16    Bmp4    11.4500
## 1806   16C 1.9        16    Bmp4    13.7800
## 1807  16C 1.10        16    Bmp4    14.2300
## 1808  16C 1.11        16    Bmp4    13.9500
## 1809  16C 1.12        16    Bmp4    12.5700
## 1810  16C 1.13        16    Bmp4    13.1200
## 1811  16C 1.14        16    Bmp4    10.6250
## 1812  16C 1.15        16    Bmp4    11.4850
## 1813  16C 1.16        16    Bmp4    12.6200
## 1814   16C 2.1        16    Bmp4    11.5700
## 1815   16C 2.2        16    Bmp4    14.0300
## 1816   16C 2.3        16    Bmp4    14.3550
## 1817   16C 2.4        16    Bmp4    13.4350
## 1818   16C 2.5        16    Bmp4    13.9050
## 1819   16C 2.6        16    Bmp4    14.1850
## 1820   16C 2.7        16    Bmp4    11.8100
## 1821   16C 2.8        16    Bmp4    11.6050
## 1822   16C 2.9        16    Bmp4    11.8350
## 1823  16C 2.10        16    Bmp4    11.5300
## 1824  16C 2.11        16    Bmp4    11.8900
## 1825  16C 2.12        16    Bmp4    13.2950
## 1826  16C 2.13        16    Bmp4    13.6050
## 1827  16C 2.14        16    Bmp4    13.5150
## 1828  16C 2.15        16    Bmp4    14.5650
## 1829  16C 2.16        16    Bmp4    11.6400
## 1830   16C 3.1        16    Bmp4     8.0150
## 1831   16C 3.2        16    Bmp4    12.5600
## 1832   16C 3.3        16    Bmp4    12.0050
## 1833   16C 3.4        16    Bmp4    14.8450
## 1834   16C 3.5        16    Bmp4    13.7700
## 1835   16C 3.6        16    Bmp4    14.3000
## 1836   16C 3.7        16    Bmp4    13.4700
## 1837   16C 3.8        16    Bmp4    13.1300
## 1838   16C 3.9        16    Bmp4    12.3250
## 1839  16C 3.10        16    Bmp4    10.9550
## 1840  16C 3.11        16    Bmp4    11.2100
## 1841  16C 3.12        16    Bmp4    11.7950
## 1842  16C 3.13        16    Bmp4    14.3350
## 1843  16C 3.14        16    Bmp4    15.2575
## 1844  16C 3.15        16    Bmp4    13.8800
## 1845   16C 4.1        16    Bmp4    13.1450
## 1846   16C 4.2        16    Bmp4    12.6400
## 1847   16C 4.3        16    Bmp4     9.8700
## 1848   16C 4.4        16    Bmp4    11.4350
## 1849   16C 4.5        16    Bmp4    12.4900
## 1850   16C 4.6        16    Bmp4    13.5850
## 1851   16C 4.7        16    Bmp4    13.3300
## 1852   16C 4.8        16    Bmp4    12.5725
## 1853   16C 4.9        16    Bmp4    14.6150
## 1854  16C 4.10        16    Bmp4    11.9350
## 1855  16C 4.11        16    Bmp4    12.4550
## 1856  16C 4.12        16    Bmp4    10.0050
## 1857  16C 4.13        16    Bmp4    11.9300
## 1858  16C 4.14        16    Bmp4    11.3350
## 1859  16C 4.15        16    Bmp4    12.5650
## 1860  16C 4.16        16    Bmp4    14.3750
## 1861   16C 5.1        16    Bmp4    13.4050
## 1862   16C 5.2        16    Bmp4    13.3050
## 1863   16C 5.3        16    Bmp4    11.1000
## 1864   16C 5.4        16    Bmp4    10.8150
## 1865   16C 5.5        16    Bmp4    10.5100
## 1866   16C 5.6        16    Bmp4     9.7250
## 1867   16C 5.7        16    Bmp4    10.1350
## 1868   16C 5.8        16    Bmp4    12.9000
## 1869   16C 5.9        16    Bmp4    13.7550
## 1870  16C 5.10        16    Bmp4    12.7250
## 1871  16C 5.11        16    Bmp4    13.4150
## 1872  16C 5.12        16    Bmp4     9.8450
## 1873   32C 1.1        32    Bmp4    12.0500
## 1874   32C 1.2        32    Bmp4     3.0050
## 1875   32C 1.3        32    Bmp4    10.8950
## 1876   32C 1.4        32    Bmp4     9.9050
## 1877   32C 1.5        32    Bmp4     5.8900
## 1878   32C 1.6        32    Bmp4     7.0150
## 1879   32C 1.7        32    Bmp4    12.9000
## 1880   32C 1.8        32    Bmp4     9.5500
## 1881   32C 1.9        32    Bmp4     6.3350
## 1882  32C 1.10        32    Bmp4     8.6850
## 1883  32C 1.11        32    Bmp4     9.5100
## 1884  32C 1.12        32    Bmp4    11.1900
## 1885  32C 1.13        32    Bmp4     5.6350
## 1886  32C 1.14        32    Bmp4    13.7700
## 1887  32C 1.15        32    Bmp4     6.3550
## 1888  32C 1.16        32    Bmp4     6.0050
## 1889  32C 1.17        32    Bmp4     7.2050
## 1890  32C 1.18        32    Bmp4     8.9550
## 1891  32C 1.19        32    Bmp4    11.0150
## 1892  32C 1.20        32    Bmp4     6.0300
## 1893  32C 1.21        32    Bmp4     5.1400
## 1894   32C 2.1        32    Bmp4    11.7950
## 1895   32C 2.2        32    Bmp4    13.2550
## 1896   32C 2.3        32    Bmp4    14.8450
## 1897   32C 2.4        32    Bmp4     7.8450
## 1898   32C 2.5        32    Bmp4    12.4750
## 1899   32C 2.6        32    Bmp4    14.1900
## 1900   32C 2.7        32    Bmp4     8.8400
## 1901   32C 2.8        32    Bmp4     8.3350
## 1902   32C 2.9        32    Bmp4    12.2150
## 1903  32C 2.10        32    Bmp4     9.0200
## 1904  32C 2.11        32    Bmp4    11.2300
## 1905  32C 2.12        32    Bmp4    13.1050
## 1906  32C 2.13        32    Bmp4    12.5900
## 1907  32C 2.14        32    Bmp4    14.3600
## 1908  32C 2.15        32    Bmp4    11.5450
## 1909  32C 2.16        32    Bmp4    13.0500
## 1910   32C 3.1        32    Bmp4    11.7000
## 1911   32C 3.2        32    Bmp4    12.4950
## 1912   32C 3.3        32    Bmp4    11.4500
## 1913   32C 3.4        32    Bmp4    13.7800
## 1914   32C 3.5        32    Bmp4    14.2300
## 1915   32C 3.6        32    Bmp4     8.6400
## 1916   32C 3.7        32    Bmp4     8.8300
## 1917   32C 3.8        32    Bmp4     8.6600
## 1918   32C 4.1        32    Bmp4    11.7850
## 1919   32C 4.2        32    Bmp4     9.1850
## 1920   32C 4.3        32    Bmp4     9.8400
## 1921   32C 4.4        32    Bmp4     8.5700
## 1922   32C 4.5        32    Bmp4    11.8000
## 1923   32C 4.6        32    Bmp4    10.0150
## 1924   32C 4.7        32    Bmp4    13.4350
## 1925   32C 4.8        32    Bmp4    13.9050
## 1926  32C 4.10        32    Bmp4    14.1850
## 1927  32C 4.11        32    Bmp4    10.3000
## 1928  32C 4.12        32    Bmp4    11.6050
## 1929  32C 4.13        32    Bmp4    11.8350
## 1930  32C 4.14        32    Bmp4    11.5300
## 1931  32C 4.15        32    Bmp4     9.2100
## 1932  32C 4.16        32    Bmp4     9.0450
## 1933  32C 4.17        32    Bmp4    13.6050
## 1934  32C 4.18        32    Bmp4    13.5150
## 1935  32C 4.19        32    Bmp4    14.5650
## 1936  32C 4.20        32    Bmp4     9.6500
## 1937  32C 4.21        32    Bmp4     8.0150
## 1938  32C 4.22        32    Bmp4    10.4200
## 1939  32C 4.23        32    Bmp4     9.9850
## 1940  32C 4.24        32    Bmp4    10.7450
## 1941   32C 5.1        32    Bmp4    13.7700
## 1942   32C 5.2        32    Bmp4    14.3000
## 1943   32C 5.3        32    Bmp4    11.4500
## 1944   32C 5.4        32    Bmp4    13.1300
## 1945   32C 5.5        32    Bmp4    12.3250
## 1946   32C 5.6        32    Bmp4    10.9550
## 1947   32C 5.7        32    Bmp4    11.2100
## 1948   32C 5.8        32    Bmp4     7.4850
## 1949   32C 5.9        32    Bmp4    14.3350
## 1950  32C 5.10        32    Bmp4     9.7275
## 1951  32C 5.11        32    Bmp4    13.8800
## 1952  32C 5.12        32    Bmp4     8.3750
## 1953  32C 5.13        32    Bmp4    10.9400
## 1954  32C 5.14        32    Bmp4    11.8000
## 1955  32C 5.15        32    Bmp4    11.4350
## 1956  32C 5.16        32    Bmp4    12.4900
## 1957  32C 5.17        32    Bmp4    13.5850
## 1958  32C 5.18        32    Bmp4    11.1200
## 1959  32C 5.19        32    Bmp4    11.3025
## 1960  32C 5.20        32    Bmp4    14.6150
## 1961  32C 5.21        32    Bmp4    11.9350
## 1962  32C 5.22        32    Bmp4    12.4550
## 1963  32C 5.23        32    Bmp4    10.0050
## 1964   32C 6.1        32    Bmp4     9.2100
## 1965   32C 6.2        32    Bmp4    11.3350
## 1966   32C 6.3        32    Bmp4    12.5650
## 1967   32C 6.4        32    Bmp4    12.1450
## 1968   32C 6.6        32    Bmp4    13.4050
## 1969   32C 6.7        32    Bmp4    13.3050
## 1970   32C 7.1        32    Bmp4    11.1000
## 1971   32C 7.2        32    Bmp4     9.1700
## 1972   32C 7.3        32    Bmp4    10.5100
## 1973   32C 7.4        32    Bmp4    11.3850
## 1974   32C 7.5        32    Bmp4     6.3900
## 1975   32C 7.6        32    Bmp4     8.3600
## 1976   32C 7.8        32    Bmp4    13.7550
## 1977   32C 8.1        32    Bmp4    12.7250
## 1978   32C 8.2        32    Bmp4    13.4150
## 1979   32C 8.4        32    Bmp4    11.8150
## 1980   32C 8.5        32    Bmp4    11.4900
## 1981   32C 8.6        32    Bmp4     9.8150
## 1982   64C 1.1        64    Bmp4    10.8950
## 1983   64C 1.2        64    Bmp4     9.9050
## 1984   64C 1.3        64    Bmp4     9.1300
## 1985   64C 1.4        64    Bmp4    13.3750
## 1986   64C 1.5        64    Bmp4    12.9000
## 1987   64C 1.6        64    Bmp4     9.5600
## 1988   64C 1.7        64    Bmp4    13.5050
## 1989   64C 1.8        64    Bmp4    12.7050
## 1990   64C 1.9        64    Bmp4     9.5100
## 1991  64C 1.10        64    Bmp4    11.1900
## 1992  64C 1.11        64    Bmp4    10.9850
## 1993  64C 1.12        64    Bmp4    13.7700
## 1994  64C 1.13        64    Bmp4    13.2950
## 1995  64C 1.14        64    Bmp4    12.5450
## 1996  64C 1.15        64    Bmp4    13.6850
## 1997  64C 1.16        64    Bmp4    14.1950
## 1998  64C 1.17        64    Bmp4    11.0150
## 1999  64C 1.18        64    Bmp4    10.9900
## 2000  64C 1.19        64    Bmp4    11.5100
## 2001  64C 1.20        64    Bmp4    11.7950
## 2002  64C 1.21        64    Bmp4     8.7450
## 2003  64C 1.22        64    Bmp4    10.2250
## 2004  64C 1.23        64    Bmp4     6.0550
## 2005  64C 1.24        64    Bmp4    12.4750
## 2006  64C 1.25        64    Bmp4    14.1900
## 2007  64C 1.26        64    Bmp4    11.8800
## 2008  64C 1.27        64    Bmp4    11.4450
## 2009  64C 1.28        64    Bmp4    12.2150
## 2010  64C 1.29        64    Bmp4    11.0900
## 2011  64C 1.30        64    Bmp4    14.4500
## 2012  64C 1.31        64    Bmp4    13.1050
## 2013  64C 1.32        64    Bmp4    12.5900
## 2014  64C 1.33        64    Bmp4    14.3600
## 2015  64C 1.34        64    Bmp4    13.0350
## 2016  64C 1.35        64    Bmp4    13.0500
## 2017  64C 1.36        64    Bmp4    11.7000
## 2018  64C 1.37        64    Bmp4    12.4950
## 2019  64C 1.38        64    Bmp4    11.4500
## 2020  64C 1.39        64    Bmp4    13.7800
## 2021  64C 1.40        64    Bmp4     7.3000
## 2022  64C 1.41        64    Bmp4    13.9500
## 2023  64C 1.42        64    Bmp4    12.5700
## 2024  64C 1.43        64    Bmp4    13.1200
## 2025  64C 1.44        64    Bmp4    11.7850
## 2026  64C 1.45        64    Bmp4    11.4850
## 2027  64C 1.46        64    Bmp4    12.6200
## 2028  64C 1.47        64    Bmp4    11.5700
## 2029  64C 1.48        64    Bmp4    14.0300
## 2030   64C 2.1        64    Bmp4    14.3550
## 2031   64C 2.2        64    Bmp4    13.4350
## 2032   64C 2.3        64    Bmp4    13.9050
## 2033   64C 2.4        64    Bmp4    13.0250
## 2034   64C 2.5        64    Bmp4    11.8100
## 2035   64C 2.6        64    Bmp4    11.6050
## 2036   64C 2.7        64    Bmp4    11.8350
## 2037   64C 2.8        64    Bmp4     5.9100
## 2038   64C 2.9        64    Bmp4    14.4500
## 2039  64C 2.10        64    Bmp4    13.2950
## 2040  64C 2.11        64    Bmp4    13.6050
## 2041  64C 2.12        64    Bmp4    13.5150
## 2042  64C 2.13        64    Bmp4    12.0950
## 2043  64C 2.14        64    Bmp4    11.6400
## 2044  64C 2.15        64    Bmp4     8.0150
## 2045  64C 2.16        64    Bmp4    12.5600
## 2046  64C 2.17        64    Bmp4    12.0050
## 2047  64C 2.18        64    Bmp4    14.8450
## 2048  64C 2.19        64    Bmp4    13.7700
## 2049  64C 2.20        64    Bmp4    14.3000
## 2050  64C 2.21        64    Bmp4    13.4700
## 2051  64C 2.22        64    Bmp4    13.1300
## 2052  64C 2.23        64    Bmp4    12.3250
## 2053  64C 2.24        64    Bmp4    10.9550
## 2054  64C 2.25        64    Bmp4    11.2100
## 2055   64C 3.1        64    Bmp4     9.6650
## 2056   64C 3.2        64    Bmp4    14.3350
## 2057   64C 3.3        64    Bmp4    15.2575
## 2058   64C 3.4        64    Bmp4    13.8800
## 2059   64C 3.5        64    Bmp4    13.1450
## 2060   64C 3.6        64    Bmp4    12.6400
## 2061   64C 3.7        64    Bmp4    11.8000
## 2062   64C 3.8        64    Bmp4    11.4350
## 2063   64C 4.1        64    Bmp4    12.4900
## 2064  64C 4.1b        64    Bmp4     2.8350
## 2065   64C 4.2        64    Bmp4     4.7500
## 2066   64C 4.3        64    Bmp4     5.1425
## 2067   64C 4.4        64    Bmp4     4.8050
## 2068   64C 4.5        64    Bmp4     3.1450
## 2069   64C 4.6        64    Bmp4    12.4550
## 2070   64C 4.7        64    Bmp4    10.0050
## 2071   64C 4.8        64    Bmp4     2.3300
## 2072   64C 4.9        64    Bmp4     3.3650
## 2073  64C 4.10        64    Bmp4     1.9850
## 2074  64C 4.11        64    Bmp4     4.1050
## 2075  64C 4.12        64    Bmp4    13.4050
## 2076  64C 4.13        64    Bmp4    13.3050
## 2077  64C 4.14        64    Bmp4    11.1000
## 2078  64C 4.15        64    Bmp4    10.8150
## 2079  64C 4.16        64    Bmp4    10.5100
## 2080  64C 4.17        64    Bmp4    11.3850
## 2081  64C 4.18        64    Bmp4    10.1350
## 2082  64C 4.19        64    Bmp4    12.9000
## 2083  64C 4.20        64    Bmp4    13.7550
## 2084  64C 4.21        64    Bmp4    12.7250
## 2085  64C 4.22        64    Bmp4    13.4150
## 2086  64C 4.23        64    Bmp4    11.8150
## 2087  64C 4.24        64    Bmp4    12.0500
## 2088  64C 4.25        64    Bmp4     9.8150
## 2089  64C 4.26        64    Bmp4    10.8950
## 2090  64C 4.27        64    Bmp4     9.9050
## 2091  64C 4.28        64    Bmp4     3.4900
## 2092  64C 4.29        64    Bmp4    13.3750
## 2093  64C 4.30        64    Bmp4    12.9000
## 2094  64C 4.31        64    Bmp4    14.5200
## 2095  64C 4.32        64    Bmp4     5.8950
## 2096  64C 4.33        64    Bmp4    12.7050
## 2097  64C 4.34        64    Bmp4     9.5100
## 2098  64C 4.35        64    Bmp4     3.3300
## 2099  64C 4.36        64    Bmp4    10.9850
## 2100  64C 4.37        64    Bmp4    13.7700
## 2101  64C 4.38        64    Bmp4    13.2950
## 2102  64C 4.39        64    Bmp4    12.5450
## 2103   64C 5.1        64    Bmp4    13.6850
## 2104   64C 5.2        64    Bmp4    14.1950
## 2105   64C 5.3        64    Bmp4    11.0150
## 2106   64C 5.4        64    Bmp4    10.9900
## 2107   64C 5.5        64    Bmp4    11.5100
## 2108   64C 5.6        64    Bmp4    11.7950
## 2109   64C 5.7        64    Bmp4    13.2550
## 2110   64C 5.8        64    Bmp4     7.6450
## 2111   64C 5.9        64    Bmp4    12.3950
## 2112  64C 5.10        64    Bmp4    12.4750
## 2113  64C 5.11        64    Bmp4    14.1900
## 2114  64C 5.12        64    Bmp4    11.8800
## 2115  64C 5.13        64    Bmp4    11.4450
## 2116  64C 5.14        64    Bmp4    12.2150
## 2117  64C 5.15        64    Bmp4    11.0900
## 2118  64C 5.16        64    Bmp4    14.4500
## 2119   64C 6.1        64    Bmp4     6.5750
## 2120   64C 6.2        64    Bmp4     2.6300
## 2121   64C 6.3        64    Bmp4     3.6800
## 2122   64C 6.4        64    Bmp4     2.0750
## 2123   64C 6.5        64    Bmp4     0.6700
## 2124   64C 6.6        64    Bmp4     1.4900
## 2125   64C 6.7        64    Bmp4     4.7050
## 2126   64C 6.8        64    Bmp4     3.1000
## 2127   64C 7.1        64    Bmp4    13.7800
## 2128   64C 7.2        64    Bmp4    14.2300
## 2129   64C 7.3        64    Bmp4     4.0000
## 2130   64C 7.4        64    Bmp4    12.5700
## 2131   64C 7.5        64    Bmp4    13.1200
## 2132   64C 7.6        64    Bmp4    11.7850
## 2133   64C 7.7        64    Bmp4    11.4850
## 2134   64C 7.8        64    Bmp4     2.6900
## 2135   64C 7.9        64    Bmp4    11.5700
## 2136  64C 7.10        64    Bmp4    14.0300
## 2137  64C 7.11        64    Bmp4    14.3550
## 2138  64C 7.12        64    Bmp4    13.4350
## 2139  64C 7.13        64    Bmp4    13.9050
## 2140  64C 7.14        64    Bmp4    14.1850
## 2141    2C 1.1         2    Cdx2     6.6850
## 2142    2C 1.2         2    Cdx2     5.8600
## 2143    2C 2.1         2    Cdx2     5.0800
## 2144    2C 2.2         2    Cdx2     8.3750
## 2145    2C 3.1         2    Cdx2    10.6150
## 2146    2C 3.2         2    Cdx2    11.2100
## 2147    2C 4.1         2    Cdx2     9.5400
## 2148    2C 5.1         2    Cdx2     8.7900
## 2149    2C 5.2         2    Cdx2     7.2700
## 2150    2C 6.1         2    Cdx2     7.2950
## 2151    2C 6.2         2    Cdx2     6.8750
## 2152    2C 7.1         2    Cdx2     6.6250
## 2153    2C 7.2         2    Cdx2     6.0350
## 2154    2C 8.1         2    Cdx2     7.6150
## 2155    2C 8.2         2    Cdx2     8.6350
## 2156    2C 9.1         2    Cdx2    10.1400
## 2157    2C 9.2         2    Cdx2     7.4950
## 2158   2C 10.1         2    Cdx2     7.0500
## 2159   2C 10.2         2    Cdx2     5.1800
## 2160    4C 1.1         4    Cdx2     5.1050
## 2161    4C 1.2         4    Cdx2     6.5100
## 2162    4C 1.3         4    Cdx2     7.0800
## 2163    4C 1.4         4    Cdx2     9.4100
## 2164    4C 2.1         4    Cdx2     9.4850
## 2165    4C 2.2         4    Cdx2     9.0500
## 2166    4C 2.3         4    Cdx2    10.5700
## 2167    4C 3.1         4    Cdx2     5.9200
## 2168    4C 3.2         4    Cdx2     4.8450
## 2169    4C 3.3         4    Cdx2     4.3350
## 2170    4C 3.4         4    Cdx2     7.0600
## 2171    4C 4.1         4    Cdx2     8.9700
## 2172    4C 4.2         4    Cdx2     9.1450
## 2173    4C 4.3         4    Cdx2     9.0925
## 2174    4C 4.4         4    Cdx2     8.3600
## 2175    4C 5.1         4    Cdx2     6.3400
## 2176    4C 5.2         4    Cdx2     9.0750
## 2177    4C 5.3         4    Cdx2     5.4550
## 2178    4C 5.4         4    Cdx2     6.9050
## 2179    4C 6.1         4    Cdx2     5.6600
## 2180    4C 6.2         4    Cdx2     7.4300
## 2181    4C 6.3         4    Cdx2     8.6350
## 2182    4C 6.4         4    Cdx2     7.2800
## 2183    8C 1.1         8    Cdx2    10.6600
## 2184    8C 1.2         8    Cdx2     9.1050
## 2185    8C 1.3         8    Cdx2     9.2550
## 2186    8C 1.4         8    Cdx2     5.2650
## 2187    8C 1.5         8    Cdx2     5.9050
## 2188    8C 2.1         8    Cdx2     4.6200
## 2189    8C 2.2         8    Cdx2     7.2300
## 2190    8C 2.3         8    Cdx2     8.3100
## 2191    8C 2.4         8    Cdx2    12.7400
## 2192    8C 2.5         8    Cdx2     7.4900
## 2193    8C 2.6         8    Cdx2     7.9950
## 2194    8C 2.7         8    Cdx2     6.4500
## 2195    8C 2.8         8    Cdx2     9.5050
## 2196    8C 3.1         8    Cdx2     5.4750
## 2197    8C 3.2         8    Cdx2     3.6900
## 2198    8C 3.3         8    Cdx2     9.3550
## 2199    8C 3.4         8    Cdx2     9.8100
## 2200    8C 3.5         8    Cdx2     6.6700
## 2201    8C 3.6         8    Cdx2    10.1800
## 2202    8C 3.7         8    Cdx2     9.8850
## 2203    8C 3.8         8    Cdx2     6.2000
## 2204    8C 4.2         8    Cdx2     4.2800
## 2205    8C 4.3         8    Cdx2     6.6850
## 2206    8C 4.4         8    Cdx2     5.7350
## 2207    8C 4.5         8    Cdx2     8.8800
## 2208    8C 4.6         8    Cdx2     9.6250
## 2209    8C 4.7         8    Cdx2     5.9400
## 2210    8C 5.1         8    Cdx2     7.2050
## 2211    8C 5.2         8    Cdx2    14.4400
## 2212    8C 5.3         8    Cdx2     6.1250
## 2213    8C 5.4         8    Cdx2     4.8150
## 2214    8C 5.5         8    Cdx2     4.3950
## 2215    8C 5.6         8    Cdx2     6.2850
## 2216    8C 5.7         8    Cdx2    12.7750
## 2217    8C 5.8         8    Cdx2     8.4150
## 2218    8C 6.1         8    Cdx2     9.2950
## 2219    8C 6.2         8    Cdx2    10.7000
## 2220    8C 6.3         8    Cdx2     9.0850
## 2221    8C 6.4         8    Cdx2     6.3850
## 2222    8C 6.5         8    Cdx2     7.2350
## 2223    8C 6.6         8    Cdx2     6.5100
## 2224    8C 6.7         8    Cdx2     8.7050
## 2225    8C 6.8         8    Cdx2     8.2300
## 2226   16C 1.1        16    Cdx2     8.3200
## 2227   16C 1.2        16    Cdx2     3.9200
## 2228   16C 1.3        16    Cdx2     7.3700
## 2229   16C 1.4        16    Cdx2     5.0000
## 2230   16C 1.5        16    Cdx2     4.9950
## 2231   16C 1.6        16    Cdx2     3.6150
## 2232   16C 1.7        16    Cdx2     3.7850
## 2233   16C 1.8        16    Cdx2     2.2850
## 2234   16C 1.9        16    Cdx2     4.9800
## 2235  16C 1.10        16    Cdx2     6.0650
## 2236  16C 1.11        16    Cdx2     4.8550
## 2237  16C 1.12        16    Cdx2     2.1700
## 2238  16C 1.13        16    Cdx2     5.3700
## 2239  16C 1.14        16    Cdx2     2.1450
## 2240  16C 1.15        16    Cdx2     5.9250
## 2241  16C 1.16        16    Cdx2     4.0100
## 2242   16C 2.1        16    Cdx2     5.4000
## 2243   16C 2.2        16    Cdx2     4.9350
## 2244   16C 2.3        16    Cdx2     6.4750
## 2245   16C 2.4        16    Cdx2     4.6550
## 2246   16C 2.5        16    Cdx2     4.5300
## 2247   16C 2.6        16    Cdx2     5.3650
## 2248   16C 2.7        16    Cdx2     6.3650
## 2249   16C 2.8        16    Cdx2     3.7800
## 2250   16C 2.9        16    Cdx2     4.0400
## 2251  16C 2.10        16    Cdx2     4.2450
## 2252  16C 2.11        16    Cdx2     7.8650
## 2253  16C 2.12        16    Cdx2     5.6400
## 2254  16C 2.13        16    Cdx2     7.5000
## 2255  16C 2.14        16    Cdx2     5.3100
## 2256  16C 2.15        16    Cdx2     6.0000
## 2257  16C 2.16        16    Cdx2     3.2850
## 2258   16C 3.1        16    Cdx2     3.9350
## 2259   16C 3.2        16    Cdx2     4.4350
## 2260   16C 3.3        16    Cdx2     2.0850
## 2261   16C 3.4        16    Cdx2     6.9750
## 2262   16C 3.5        16    Cdx2     6.7450
## 2263   16C 3.6        16    Cdx2     5.9400
## 2264   16C 3.7        16    Cdx2     5.2950
## 2265   16C 3.8        16    Cdx2     5.4400
## 2266   16C 3.9        16    Cdx2     5.1000
## 2267  16C 3.10        16    Cdx2     3.0150
## 2268  16C 3.11        16    Cdx2     4.7000
## 2269  16C 3.12        16    Cdx2     3.3800
## 2270  16C 3.13        16    Cdx2     6.8600
## 2271  16C 3.14        16    Cdx2     6.3450
## 2272  16C 3.15        16    Cdx2     4.6900
## 2273   16C 4.1        16    Cdx2     6.7100
## 2274   16C 4.2        16    Cdx2     3.9200
## 2275   16C 4.3        16    Cdx2     3.3650
## 2276   16C 4.4        16    Cdx2     2.8350
## 2277   16C 4.5        16    Cdx2     6.9800
## 2278   16C 4.6        16    Cdx2     5.6200
## 2279   16C 4.7        16    Cdx2     9.1650
## 2280   16C 4.8        16    Cdx2     5.5225
## 2281   16C 4.9        16    Cdx2     8.4000
## 2282  16C 4.10        16    Cdx2     5.2700
## 2283  16C 4.11        16    Cdx2     6.1550
## 2284  16C 4.12        16    Cdx2     3.7150
## 2285  16C 4.13        16    Cdx2     5.7650
## 2286  16C 4.14        16    Cdx2     3.2900
## 2287  16C 4.15        16    Cdx2     6.4700
## 2288  16C 4.16        16    Cdx2     6.8850
## 2289   16C 5.1        16    Cdx2     4.7400
## 2290   16C 5.2        16    Cdx2     5.2200
## 2291   16C 5.3        16    Cdx2     5.9850
## 2292   16C 5.4        16    Cdx2    -0.3450
## 2293   16C 5.5        16    Cdx2     2.6050
## 2294   16C 5.6        16    Cdx2     8.4350
## 2295   16C 5.7        16    Cdx2     3.7200
## 2296   16C 5.8        16    Cdx2     5.4900
## 2297   16C 5.9        16    Cdx2     5.4100
## 2298  16C 5.10        16    Cdx2     6.5900
## 2299  16C 5.11        16    Cdx2     5.2300
## 2300  16C 5.12        16    Cdx2     6.5950
## 2301   32C 1.1        32    Cdx2     3.0500
## 2302   32C 1.2        32    Cdx2     9.5050
## 2303   32C 1.3        32    Cdx2     3.3850
## 2304   32C 1.4        32    Cdx2     0.9400
## 2305   32C 1.5        32    Cdx2    10.6650
## 2306   32C 1.6        32    Cdx2     8.3200
## 2307   32C 1.7        32    Cdx2     5.3600
## 2308   32C 1.8        32    Cdx2     9.3600
## 2309   32C 1.9        32    Cdx2     8.0750
## 2310  32C 1.10        32    Cdx2     5.1100
## 2311  32C 1.11        32    Cdx2     1.6600
## 2312  32C 1.12        32    Cdx2     3.1450
## 2313  32C 1.13        32    Cdx2     6.0950
## 2314  32C 1.14        32    Cdx2     3.8500
## 2315  32C 1.15        32    Cdx2    14.2750
## 2316  32C 1.16        32    Cdx2     7.2800
## 2317  32C 1.17        32    Cdx2     6.8950
## 2318  32C 1.18        32    Cdx2     8.3100
## 2319  32C 1.19        32    Cdx2     8.5450
## 2320  32C 1.20        32    Cdx2     5.5050
## 2321  32C 1.21        32    Cdx2     4.2650
## 2322   32C 2.1        32    Cdx2     2.7750
## 2323   32C 2.2        32    Cdx2     8.2750
## 2324   32C 2.3        32    Cdx2     4.9950
## 2325   32C 2.4        32    Cdx2     7.0450
## 2326   32C 2.5        32    Cdx2    11.3800
## 2327   32C 2.6        32    Cdx2     5.2150
## 2328   32C 2.7        32    Cdx2     4.2450
## 2329   32C 2.8        32    Cdx2     7.2650
## 2330   32C 2.9        32    Cdx2     4.8300
## 2331  32C 2.10        32    Cdx2     4.4450
## 2332  32C 2.11        32    Cdx2    11.6000
## 2333  32C 2.12        32    Cdx2     5.4200
## 2334  32C 2.13        32    Cdx2     6.6600
## 2335  32C 2.14        32    Cdx2     7.6100
## 2336  32C 2.15        32    Cdx2     9.3600
## 2337  32C 2.16        32    Cdx2     8.1250
## 2338   32C 3.1        32    Cdx2     2.8850
## 2339   32C 3.2        32    Cdx2     3.1750
## 2340   32C 3.3        32    Cdx2     1.8650
## 2341   32C 3.4        32    Cdx2     4.9700
## 2342   32C 3.5        32    Cdx2     5.3650
## 2343   32C 3.6        32    Cdx2     7.2350
## 2344   32C 3.7        32    Cdx2     6.3700
## 2345   32C 3.8        32    Cdx2    10.0900
## 2346   32C 4.1        32    Cdx2     1.7250
## 2347   32C 4.2        32    Cdx2     3.1650
## 2348   32C 4.3        32    Cdx2     7.3800
## 2349   32C 4.4        32    Cdx2     7.0100
## 2350   32C 4.5        32    Cdx2     6.8750
## 2351   32C 4.6        32    Cdx2     8.3350
## 2352   32C 4.7        32    Cdx2     4.2650
## 2353   32C 4.8        32    Cdx2     3.1700
## 2354  32C 4.10        32    Cdx2     4.2950
## 2355  32C 4.11        32    Cdx2     5.2850
## 2356  32C 4.12        32    Cdx2     3.3900
## 2357  32C 4.13        32    Cdx2     1.9500
## 2358  32C 4.14        32    Cdx2     5.3250
## 2359  32C 4.15        32    Cdx2    10.2150
## 2360  32C 4.16        32    Cdx2     9.8300
## 2361  32C 4.17        32    Cdx2     4.4400
## 2362  32C 4.18        32    Cdx2     4.7200
## 2363  32C 4.19        32    Cdx2     3.9100
## 2364  32C 4.20        32    Cdx2     7.1250
## 2365  32C 4.21        32    Cdx2     4.8550
## 2366  32C 4.22        32    Cdx2     6.3950
## 2367  32C 4.23        32    Cdx2     1.6650
## 2368  32C 4.24        32    Cdx2     8.1150
## 2369   32C 5.1        32    Cdx2     6.0650
## 2370   32C 5.2        32    Cdx2     5.9800
## 2371   32C 5.3        32    Cdx2    10.9650
## 2372   32C 5.4        32    Cdx2     3.5100
## 2373   32C 5.5        32    Cdx2     6.8700
## 2374   32C 5.6        32    Cdx2     3.1150
## 2375   32C 5.7        32    Cdx2     3.7000
## 2376   32C 5.8        32    Cdx2    11.8100
## 2377   32C 5.9        32    Cdx2     5.7200
## 2378  32C 5.10        32    Cdx2     9.0450
## 2379  32C 5.11        32    Cdx2     5.4800
## 2380  32C 5.12        32    Cdx2     7.8000
## 2381  32C 5.13        32    Cdx2     2.9200
## 2382  32C 5.14        32    Cdx2     1.6750
## 2383  32C 5.15        32    Cdx2     1.1850
## 2384  32C 5.16        32    Cdx2     3.6900
## 2385  32C 5.17        32    Cdx2     4.3100
## 2386  32C 5.18        32    Cdx2     4.3350
## 2387  32C 5.19        32    Cdx2     8.5725
## 2388  32C 5.20        32    Cdx2     5.6100
## 2389  32C 5.21        32    Cdx2     3.3200
## 2390  32C 5.22        32    Cdx2     3.8450
## 2391  32C 5.23        32    Cdx2     2.1950
## 2392   32C 6.1        32    Cdx2     7.2700
## 2393   32C 6.2        32    Cdx2     1.4400
## 2394   32C 6.3        32    Cdx2     4.8900
## 2395   32C 6.4        32    Cdx2     7.6850
## 2396   32C 6.6        32    Cdx2     3.6200
## 2397   32C 6.7        32    Cdx2     5.3050
## 2398   32C 7.1        32    Cdx2     5.2100
## 2399   32C 7.2        32    Cdx2     1.7900
## 2400   32C 7.3        32    Cdx2     2.4050
## 2401   32C 7.4        32    Cdx2     4.2900
## 2402   32C 7.5        32    Cdx2     4.4950
## 2403   32C 7.6        32    Cdx2     5.7450
## 2404   32C 7.8        32    Cdx2     5.5200
## 2405   32C 8.1        32    Cdx2     5.4100
## 2406   32C 8.2        32    Cdx2     6.0800
## 2407   32C 8.4        32    Cdx2     3.6200
## 2408   32C 8.5        32    Cdx2     5.5550
## 2409   32C 8.6        32    Cdx2     2.2950
## 2410   64C 1.1        64    Cdx2    10.3250
## 2411   64C 1.2        64    Cdx2     1.3000
## 2412   64C 1.3        64    Cdx2     9.6650
## 2413   64C 1.4        64    Cdx2     9.2500
## 2414   64C 1.5        64    Cdx2     6.7500
## 2415   64C 1.6        64    Cdx2     9.1200
## 2416   64C 1.7        64    Cdx2     9.7250
## 2417   64C 1.8        64    Cdx2     4.2000
## 2418   64C 1.9        64    Cdx2     5.5100
## 2419  64C 1.10        64    Cdx2     3.6350
## 2420  64C 1.11        64    Cdx2     6.1150
## 2421  64C 1.12        64    Cdx2     7.4400
## 2422  64C 1.13        64    Cdx2     9.2150
## 2423  64C 1.14        64    Cdx2     6.8400
## 2424  64C 1.15        64    Cdx2     5.3650
## 2425  64C 1.16        64    Cdx2     7.2200
## 2426  64C 1.17        64    Cdx2     5.8550
## 2427  64C 1.18        64    Cdx2     5.0950
## 2428  64C 1.19        64    Cdx2     2.9250
## 2429  64C 1.20        64    Cdx2     4.0550
## 2430  64C 1.21        64    Cdx2     9.3950
## 2431  64C 1.22        64    Cdx2     8.4950
## 2432  64C 1.23        64    Cdx2     7.2050
## 2433  64C 1.24        64    Cdx2     7.6300
## 2434  64C 1.25        64    Cdx2     7.6050
## 2435  64C 1.26        64    Cdx2     6.1450
## 2436  64C 1.27        64    Cdx2     4.6050
## 2437  64C 1.28        64    Cdx2     5.2400
## 2438  64C 1.29        64    Cdx2     5.2050
## 2439  64C 1.30        64    Cdx2     7.4500
## 2440  64C 1.31        64    Cdx2     7.7900
## 2441  64C 1.32        64    Cdx2     4.2500
## 2442  64C 1.33        64    Cdx2     7.4300
## 2443  64C 1.34        64    Cdx2     9.7900
## 2444  64C 1.35        64    Cdx2     5.8950
## 2445  64C 1.36        64    Cdx2     3.9350
## 2446  64C 1.37        64    Cdx2     5.3150
## 2447  64C 1.38        64    Cdx2     3.3750
## 2448  64C 1.39        64    Cdx2     6.7000
## 2449  64C 1.40        64    Cdx2     6.4950
## 2450  64C 1.41        64    Cdx2     7.4650
## 2451  64C 1.42        64    Cdx2     3.5500
## 2452  64C 1.43        64    Cdx2     8.3600
## 2453  64C 1.44        64    Cdx2     4.9150
## 2454  64C 1.45        64    Cdx2     4.0150
## 2455  64C 1.46        64    Cdx2     5.9200
## 2456  64C 1.47        64    Cdx2     4.1100
## 2457  64C 1.48        64    Cdx2     6.9750
## 2458   64C 2.1        64    Cdx2     7.1650
## 2459   64C 2.2        64    Cdx2     6.3050
## 2460   64C 2.3        64    Cdx2     5.1700
## 2461   64C 2.4        64    Cdx2     5.6850
## 2462   64C 2.5        64    Cdx2     8.0350
## 2463   64C 2.6        64    Cdx2     4.5000
## 2464   64C 2.7        64    Cdx2     7.9900
## 2465   64C 2.8        64    Cdx2     5.9050
## 2466   64C 2.9        64    Cdx2     6.3150
## 2467  64C 2.10        64    Cdx2     6.7200
## 2468  64C 2.11        64    Cdx2     6.7400
## 2469  64C 2.12        64    Cdx2     7.1300
## 2470  64C 2.13        64    Cdx2     5.6200
## 2471  64C 2.14        64    Cdx2     2.7850
## 2472  64C 2.15        64    Cdx2     1.9850
## 2473  64C 2.16        64    Cdx2    12.1450
## 2474  64C 2.17        64    Cdx2     5.4850
## 2475  64C 2.18        64    Cdx2     6.9050
## 2476  64C 2.19        64    Cdx2     7.3050
## 2477  64C 2.20        64    Cdx2     7.1300
## 2478  64C 2.21        64    Cdx2     7.4650
## 2479  64C 2.22        64    Cdx2     5.9300
## 2480  64C 2.23        64    Cdx2     3.9900
## 2481  64C 2.24        64    Cdx2     4.0550
## 2482  64C 2.25        64    Cdx2     3.9400
## 2483   64C 3.1        64    Cdx2     4.7700
## 2484   64C 3.2        64    Cdx2     7.2300
## 2485   64C 3.3        64    Cdx2     6.4750
## 2486   64C 3.4        64    Cdx2     6.4100
## 2487   64C 3.5        64    Cdx2     8.3000
## 2488   64C 3.6        64    Cdx2     4.8500
## 2489   64C 3.7        64    Cdx2     4.4550
## 2490   64C 3.8        64    Cdx2     3.0550
## 2491   64C 4.1        64    Cdx2     6.9900
## 2492  64C 4.1b        64    Cdx2    12.3000
## 2493   64C 4.2        64    Cdx2     7.8450
## 2494   64C 4.3        64    Cdx2    11.9525
## 2495   64C 4.4        64    Cdx2    13.8100
## 2496   64C 4.5        64    Cdx2    11.9800
## 2497   64C 4.6        64    Cdx2     7.6850
## 2498   64C 4.7        64    Cdx2     2.4850
## 2499   64C 4.8        64    Cdx2     7.4250
## 2500   64C 4.9        64    Cdx2     3.6000
## 2501  64C 4.10        64    Cdx2     9.5400
## 2502  64C 4.11        64    Cdx2     9.4650
## 2503  64C 4.12        64    Cdx2     5.2700
## 2504  64C 4.13        64    Cdx2     4.4700
## 2505  64C 4.14        64    Cdx2     5.6850
## 2506  64C 4.15        64    Cdx2     2.1850
## 2507  64C 4.16        64    Cdx2    10.2250
## 2508  64C 4.17        64    Cdx2     5.2950
## 2509  64C 4.18        64    Cdx2     2.4400
## 2510  64C 4.19        64    Cdx2     4.7000
## 2511  64C 4.20        64    Cdx2     5.3200
## 2512  64C 4.21        64    Cdx2     5.2200
## 2513  64C 4.22        64    Cdx2     4.8400
## 2514  64C 4.23        64    Cdx2     3.7350
## 2515  64C 4.24        64    Cdx2     6.2100
## 2516  64C 4.25        64    Cdx2     2.4150
## 2517  64C 4.26        64    Cdx2     5.6050
## 2518  64C 4.27        64    Cdx2     1.3600
## 2519  64C 4.28        64    Cdx2     8.9850
## 2520  64C 4.29        64    Cdx2     5.5900
## 2521  64C 4.30        64    Cdx2    12.9700
## 2522  64C 4.31        64    Cdx2     9.5300
## 2523  64C 4.32        64    Cdx2     9.5850
## 2524  64C 4.33        64    Cdx2     3.7200
## 2525  64C 4.34        64    Cdx2     1.0700
## 2526  64C 4.35        64    Cdx2     7.8150
## 2527  64C 4.36        64    Cdx2     3.2650
## 2528  64C 4.37        64    Cdx2     6.1100
## 2529  64C 4.38        64    Cdx2     5.6850
## 2530  64C 4.39        64    Cdx2     7.1300
## 2531   64C 5.1        64    Cdx2     6.1050
## 2532   64C 5.2        64    Cdx2    14.4400
## 2533   64C 5.3        64    Cdx2     7.9050
## 2534   64C 5.4        64    Cdx2     3.3750
## 2535   64C 5.5        64    Cdx2     4.2250
## 2536   64C 5.6        64    Cdx2    11.5850
## 2537   64C 5.7        64    Cdx2    15.2850
## 2538   64C 5.8        64    Cdx2    13.8650
## 2539   64C 5.9        64    Cdx2     9.2350
## 2540  64C 5.10        64    Cdx2     9.5200
## 2541  64C 5.11        64    Cdx2     7.2550
## 2542  64C 5.12        64    Cdx2     4.5850
## 2543  64C 5.13        64    Cdx2     4.7150
## 2544  64C 5.14        64    Cdx2     4.2400
## 2545  64C 5.15        64    Cdx2     5.2350
## 2546  64C 5.16        64    Cdx2    10.0400
## 2547   64C 6.1        64    Cdx2    13.4100
## 2548   64C 6.2        64    Cdx2     7.2000
## 2549   64C 6.3        64    Cdx2    13.9100
## 2550   64C 6.4        64    Cdx2    10.9400
## 2551   64C 6.5        64    Cdx2    13.2950
## 2552   64C 6.6        64    Cdx2    11.4450
## 2553   64C 6.7        64    Cdx2     7.4450
## 2554   64C 6.8        64    Cdx2     5.6550
## 2555   64C 7.1        64    Cdx2     7.4700
## 2556   64C 7.2        64    Cdx2    12.6150
## 2557   64C 7.3        64    Cdx2    10.3850
## 2558   64C 7.4        64    Cdx2     9.9600
## 2559   64C 7.5        64    Cdx2    11.0400
## 2560   64C 7.6        64    Cdx2    11.5150
## 2561   64C 7.7        64    Cdx2    11.6750
## 2562   64C 7.8        64    Cdx2     9.3100
## 2563   64C 7.9        64    Cdx2    11.7300
## 2564  64C 7.10        64    Cdx2     5.0550
## 2565  64C 7.11        64    Cdx2     5.8950
## 2566  64C 7.12        64    Cdx2     4.2350
## 2567  64C 7.13        64    Cdx2     6.1900
## 2568  64C 7.14        64    Cdx2     5.8550
## 2569    2C 1.1         2 Creb312     7.0900
## 2570    2C 1.2         2 Creb312     5.2400
## 2571    2C 2.1         2 Creb312    12.3250
## 2572    2C 2.2         2 Creb312    11.6700
## 2573    2C 3.1         2 Creb312    14.3350
## 2574    2C 3.2         2 Creb312    10.2650
## 2575    2C 4.1         2 Creb312    12.5350
## 2576    2C 5.1         2 Creb312     8.3250
## 2577    2C 5.2         2 Creb312     6.5400
## 2578    2C 6.1         2 Creb312    12.4350
## 2579    2C 6.2         2 Creb312     5.9550
## 2580    2C 7.1         2 Creb312     7.5900
## 2581    2C 7.2         2 Creb312    12.4050
## 2582    2C 8.1         2 Creb312     8.3850
## 2583    2C 8.2         2 Creb312    13.9300
## 2584    2C 9.1         2 Creb312     8.9400
## 2585    2C 9.2         2 Creb312     8.8450
## 2586   2C 10.1         2 Creb312     8.3050
## 2587   2C 10.2         2 Creb312     6.0700
## 2588    4C 1.1         4 Creb312     7.4500
## 2589    4C 1.2         4 Creb312    11.6000
## 2590    4C 1.3         4 Creb312     8.7300
## 2591    4C 1.4         4 Creb312    13.2800
## 2592    4C 2.1         4 Creb312    12.2975
## 2593    4C 2.2         4 Creb312    12.7250
## 2594    4C 2.3         4 Creb312    12.0700
## 2595    4C 3.1         4 Creb312     7.4100
## 2596    4C 3.2         4 Creb312    11.2750
## 2597    4C 3.3         4 Creb312     9.0650
## 2598    4C 3.4         4 Creb312    12.8250
## 2599    4C 4.1         4 Creb312    13.2950
## 2600    4C 4.2         4 Creb312    13.6250
## 2601    4C 4.3         4 Creb312    12.0575
## 2602    4C 4.4         4 Creb312    14.2550
## 2603    4C 5.1         4 Creb312     9.4600
## 2604    4C 5.2         4 Creb312    12.7000
## 2605    4C 5.3         4 Creb312    10.3550
## 2606    4C 5.4         4 Creb312    12.1400
## 2607    4C 6.1         4 Creb312     5.7450
## 2608    4C 6.2         4 Creb312    12.8150
## 2609    4C 6.3         4 Creb312    13.5600
## 2610    4C 6.4         4 Creb312    12.7325
## 2611    8C 1.1         8 Creb312    13.5650
## 2612    8C 1.2         8 Creb312    11.6150
## 2613    8C 1.3         8 Creb312    12.4200
## 2614    8C 1.4         8 Creb312    10.4750
## 2615    8C 1.5         8 Creb312     9.1750
## 2616    8C 2.1         8 Creb312    11.6550
## 2617    8C 2.2         8 Creb312     8.9850
## 2618    8C 2.3         8 Creb312    10.0750
## 2619    8C 2.4         8 Creb312    12.5000
## 2620    8C 2.5         8 Creb312    14.3950
## 2621    8C 2.6         8 Creb312    13.1550
## 2622    8C 2.7         8 Creb312    11.4100
## 2623    8C 2.8         8 Creb312     9.5850
## 2624    8C 3.1         8 Creb312    10.6800
## 2625    8C 3.2         8 Creb312    10.3450
## 2626    8C 3.3         8 Creb312    13.4050
## 2627    8C 3.4         8 Creb312    14.0950
## 2628    8C 3.5         8 Creb312    12.8700
## 2629    8C 3.6         8 Creb312    15.0900
## 2630    8C 3.7         8 Creb312    14.0750
## 2631    8C 3.8         8 Creb312     9.1850
## 2632    8C 4.2         8 Creb312    10.5950
## 2633    8C 4.3         8 Creb312    11.2950
## 2634    8C 4.4         8 Creb312    10.8700
## 2635    8C 4.5         8 Creb312    12.5350
## 2636    8C 4.6         8 Creb312    13.9250
## 2637    8C 4.7         8 Creb312    12.1200
## 2638    8C 5.1         8 Creb312     9.9350
## 2639    8C 5.2         8 Creb312    13.9900
## 2640    8C 5.3         8 Creb312    11.9200
## 2641    8C 5.4         8 Creb312    11.9500
## 2642    8C 5.5         8 Creb312     9.0850
## 2643    8C 5.6         8 Creb312    10.6400
## 2644    8C 5.7         8 Creb312    14.3400
## 2645    8C 5.8         8 Creb312    13.3150
## 2646    8C 6.1         8 Creb312    12.6950
## 2647    8C 6.2         8 Creb312    14.4300
## 2648    8C 6.3         8 Creb312    13.4450
## 2649    8C 6.4         8 Creb312    11.9400
## 2650    8C 6.5         8 Creb312    11.1700
## 2651    8C 6.6         8 Creb312    11.8150
## 2652    8C 6.7         8 Creb312    12.2600
## 2653    8C 6.8         8 Creb312    13.5550
## 2654   16C 1.1        16 Creb312     9.3300
## 2655   16C 1.2        16 Creb312    13.2900
## 2656   16C 1.3        16 Creb312    14.0200
## 2657   16C 1.4        16 Creb312    13.0200
## 2658   16C 1.5        16 Creb312     8.4100
## 2659   16C 1.6        16 Creb312    11.5150
## 2660   16C 1.7        16 Creb312    12.3600
## 2661   16C 1.8        16 Creb312    11.6750
## 2662   16C 1.9        16 Creb312    15.0050
## 2663  16C 1.10        16 Creb312    13.3050
## 2664  16C 1.11        16 Creb312    13.6650
## 2665  16C 1.12        16 Creb312    11.1100
## 2666  16C 1.13        16 Creb312     8.9150
## 2667  16C 1.14        16 Creb312    11.7950
## 2668  16C 1.15        16 Creb312     4.6650
## 2669  16C 1.16        16 Creb312    13.1700
## 2670   16C 2.1        16 Creb312     6.6500
## 2671   16C 2.2        16 Creb312    14.0950
## 2672   16C 2.3        16 Creb312    14.0350
## 2673   16C 2.4        16 Creb312     7.0100
## 2674   16C 2.5        16 Creb312     8.5700
## 2675   16C 2.6        16 Creb312     9.4750
## 2676   16C 2.7        16 Creb312    11.7000
## 2677   16C 2.8        16 Creb312    11.3000
## 2678   16C 2.9        16 Creb312    12.3250
## 2679  16C 2.10        16 Creb312    11.6700
## 2680  16C 2.11        16 Creb312    14.3350
## 2681  16C 2.12        16 Creb312    13.7550
## 2682  16C 2.13        16 Creb312    12.5350
## 2683  16C 2.14        16 Creb312    13.8350
## 2684  16C 2.15        16 Creb312    12.9500
## 2685  16C 2.16        16 Creb312    12.4350
## 2686   16C 3.1        16 Creb312    11.5450
## 2687   16C 3.2        16 Creb312    13.9600
## 2688   16C 3.3        16 Creb312    12.4050
## 2689   16C 3.4        16 Creb312    14.1050
## 2690   16C 3.5        16 Creb312    13.9300
## 2691   16C 3.6        16 Creb312    13.4500
## 2692   16C 3.7        16 Creb312    13.0850
## 2693   16C 3.8        16 Creb312     7.6250
## 2694   16C 3.9        16 Creb312    11.7900
## 2695  16C 3.10        16 Creb312    11.5800
## 2696  16C 3.11        16 Creb312     6.5400
## 2697  16C 3.12        16 Creb312    12.6300
## 2698  16C 3.13        16 Creb312    13.2800
## 2699  16C 3.14        16 Creb312    12.2975
## 2700  16C 3.15        16 Creb312    12.7250
## 2701   16C 4.1        16 Creb312    12.0700
## 2702   16C 4.2        16 Creb312    12.1200
## 2703   16C 4.3        16 Creb312    11.2750
## 2704   16C 4.4        16 Creb312     9.0650
## 2705   16C 4.5        16 Creb312    12.8250
## 2706   16C 4.6        16 Creb312    13.2950
## 2707   16C 4.7        16 Creb312    13.6250
## 2708   16C 4.8        16 Creb312    12.0575
## 2709   16C 4.9        16 Creb312    14.2550
## 2710  16C 4.10        16 Creb312    12.2000
## 2711  16C 4.11        16 Creb312    12.7000
## 2712  16C 4.12        16 Creb312    10.3550
## 2713  16C 4.13        16 Creb312    12.1400
## 2714  16C 4.14        16 Creb312    10.7950
## 2715  16C 4.15        16 Creb312    12.8150
## 2716  16C 4.16        16 Creb312    13.5600
## 2717   16C 5.1        16 Creb312    12.7325
## 2718   16C 5.2        16 Creb312    13.5650
## 2719   16C 5.3        16 Creb312    11.6150
## 2720   16C 5.4        16 Creb312    12.4200
## 2721   16C 5.5        16 Creb312    10.4750
## 2722   16C 5.6        16 Creb312    12.3650
## 2723   16C 5.7        16 Creb312    11.6550
## 2724   16C 5.8        16 Creb312    12.8950
## 2725   16C 5.9        16 Creb312    13.8650
## 2726  16C 5.10        16 Creb312    12.5000
## 2727  16C 5.11        16 Creb312    14.3950
## 2728  16C 5.12        16 Creb312    13.1550
## 2729   32C 1.1        32 Creb312    11.4100
## 2730   32C 1.2        32 Creb312     4.8950
## 2731   32C 1.3        32 Creb312    10.6800
## 2732   32C 1.4        32 Creb312    10.3450
## 2733   32C 1.5        32 Creb312     8.2850
## 2734   32C 1.6        32 Creb312     6.2850
## 2735   32C 1.7        32 Creb312     9.0100
## 2736   32C 1.8        32 Creb312     6.1600
## 2737   32C 1.9        32 Creb312     6.1050
## 2738  32C 1.10        32 Creb312    -0.3950
## 2739  32C 1.11        32 Creb312    10.5950
## 2740  32C 1.12        32 Creb312    11.2950
## 2741  32C 1.13        32 Creb312     2.3400
## 2742  32C 1.14        32 Creb312     7.2350
## 2743  32C 1.15        32 Creb312     7.3050
## 2744  32C 1.16        32 Creb312     4.9900
## 2745  32C 1.17        32 Creb312     4.2850
## 2746  32C 1.18        32 Creb312    13.9900
## 2747  32C 1.19        32 Creb312     6.2500
## 2748  32C 1.20        32 Creb312     3.0600
## 2749  32C 1.21        32 Creb312     7.4050
## 2750   32C 2.1        32 Creb312     6.1300
## 2751   32C 2.2        32 Creb312    14.3400
## 2752   32C 2.3        32 Creb312    13.3150
## 2753   32C 2.4        32 Creb312     7.1850
## 2754   32C 2.5        32 Creb312     9.5800
## 2755   32C 2.6        32 Creb312    13.4450
## 2756   32C 2.7        32 Creb312     7.9200
## 2757   32C 2.8        32 Creb312     6.2100
## 2758   32C 2.9        32 Creb312    11.8150
## 2759  32C 2.10        32 Creb312     8.3900
## 2760  32C 2.11        32 Creb312     8.7150
## 2761  32C 2.12        32 Creb312    13.5000
## 2762  32C 2.13        32 Creb312     8.1800
## 2763  32C 2.14        32 Creb312     9.4900
## 2764  32C 2.15        32 Creb312     4.8900
## 2765  32C 2.16        32 Creb312     5.5100
## 2766   32C 3.1        32 Creb312    11.5150
## 2767   32C 3.2        32 Creb312     7.5400
## 2768   32C 3.3        32 Creb312     6.8550
## 2769   32C 3.4        32 Creb312     9.8050
## 2770   32C 3.5        32 Creb312    13.3050
## 2771   32C 3.6        32 Creb312     7.0050
## 2772   32C 3.7        32 Creb312    10.7000
## 2773   32C 3.8        32 Creb312     5.6950
## 2774   32C 4.1        32 Creb312     7.5850
## 2775   32C 4.2        32 Creb312     4.3950
## 2776   32C 4.3        32 Creb312     6.7500
## 2777   32C 4.4        32 Creb312     4.2300
## 2778   32C 4.5        32 Creb312     6.3550
## 2779   32C 4.6        32 Creb312     8.4550
## 2780   32C 4.7        32 Creb312    11.7500
## 2781   32C 4.8        32 Creb312     9.8800
## 2782  32C 4.10        32 Creb312     9.7450
## 2783  32C 4.11        32 Creb312     7.5000
## 2784  32C 4.12        32 Creb312     6.8600
## 2785  32C 4.13        32 Creb312     7.3950
## 2786  32C 4.14        32 Creb312     4.7100
## 2787  32C 4.15        32 Creb312     7.0550
## 2788  32C 4.16        32 Creb312     5.3250
## 2789  32C 4.17        32 Creb312    12.5350
## 2790  32C 4.18        32 Creb312     9.1450
## 2791  32C 4.19        32 Creb312     7.9800
## 2792  32C 4.20        32 Creb312     4.6550
## 2793  32C 4.21        32 Creb312     7.5250
## 2794  32C 4.22        32 Creb312     6.0400
## 2795  32C 4.23        32 Creb312     9.5650
## 2796  32C 4.24        32 Creb312     7.5350
## 2797   32C 5.1        32 Creb312     8.0100
## 2798   32C 5.2        32 Creb312     8.4800
## 2799   32C 5.3        32 Creb312     9.1850
## 2800   32C 5.4        32 Creb312    12.2750
## 2801   32C 5.5        32 Creb312    11.7900
## 2802   32C 5.6        32 Creb312    11.5800
## 2803   32C 5.7        32 Creb312    11.6000
## 2804   32C 5.8        32 Creb312     5.0800
## 2805   32C 5.9        32 Creb312     9.4800
## 2806  32C 5.10        32 Creb312     4.3275
## 2807  32C 5.11        32 Creb312    12.7250
## 2808  32C 5.12        32 Creb312     5.9500
## 2809  32C 5.13        32 Creb312    12.1200
## 2810  32C 5.14        32 Creb312    11.2750
## 2811  32C 5.15        32 Creb312     4.0950
## 2812  32C 5.16        32 Creb312    12.8250
## 2813  32C 5.17        32 Creb312    13.2950
## 2814  32C 5.18        32 Creb312    13.6250
## 2815  32C 5.19        32 Creb312    12.0575
## 2816  32C 5.20        32 Creb312    10.5750
## 2817  32C 5.21        32 Creb312    12.2000
## 2818  32C 5.22        32 Creb312    12.7000
## 2819  32C 5.23        32 Creb312    10.3550
## 2820   32C 6.1        32 Creb312     5.0050
## 2821   32C 6.2        32 Creb312     6.6250
## 2822   32C 6.3        32 Creb312    12.8150
## 2823   32C 6.4        32 Creb312     8.2650
## 2824   32C 6.6        32 Creb312     9.2825
## 2825   32C 6.7        32 Creb312     8.9250
## 2826   32C 7.1        32 Creb312     7.6350
## 2827   32C 7.2        32 Creb312     9.2300
## 2828   32C 7.3        32 Creb312    10.4750
## 2829   32C 7.4        32 Creb312    12.3650
## 2830   32C 7.5        32 Creb312     7.9400
## 2831   32C 7.6        32 Creb312    12.8950
## 2832   32C 7.8        32 Creb312    13.8650
## 2833   32C 8.1        32 Creb312    12.5000
## 2834   32C 8.2        32 Creb312     9.8250
## 2835   32C 8.4        32 Creb312     8.8600
## 2836   32C 8.5        32 Creb312     7.1300
## 2837   32C 8.6        32 Creb312     6.7150
## 2838   64C 1.1        64 Creb312     2.3000
## 2839   64C 1.2        64 Creb312    10.3450
## 2840   64C 1.3        64 Creb312    13.4050
## 2841   64C 1.4        64 Creb312     6.8650
## 2842   64C 1.5        64 Creb312     3.2500
## 2843   64C 1.6        64 Creb312    15.0900
## 2844   64C 1.7        64 Creb312     5.6550
## 2845   64C 1.8        64 Creb312     9.1850
## 2846   64C 1.9        64 Creb312     4.3550
## 2847  64C 1.10        64 Creb312    11.2950
## 2848  64C 1.11        64 Creb312     3.3100
## 2849  64C 1.12        64 Creb312    12.5350
## 2850  64C 1.13        64 Creb312     7.3650
## 2851  64C 1.14        64 Creb312    12.1200
## 2852  64C 1.15        64 Creb312    13.1350
## 2853  64C 1.16        64 Creb312    13.9900
## 2854  64C 1.17        64 Creb312    11.9200
## 2855  64C 1.18        64 Creb312     8.0800
## 2856  64C 1.19        64 Creb312     9.7550
## 2857  64C 1.20        64 Creb312    10.6400
## 2858  64C 1.21        64 Creb312     7.0300
## 2859  64C 1.22        64 Creb312     8.9950
## 2860  64C 1.23        64 Creb312     8.8050
## 2861  64C 1.24        64 Creb312    10.8600
## 2862  64C 1.25        64 Creb312    13.4450
## 2863  64C 1.26        64 Creb312     4.2600
## 2864  64C 1.27        64 Creb312    11.1700
## 2865  64C 1.28        64 Creb312    11.8150
## 2866  64C 1.29        64 Creb312    12.2600
## 2867  64C 1.30        64 Creb312     8.2850
## 2868  64C 1.31        64 Creb312    13.5000
## 2869  64C 1.32        64 Creb312    13.2900
## 2870  64C 1.33        64 Creb312    14.0200
## 2871  64C 1.34        64 Creb312    13.0200
## 2872  64C 1.35        64 Creb312    12.1900
## 2873  64C 1.36        64 Creb312     6.9450
## 2874  64C 1.37        64 Creb312    12.3600
## 2875  64C 1.38        64 Creb312    11.6750
## 2876  64C 1.39        64 Creb312    15.0050
## 2877  64C 1.40        64 Creb312    13.3050
## 2878  64C 1.41        64 Creb312     8.3550
## 2879  64C 1.42        64 Creb312    10.5700
## 2880  64C 1.43        64 Creb312     5.4450
## 2881  64C 1.44        64 Creb312    11.7950
## 2882  64C 1.45        64 Creb312     9.5250
## 2883  64C 1.46        64 Creb312    13.1700
## 2884  64C 1.47        64 Creb312    11.3100
## 2885  64C 1.48        64 Creb312    14.0950
## 2886   64C 2.1        64 Creb312    14.0350
## 2887   64C 2.2        64 Creb312     7.2600
## 2888   64C 2.3        64 Creb312    13.7500
## 2889   64C 2.4        64 Creb312    13.9650
## 2890   64C 2.5        64 Creb312     3.6000
## 2891   64C 2.6        64 Creb312    11.3000
## 2892   64C 2.7        64 Creb312     5.4850
## 2893   64C 2.8        64 Creb312     6.2300
## 2894   64C 2.9        64 Creb312    14.3350
## 2895  64C 2.10        64 Creb312    13.7550
## 2896  64C 2.11        64 Creb312    10.5550
## 2897  64C 2.12        64 Creb312    13.8350
## 2898  64C 2.13        64 Creb312    12.9500
## 2899  64C 2.14        64 Creb312    12.4350
## 2900  64C 2.15        64 Creb312    11.5450
## 2901  64C 2.16        64 Creb312     8.5000
## 2902  64C 2.17        64 Creb312     4.8950
## 2903  64C 2.18        64 Creb312    14.1050
## 2904  64C 2.19        64 Creb312     9.5100
## 2905  64C 2.20        64 Creb312    13.4500
## 2906  64C 2.21        64 Creb312    13.0850
## 2907  64C 2.22        64 Creb312    12.2750
## 2908  64C 2.23        64 Creb312    11.7900
## 2909  64C 2.24        64 Creb312    11.5800
## 2910  64C 2.25        64 Creb312    11.6000
## 2911   64C 3.1        64 Creb312     9.0000
## 2912   64C 3.2        64 Creb312    13.2800
## 2913   64C 3.3        64 Creb312    12.2975
## 2914   64C 3.4        64 Creb312    12.7250
## 2915   64C 3.5        64 Creb312     3.7600
## 2916   64C 3.6        64 Creb312    12.1200
## 2917   64C 3.7        64 Creb312    11.2750
## 2918   64C 3.8        64 Creb312     9.0650
## 2919   64C 4.1        64 Creb312     4.0750
## 2920  64C 4.1b        64 Creb312     7.5450
## 2921   64C 4.2        64 Creb312    13.6250
## 2922   64C 4.3        64 Creb312     3.9175
## 2923   64C 4.4        64 Creb312     7.7250
## 2924   64C 4.5        64 Creb312     4.6900
## 2925   64C 4.6        64 Creb312     5.7700
## 2926   64C 4.7        64 Creb312    10.3550
## 2927   64C 4.8        64 Creb312     3.7300
## 2928   64C 4.9        64 Creb312    10.7950
## 2929  64C 4.10        64 Creb312     7.2350
## 2930  64C 4.11        64 Creb312    13.5600
## 2931  64C 4.12        64 Creb312    12.7325
## 2932  64C 4.13        64 Creb312    13.5650
## 2933  64C 4.14        64 Creb312    11.6150
## 2934  64C 4.15        64 Creb312    12.4200
## 2935  64C 4.16        64 Creb312    10.4750
## 2936  64C 4.17        64 Creb312     7.2450
## 2937  64C 4.18        64 Creb312    11.6550
## 2938  64C 4.19        64 Creb312    12.8950
## 2939  64C 4.20        64 Creb312    13.8650
## 2940  64C 4.21        64 Creb312     7.7400
## 2941  64C 4.22        64 Creb312     9.4050
## 2942  64C 4.23        64 Creb312    13.1550
## 2943  64C 4.24        64 Creb312    11.4100
## 2944  64C 4.25        64 Creb312     9.5850
## 2945  64C 4.26        64 Creb312     2.3300
## 2946  64C 4.27        64 Creb312     5.6750
## 2947  64C 4.28        64 Creb312     5.9050
## 2948  64C 4.29        64 Creb312    14.0950
## 2949  64C 4.30        64 Creb312     3.4200
## 2950  64C 4.31        64 Creb312    15.0900
## 2951  64C 4.32        64 Creb312    14.0750
## 2952  64C 4.33        64 Creb312     9.1850
## 2953  64C 4.34        64 Creb312    10.5950
## 2954  64C 4.35        64 Creb312     2.8150
## 2955  64C 4.36        64 Creb312    10.8700
## 2956  64C 4.37        64 Creb312    12.5350
## 2957  64C 4.38        64 Creb312    13.9250
## 2958  64C 4.39        64 Creb312    12.1200
## 2959   64C 5.1        64 Creb312    13.1350
## 2960   64C 5.2        64 Creb312     5.2700
## 2961   64C 5.3        64 Creb312     3.7400
## 2962   64C 5.4        64 Creb312     7.8100
## 2963   64C 5.5        64 Creb312     3.4850
## 2964   64C 5.6        64 Creb312     2.3500
## 2965   64C 5.7        64 Creb312     6.0100
## 2966   64C 5.8        64 Creb312     8.4150
## 2967   64C 5.9        64 Creb312     4.7450
## 2968  64C 5.10        64 Creb312     6.2200
## 2969  64C 5.11        64 Creb312    13.4450
## 2970  64C 5.12        64 Creb312    11.9400
## 2971  64C 5.13        64 Creb312     6.7000
## 2972  64C 5.14        64 Creb312    11.8150
## 2973  64C 5.15        64 Creb312    12.2600
## 2974  64C 5.16        64 Creb312     8.9750
## 2975   64C 6.1        64 Creb312     5.0000
## 2976   64C 6.2        64 Creb312    13.2900
## 2977   64C 6.3        64 Creb312    14.0200
## 2978   64C 6.4        64 Creb312     8.5600
## 2979   64C 6.5        64 Creb312    12.1900
## 2980   64C 6.6        64 Creb312    11.5150
## 2981   64C 6.7        64 Creb312     4.1500
## 2982   64C 6.8        64 Creb312     8.3950
## 2983   64C 7.1        64 Creb312     7.9650
## 2984   64C 7.2        64 Creb312     5.9950
## 2985   64C 7.3        64 Creb312     9.3150
## 2986   64C 7.4        64 Creb312     7.1000
## 2987   64C 7.5        64 Creb312     4.3450
## 2988   64C 7.6        64 Creb312     4.4350
## 2989   64C 7.7        64 Creb312     1.4750
## 2990   64C 7.8        64 Creb312     8.8500
## 2991   64C 7.9        64 Creb312     3.1600
## 2992  64C 7.10        64 Creb312     9.6150
## 2993  64C 7.11        64 Creb312    14.0350
## 2994  64C 7.12        64 Creb312    11.7500
## 2995  64C 7.13        64 Creb312    13.7500
## 2996  64C 7.14        64 Creb312    14.7950
## 2997    2C 1.1         2   Cebpa    12.0900
## 2998    2C 1.2         2   Cebpa     2.8850
## 2999    2C 2.1         2   Cebpa     5.4000
## 3000    2C 2.2         2   Cebpa     6.4400
## 3001    2C 3.1         2   Cebpa    14.2350
## 3002    2C 3.2         2   Cebpa     7.6500
## 3003    2C 4.1         2   Cebpa    14.3950
## 3004    2C 5.1         2   Cebpa     6.9100
## 3005    2C 5.2         2   Cebpa     6.1400
## 3006    2C 6.1         2   Cebpa     5.2950
## 3007    2C 6.2         2   Cebpa     4.4350
## 3008    2C 7.1         2   Cebpa     4.5550
## 3009    2C 7.2         2   Cebpa    10.9800
## 3010    2C 8.1         2   Cebpa    14.1900
## 3011    2C 8.2         2   Cebpa    13.0850
## 3012    2C 9.1         2   Cebpa     6.3350
## 3013    2C 9.2         2   Cebpa     5.1400
## 3014   2C 10.1         2   Cebpa    12.1000
## 3015   2C 10.2         2   Cebpa     9.1150
## 3016    4C 1.1         4   Cebpa     3.1050
## 3017    4C 1.2         4   Cebpa    11.5650
## 3018    4C 1.3         4   Cebpa     3.8850
## 3019    4C 1.4         4   Cebpa     5.6300
## 3020    4C 2.1         4   Cebpa     7.5350
## 3021    4C 2.2         4   Cebpa    15.2400
## 3022    4C 2.3         4   Cebpa     4.9900
## 3023    4C 3.1         4   Cebpa     5.4550
## 3024    4C 3.2         4   Cebpa     2.5650
## 3025    4C 3.3         4   Cebpa     3.1250
## 3026    4C 3.4         4   Cebpa     5.7950
## 3027    4C 4.1         4   Cebpa    13.3750
## 3028    4C 4.2         4   Cebpa     7.3100
## 3029    4C 4.3         4   Cebpa     7.5750
## 3030    4C 4.4         4   Cebpa     6.9700
## 3031    4C 5.1         4   Cebpa    11.2600
## 3032    4C 5.2         4   Cebpa     6.7750
## 3033    4C 5.3         4   Cebpa     5.1350
## 3034    4C 5.4         4   Cebpa     6.4750
## 3035    4C 6.1         4   Cebpa     4.4550
## 3036    4C 6.2         4   Cebpa     5.6700
## 3037    4C 6.3         4   Cebpa     6.1350
## 3038    4C 6.4         4   Cebpa    13.4025
## 3039    8C 1.1         8   Cebpa     9.3000
## 3040    8C 1.2         8   Cebpa     8.1100
## 3041    8C 1.3         8   Cebpa     6.8600
## 3042    8C 1.4         8   Cebpa     4.3000
## 3043    8C 1.5         8   Cebpa     7.4550
## 3044    8C 2.1         8   Cebpa     5.6500
## 3045    8C 2.2         8   Cebpa     6.3700
## 3046    8C 2.3         8   Cebpa    10.3250
## 3047    8C 2.4         8   Cebpa    12.0825
## 3048    8C 2.5         8   Cebpa     5.8650
## 3049    8C 2.6         8   Cebpa     7.8850
## 3050    8C 2.7         8   Cebpa     4.7850
## 3051    8C 2.8         8   Cebpa     3.2350
## 3052    8C 3.1         8   Cebpa     8.3750
## 3053    8C 3.2         8   Cebpa     9.7950
## 3054    8C 3.3         8   Cebpa     7.1400
## 3055    8C 3.4         8   Cebpa     7.4400
## 3056    8C 3.5         8   Cebpa     5.1900
## 3057    8C 3.6         8   Cebpa     8.2950
## 3058    8C 3.7         8   Cebpa     6.2400
## 3059    8C 3.8         8   Cebpa     6.4050
## 3060    8C 4.2         8   Cebpa    11.2100
## 3061    8C 4.3         8   Cebpa     4.4850
## 3062    8C 4.4         8   Cebpa     4.6300
## 3063    8C 4.5         8   Cebpa     6.7800
## 3064    8C 4.6         8   Cebpa     7.4050
## 3065    8C 4.7         8   Cebpa     3.8800
## 3066    8C 5.1         8   Cebpa    13.3950
## 3067    8C 5.2         8   Cebpa     9.6900
## 3068    8C 5.3         8   Cebpa     4.0500
## 3069    8C 5.4         8   Cebpa     3.6200
## 3070    8C 5.5         8   Cebpa     7.4550
## 3071    8C 5.6         8   Cebpa     6.8300
## 3072    8C 5.7         8   Cebpa     7.5000
## 3073    8C 5.8         8   Cebpa     6.8000
## 3074    8C 6.1         8   Cebpa     7.0850
## 3075    8C 6.2         8   Cebpa     7.9900
## 3076    8C 6.3         8   Cebpa     9.4300
## 3077    8C 6.4         8   Cebpa     4.5950
## 3078    8C 6.5         8   Cebpa     5.9800
## 3079    8C 6.6         8   Cebpa     8.7550
## 3080    8C 6.7         8   Cebpa     6.2400
## 3081    8C 6.8         8   Cebpa    14.7350
## 3082   16C 1.1        16   Cebpa     7.7300
## 3083   16C 1.2        16   Cebpa     6.1950
## 3084   16C 1.3        16   Cebpa    14.8100
## 3085   16C 1.4        16   Cebpa     9.6150
## 3086   16C 1.5        16   Cebpa     6.3850
## 3087   16C 1.6        16   Cebpa     4.6950
## 3088   16C 1.7        16   Cebpa    12.4150
## 3089   16C 1.8        16   Cebpa     4.3100
## 3090   16C 1.9        16   Cebpa     7.1500
## 3091  16C 1.10        16   Cebpa     4.6050
## 3092  16C 1.11        16   Cebpa     6.8050
## 3093  16C 1.12        16   Cebpa    11.7600
## 3094  16C 1.13        16   Cebpa     6.2650
## 3095  16C 1.14        16   Cebpa     2.6850
## 3096  16C 1.15        16   Cebpa     4.1100
## 3097  16C 1.16        16   Cebpa    10.4500
## 3098   16C 2.1        16   Cebpa    11.7000
## 3099   16C 2.2        16   Cebpa     9.2300
## 3100   16C 2.3        16   Cebpa    10.0650
## 3101   16C 2.4        16   Cebpa    11.6700
## 3102   16C 2.5        16   Cebpa     6.5900
## 3103   16C 2.6        16   Cebpa    11.7800
## 3104   16C 2.7        16   Cebpa     4.6500
## 3105   16C 2.8        16   Cebpa     2.8450
## 3106   16C 2.9        16   Cebpa     5.8300
## 3107  16C 2.10        16   Cebpa     5.2500
## 3108  16C 2.11        16   Cebpa     6.8850
## 3109  16C 2.12        16   Cebpa    10.9100
## 3110  16C 2.13        16   Cebpa     9.8750
## 3111  16C 2.14        16   Cebpa     7.1000
## 3112  16C 2.15        16   Cebpa     5.9900
## 3113  16C 2.16        16   Cebpa     6.0150
## 3114   16C 3.1        16   Cebpa    11.5450
## 3115   16C 3.2        16   Cebpa    10.8650
## 3116   16C 3.3        16   Cebpa    10.9800
## 3117   16C 3.4        16   Cebpa    14.1900
## 3118   16C 3.5        16   Cebpa     8.7750
## 3119   16C 3.6        16   Cebpa    13.9450
## 3120   16C 3.7        16   Cebpa    13.1700
## 3121   16C 3.8        16   Cebpa    12.1000
## 3122   16C 3.9        16   Cebpa    11.5150
## 3123  16C 3.10        16   Cebpa     8.3950
## 3124  16C 3.11        16   Cebpa    11.5650
## 3125  16C 3.12        16   Cebpa    11.3750
## 3126  16C 3.13        16   Cebpa    13.6700
## 3127  16C 3.14        16   Cebpa     7.8250
## 3128  16C 3.15        16   Cebpa    15.2400
## 3129   16C 4.1        16   Cebpa    11.7400
## 3130   16C 4.2        16   Cebpa    12.2750
## 3131   16C 4.3        16   Cebpa    10.6750
## 3132   16C 4.4        16   Cebpa     4.9650
## 3133   16C 4.5        16   Cebpa     6.6750
## 3134   16C 4.6        16   Cebpa     8.3750
## 3135   16C 4.7        16   Cebpa     7.1200
## 3136   16C 4.8        16   Cebpa    13.1050
## 3137   16C 4.9        16   Cebpa     7.7800
## 3138  16C 4.10        16   Cebpa    11.2600
## 3139  16C 4.11        16   Cebpa     6.7950
## 3140  16C 4.12        16   Cebpa    10.4450
## 3141  16C 4.13        16   Cebpa     4.5750
## 3142  16C 4.14        16   Cebpa     5.2350
## 3143  16C 4.15        16   Cebpa     5.7200
## 3144  16C 4.16        16   Cebpa     7.4350
## 3145   16C 5.1        16   Cebpa     5.8425
## 3146   16C 5.2        16   Cebpa    12.2800
## 3147   16C 5.3        16   Cebpa    13.0100
## 3148   16C 5.4        16   Cebpa     5.1300
## 3149   16C 5.5        16   Cebpa    10.3100
## 3150   16C 5.6        16   Cebpa     7.7850
## 3151   16C 5.7        16   Cebpa     4.4100
## 3152   16C 5.8        16   Cebpa    13.3600
## 3153   16C 5.9        16   Cebpa     7.1650
## 3154  16C 5.10        16   Cebpa    12.0825
## 3155  16C 5.11        16   Cebpa     7.9150
## 3156  16C 5.12        16   Cebpa     9.6050
## 3157   32C 1.1        32   Cebpa     6.9250
## 3158   32C 1.2        32   Cebpa     9.4650
## 3159   32C 1.3        32   Cebpa     5.6950
## 3160   32C 1.4        32   Cebpa     2.8350
## 3161   32C 1.5        32   Cebpa     7.6900
## 3162   32C 1.6        32   Cebpa    13.7500
## 3163   32C 1.7        32   Cebpa     6.5100
## 3164   32C 1.8        32   Cebpa    13.8850
## 3165   32C 1.9        32   Cebpa    13.1300
## 3166  32C 1.10        32   Cebpa     9.5050
## 3167  32C 1.11        32   Cebpa     7.0600
## 3168  32C 1.12        32   Cebpa     4.8450
## 3169  32C 1.13        32   Cebpa    10.9100
## 3170  32C 1.14        32   Cebpa     5.6900
## 3171  32C 1.15        32   Cebpa    13.5550
## 3172  32C 1.16        32   Cebpa     9.9500
## 3173  32C 1.17        32   Cebpa    13.3950
## 3174  32C 1.18        32   Cebpa    14.0200
## 3175  32C 1.19        32   Cebpa    11.8600
## 3176  32C 1.20        32   Cebpa    11.6300
## 3177  32C 1.21        32   Cebpa    12.1650
## 3178   32C 2.1        32   Cebpa     5.5100
## 3179   32C 2.2        32   Cebpa     8.1700
## 3180   32C 2.3        32   Cebpa    14.1500
## 3181   32C 2.4        32   Cebpa     5.2450
## 3182   32C 2.5        32   Cebpa    14.0100
## 3183   32C 2.6        32   Cebpa     7.9900
## 3184   32C 2.7        32   Cebpa     7.7150
## 3185   32C 2.8        32   Cebpa    11.2900
## 3186   32C 2.9        32   Cebpa    11.8950
## 3187  32C 2.10        32   Cebpa     5.7900
## 3188  32C 2.11        32   Cebpa    14.7350
## 3189  32C 2.12        32   Cebpa    13.0900
## 3190  32C 2.13        32   Cebpa    13.3850
## 3191  32C 2.14        32   Cebpa    14.8100
## 3192  32C 2.15        32   Cebpa    14.4450
## 3193  32C 2.16        32   Cebpa    12.3950
## 3194   32C 3.1        32   Cebpa    12.1750
## 3195   32C 3.2        32   Cebpa    12.4150
## 3196   32C 3.3        32   Cebpa     7.6400
## 3197   32C 3.4        32   Cebpa     6.6900
## 3198   32C 3.5        32   Cebpa     6.4950
## 3199   32C 3.6        32   Cebpa    13.2550
## 3200   32C 3.7        32   Cebpa    14.6800
## 3201   32C 3.8        32   Cebpa    13.8750
## 3202   32C 4.1        32   Cebpa    11.1850
## 3203   32C 4.2        32   Cebpa     9.0200
## 3204   32C 4.3        32   Cebpa     8.1100
## 3205   32C 4.4        32   Cebpa    11.7000
## 3206   32C 4.5        32   Cebpa    14.3100
## 3207   32C 4.6        32   Cebpa    13.5650
## 3208   32C 4.7        32   Cebpa    11.6700
## 3209   32C 4.8        32   Cebpa     7.7800
## 3210  32C 4.10        32   Cebpa    14.7300
## 3211  32C 4.11        32   Cebpa     6.1500
## 3212  32C 4.12        32   Cebpa     9.6850
## 3213  32C 4.13        32   Cebpa     7.9700
## 3214  32C 4.14        32   Cebpa    12.6600
## 3215  32C 4.15        32   Cebpa     9.3450
## 3216  32C 4.16        32   Cebpa    12.9600
## 3217  32C 4.17        32   Cebpa    14.3950
## 3218  32C 4.18        32   Cebpa     7.3100
## 3219  32C 4.19        32   Cebpa     5.6200
## 3220  32C 4.20        32   Cebpa    12.4350
## 3221  32C 4.21        32   Cebpa     7.3950
## 3222  32C 4.22        32   Cebpa    10.8650
## 3223  32C 4.23        32   Cebpa     4.1600
## 3224  32C 4.24        32   Cebpa    14.1900
## 3225   32C 5.1        32   Cebpa    13.0850
## 3226   32C 5.2        32   Cebpa    13.9450
## 3227   32C 5.3        32   Cebpa    13.1700
## 3228   32C 5.4        32   Cebpa     5.7200
## 3229   32C 5.5        32   Cebpa    11.5150
## 3230   32C 5.6        32   Cebpa     8.3950
## 3231   32C 5.7        32   Cebpa    11.5650
## 3232   32C 5.8        32   Cebpa    11.3750
## 3233   32C 5.9        32   Cebpa     9.8200
## 3234  32C 5.10        32   Cebpa     8.3750
## 3235  32C 5.11        32   Cebpa    15.2400
## 3236  32C 5.12        32   Cebpa    11.7400
## 3237  32C 5.13        32   Cebpa    12.2750
## 3238  32C 5.14        32   Cebpa     4.1950
## 3239  32C 5.15        32   Cebpa    11.5250
## 3240  32C 5.16        32   Cebpa     6.7750
## 3241  32C 5.17        32   Cebpa     6.1750
## 3242  32C 5.18        32   Cebpa    12.0400
## 3243  32C 5.19        32   Cebpa    13.1050
## 3244  32C 5.20        32   Cebpa    13.8700
## 3245  32C 5.21        32   Cebpa     6.0000
## 3246  32C 5.22        32   Cebpa    12.5750
## 3247  32C 5.23        32   Cebpa    10.4450
## 3248   32C 6.1        32   Cebpa     7.7000
## 3249   32C 6.2        32   Cebpa     5.4000
## 3250   32C 6.3        32   Cebpa     7.5200
## 3251   32C 6.4        32   Cebpa     7.8550
## 3252   32C 6.6        32   Cebpa     7.2925
## 3253   32C 6.7        32   Cebpa    12.2800
## 3254   32C 7.1        32   Cebpa     7.6500
## 3255   32C 7.2        32   Cebpa    12.2600
## 3256   32C 7.3        32   Cebpa     4.8700
## 3257   32C 7.4        32   Cebpa     9.0750
## 3258   32C 7.5        32   Cebpa    11.2000
## 3259   32C 7.6        32   Cebpa    13.3600
## 3260   32C 7.8        32   Cebpa     8.9450
## 3261   32C 8.1        32   Cebpa    12.0825
## 3262   32C 8.2        32   Cebpa    14.2450
## 3263   32C 8.4        32   Cebpa    13.9850
## 3264   32C 8.5        32   Cebpa     6.7450
## 3265   32C 8.6        32   Cebpa     9.4650
## 3266   64C 1.1        64   Cebpa    11.1450
## 3267   64C 1.2        64   Cebpa     3.0350
## 3268   64C 1.3        64   Cebpa    12.9200
## 3269   64C 1.4        64   Cebpa    13.7500
## 3270   64C 1.5        64   Cebpa    11.4600
## 3271   64C 1.6        64   Cebpa    13.8850
## 3272   64C 1.7        64   Cebpa    13.1300
## 3273   64C 1.8        64   Cebpa     6.6050
## 3274   64C 1.9        64   Cebpa    11.2100
## 3275  64C 1.10        64   Cebpa     6.7550
## 3276  64C 1.11        64   Cebpa    10.9100
## 3277  64C 1.12        64   Cebpa     7.3200
## 3278  64C 1.13        64   Cebpa    13.5550
## 3279  64C 1.14        64   Cebpa    12.1600
## 3280  64C 1.15        64   Cebpa    13.3950
## 3281  64C 1.16        64   Cebpa     8.0000
## 3282  64C 1.17        64   Cebpa    11.8600
## 3283  64C 1.18        64   Cebpa     5.7400
## 3284  64C 1.19        64   Cebpa     6.9450
## 3285  64C 1.20        64   Cebpa     4.9700
## 3286  64C 1.21        64   Cebpa    14.7500
## 3287  64C 1.22        64   Cebpa    14.1500
## 3288  64C 1.23        64   Cebpa    12.2850
## 3289  64C 1.24        64   Cebpa     8.5600
## 3290  64C 1.25        64   Cebpa    13.3200
## 3291  64C 1.26        64   Cebpa    12.5450
## 3292  64C 1.27        64   Cebpa     4.8000
## 3293  64C 1.28        64   Cebpa     5.9550
## 3294  64C 1.29        64   Cebpa     3.8300
## 3295  64C 1.30        64   Cebpa     7.6350
## 3296  64C 1.31        64   Cebpa     5.2000
## 3297  64C 1.32        64   Cebpa     9.3350
## 3298  64C 1.33        64   Cebpa    14.8100
## 3299  64C 1.34        64   Cebpa    14.4450
## 3300  64C 1.35        64   Cebpa     4.4450
## 3301  64C 1.36        64   Cebpa     5.1250
## 3302  64C 1.37        64   Cebpa     6.1250
## 3303  64C 1.38        64   Cebpa     8.2300
## 3304  64C 1.39        64   Cebpa     8.3700
## 3305  64C 1.40        64   Cebpa    12.9150
## 3306  64C 1.41        64   Cebpa    13.2550
## 3307  64C 1.42        64   Cebpa    14.6800
## 3308  64C 1.43        64   Cebpa    13.8750
## 3309  64C 1.44        64   Cebpa    11.1850
## 3310  64C 1.45        64   Cebpa     4.9200
## 3311  64C 1.46        64   Cebpa     5.0500
## 3312  64C 1.47        64   Cebpa    11.7000
## 3313  64C 1.48        64   Cebpa     7.0400
## 3314   64C 2.1        64   Cebpa     7.2450
## 3315   64C 2.2        64   Cebpa    11.6700
## 3316   64C 2.3        64   Cebpa    13.9200
## 3317   64C 2.4        64   Cebpa     8.4400
## 3318   64C 2.5        64   Cebpa    12.0900
## 3319   64C 2.6        64   Cebpa     9.6850
## 3320   64C 2.7        64   Cebpa    11.7400
## 3321   64C 2.8        64   Cebpa    12.6600
## 3322   64C 2.9        64   Cebpa     9.8050
## 3323  64C 2.10        64   Cebpa     5.9800
## 3324  64C 2.11        64   Cebpa     7.3150
## 3325  64C 2.12        64   Cebpa     6.5600
## 3326  64C 2.13        64   Cebpa     6.3200
## 3327  64C 2.14        64   Cebpa     6.0350
## 3328  64C 2.15        64   Cebpa     4.5150
## 3329  64C 2.16        64   Cebpa    10.8650
## 3330  64C 2.17        64   Cebpa    10.9800
## 3331  64C 2.18        64   Cebpa     7.2100
## 3332  64C 2.19        64   Cebpa     6.7150
## 3333  64C 2.20        64   Cebpa     9.1950
## 3334  64C 2.21        64   Cebpa     7.8900
## 3335  64C 2.22        64   Cebpa    12.1000
## 3336  64C 2.23        64   Cebpa     6.9050
## 3337  64C 2.24        64   Cebpa     0.7150
## 3338  64C 2.25        64   Cebpa     4.3750
## 3339   64C 3.1        64   Cebpa     4.5750
## 3340   64C 3.2        64   Cebpa    13.6700
## 3341   64C 3.3        64   Cebpa     7.2050
## 3342   64C 3.4        64   Cebpa     6.9200
## 3343   64C 3.5        64   Cebpa    11.7400
## 3344   64C 3.6        64   Cebpa    12.2750
## 3345   64C 3.7        64   Cebpa     5.2950
## 3346   64C 3.8        64   Cebpa     6.6550
## 3347   64C 4.1        64   Cebpa    12.4650
## 3348  64C 4.1b        64   Cebpa    13.3750
## 3349   64C 4.2        64   Cebpa    13.6300
## 3350   64C 4.3        64   Cebpa    13.1050
## 3351   64C 4.4        64   Cebpa    13.8700
## 3352   64C 4.5        64   Cebpa    11.2600
## 3353   64C 4.6        64   Cebpa    12.5750
## 3354   64C 4.7        64   Cebpa     4.6750
## 3355   64C 4.8        64   Cebpa    11.9650
## 3356   64C 4.9        64   Cebpa     4.6450
## 3357  64C 4.10        64   Cebpa     7.3000
## 3358  64C 4.11        64   Cebpa    13.6550
## 3359  64C 4.12        64   Cebpa     6.4725
## 3360  64C 4.13        64   Cebpa     3.4900
## 3361  64C 4.14        64   Cebpa     5.2300
## 3362  64C 4.15        64   Cebpa     4.6200
## 3363  64C 4.16        64   Cebpa    10.3100
## 3364  64C 4.17        64   Cebpa     3.4850
## 3365  64C 4.18        64   Cebpa     6.6400
## 3366  64C 4.19        64   Cebpa     4.8500
## 3367  64C 4.20        64   Cebpa     6.8450
## 3368  64C 4.21        64   Cebpa     4.3325
## 3369  64C 4.22        64   Cebpa     8.0550
## 3370  64C 4.23        64   Cebpa     6.6550
## 3371  64C 4.24        64   Cebpa     5.9850
## 3372  64C 4.25        64   Cebpa     3.4950
## 3373  64C 4.26        64   Cebpa     8.6450
## 3374  64C 4.27        64   Cebpa     2.8550
## 3375  64C 4.28        64   Cebpa    12.9200
## 3376  64C 4.29        64   Cebpa     5.8400
## 3377  64C 4.30        64   Cebpa    11.4600
## 3378  64C 4.31        64   Cebpa     6.6050
## 3379  64C 4.32        64   Cebpa    13.1300
## 3380  64C 4.33        64   Cebpa     7.1650
## 3381  64C 4.34        64   Cebpa     3.1300
## 3382  64C 4.35        64   Cebpa    11.3750
## 3383  64C 4.36        64   Cebpa     3.2400
## 3384  64C 4.37        64   Cebpa     5.0300
## 3385  64C 4.38        64   Cebpa    13.5550
## 3386  64C 4.39        64   Cebpa     9.5400
## 3387   64C 5.1        64   Cebpa     6.0050
## 3388   64C 5.2        64   Cebpa    14.0200
## 3389   64C 5.3        64   Cebpa    11.8600
## 3390   64C 5.4        64   Cebpa     6.5000
## 3391   64C 5.5        64   Cebpa    12.1650
## 3392   64C 5.6        64   Cebpa    11.1400
## 3393   64C 5.7        64   Cebpa    14.7500
## 3394   64C 5.8        64   Cebpa    14.1500
## 3395   64C 5.9        64   Cebpa    12.2850
## 3396  64C 5.10        64   Cebpa     9.6600
## 3397  64C 5.11        64   Cebpa     6.3400
## 3398  64C 5.12        64   Cebpa     4.3750
## 3399  64C 5.13        64   Cebpa     3.2300
## 3400  64C 5.14        64   Cebpa     3.4250
## 3401  64C 5.15        64   Cebpa    11.2000
## 3402  64C 5.16        64   Cebpa     9.0650
## 3403   64C 6.1        64   Cebpa    13.0900
## 3404   64C 6.2        64   Cebpa    13.3850
## 3405   64C 6.3        64   Cebpa    14.8100
## 3406   64C 6.4        64   Cebpa    14.4450
## 3407   64C 6.5        64   Cebpa    12.3950
## 3408   64C 6.6        64   Cebpa    12.1750
## 3409   64C 6.7        64   Cebpa    12.4150
## 3410   64C 6.8        64   Cebpa    11.6200
## 3411   64C 7.1        64   Cebpa    13.4600
## 3412   64C 7.2        64   Cebpa    12.9150
## 3413   64C 7.3        64   Cebpa    13.2550
## 3414   64C 7.4        64   Cebpa    14.6800
## 3415   64C 7.5        64   Cebpa    13.8750
## 3416   64C 7.6        64   Cebpa     7.8950
## 3417   64C 7.7        64   Cebpa    11.5100
## 3418   64C 7.8        64   Cebpa    12.4300
## 3419   64C 7.9        64   Cebpa    11.7000
## 3420  64C 7.10        64   Cebpa     8.0600
## 3421  64C 7.11        64   Cebpa     8.0950
## 3422  64C 7.12        64   Cebpa     3.5000
## 3423  64C 7.13        64   Cebpa    13.9200
## 3424  64C 7.14        64   Cebpa     9.3700
## 3425    2C 1.1         2    Dab2     9.4700
## 3426    2C 1.2         2    Dab2     8.0150
## 3427    2C 2.1         2    Dab2     9.0600
## 3428    2C 2.2         2    Dab2    12.0050
## 3429    2C 3.1         2    Dab2    14.8450
## 3430    2C 3.2         2    Dab2    13.7700
## 3431    2C 4.1         2    Dab2    14.3000
## 3432    2C 5.1         2    Dab2    13.4700
## 3433    2C 5.2         2    Dab2    13.1300
## 3434    2C 6.1         2    Dab2     9.1450
## 3435    2C 6.2         2    Dab2    10.9550
## 3436    2C 7.1         2    Dab2    11.2100
## 3437    2C 7.2         2    Dab2    11.7950
## 3438    2C 8.1         2    Dab2    11.2450
## 3439    2C 8.2         2    Dab2    15.2575
## 3440    2C 9.1         2    Dab2    13.8800
## 3441    2C 9.2         2    Dab2    13.1450
## 3442   2C 10.1         2    Dab2    12.6400
## 3443   2C 10.2         2    Dab2    11.8000
## 3444    4C 1.1         4    Dab2    11.4350
## 3445    4C 1.2         4    Dab2     9.7400
## 3446    4C 1.3         4    Dab2    13.5850
## 3447    4C 1.4         4    Dab2    13.3300
## 3448    4C 2.1         4    Dab2     6.3625
## 3449    4C 2.2         4    Dab2    14.6150
## 3450    4C 2.3         4    Dab2     8.4350
## 3451    4C 3.1         4    Dab2     8.0650
## 3452    4C 3.2         4    Dab2     6.4250
## 3453    4C 3.3         4    Dab2     6.5100
## 3454    4C 3.4         4    Dab2     6.5450
## 3455    4C 4.1         4    Dab2     9.2650
## 3456    4C 4.2         4    Dab2    11.8450
## 3457    4C 4.3         4    Dab2     8.3150
## 3458    4C 4.4         4    Dab2    13.3050
## 3459    4C 5.1         4    Dab2     5.5200
## 3460    4C 5.2         4    Dab2    10.8150
## 3461    4C 5.3         4    Dab2     6.5300
## 3462    4C 5.4         4    Dab2     5.3750
## 3463    4C 6.1         4    Dab2    10.1350
## 3464    4C 6.2         4    Dab2     7.1200
## 3465    4C 6.3         4    Dab2     8.4850
## 3466    4C 6.4         4    Dab2    11.8350
## 3467    8C 1.1         8    Dab2     7.3050
## 3468    8C 1.2         8    Dab2     4.7350
## 3469    8C 1.3         8    Dab2     7.8700
## 3470    8C 1.4         8    Dab2     2.3450
## 3471    8C 1.5         8    Dab2     4.1250
## 3472    8C 2.1         8    Dab2     2.3550
## 3473    8C 2.2         8    Dab2     5.0300
## 3474    8C 2.3         8    Dab2     7.5950
## 3475    8C 2.4         8    Dab2     7.2400
## 3476    8C 2.5         8    Dab2    10.2100
## 3477    8C 2.6         8    Dab2     6.5150
## 3478    8C 2.7         8    Dab2     8.7450
## 3479    8C 2.8         8    Dab2     3.6600
## 3480    8C 3.1         8    Dab2     6.2900
## 3481    8C 3.2         8    Dab2     6.7150
## 3482    8C 3.3         8    Dab2     8.1300
## 3483    8C 3.4         8    Dab2     6.3350
## 3484    8C 3.5         8    Dab2     6.7950
## 3485    8C 3.6         8    Dab2     6.9450
## 3486    8C 3.7         8    Dab2     7.3450
## 3487    8C 3.8         8    Dab2     6.3650
## 3488    8C 4.2         8    Dab2    10.9900
## 3489    8C 4.3         8    Dab2     5.1500
## 3490    8C 4.4         8    Dab2    11.7950
## 3491    8C 4.5         8    Dab2    13.2550
## 3492    8C 4.6         8    Dab2    11.1550
## 3493    8C 4.7         8    Dab2     5.0750
## 3494    8C 5.1         8    Dab2     5.8950
## 3495    8C 5.2         8    Dab2     7.7500
## 3496    8C 5.3         8    Dab2     4.1600
## 3497    8C 5.4         8    Dab2     4.0050
## 3498    8C 5.5         8    Dab2     5.0750
## 3499    8C 5.6         8    Dab2     4.6200
## 3500    8C 5.7         8    Dab2     7.2000
## 3501    8C 5.8         8    Dab2     6.4450
## 3502    8C 6.1         8    Dab2     6.5300
## 3503    8C 6.2         8    Dab2    11.2200
## 3504    8C 6.3         8    Dab2    11.9750
## 3505    8C 6.4         8    Dab2    10.0400
## 3506    8C 6.5         8    Dab2     5.7800
## 3507    8C 6.6         8    Dab2     8.5850
## 3508    8C 6.7         8    Dab2     8.5100
## 3509    8C 6.8         8    Dab2     7.2300
## 3510   16C 1.1        16    Dab2     7.1200
## 3511   16C 1.2        16    Dab2     7.5600
## 3512   16C 1.3        16    Dab2     3.8300
## 3513   16C 1.4        16    Dab2     2.9800
## 3514   16C 1.5        16    Dab2     2.9350
## 3515   16C 1.6        16    Dab2     2.4650
## 3516   16C 1.7        16    Dab2     2.5700
## 3517   16C 1.8        16    Dab2     1.8100
## 3518   16C 1.9        16    Dab2     4.3300
## 3519  16C 1.10        16    Dab2     4.8950
## 3520  16C 1.11        16    Dab2     3.2650
## 3521  16C 1.12        16    Dab2     4.5250
## 3522  16C 1.13        16    Dab2     4.8050
## 3523  16C 1.14        16    Dab2     1.9000
## 3524  16C 1.15        16    Dab2     5.8650
## 3525  16C 1.16        16    Dab2     2.0150
## 3526   16C 2.1        16    Dab2     3.4600
## 3527   16C 2.2        16    Dab2     4.0400
## 3528   16C 2.3        16    Dab2     4.2350
## 3529   16C 2.4        16    Dab2     3.2050
## 3530   16C 2.5        16    Dab2     3.7050
## 3531   16C 2.6        16    Dab2     4.5850
## 3532   16C 2.7        16    Dab2     6.1000
## 3533   16C 2.8        16    Dab2     0.3050
## 3534   16C 2.9        16    Dab2     3.8300
## 3535  16C 2.10        16    Dab2     3.6150
## 3536  16C 2.11        16    Dab2     6.3750
## 3537  16C 2.12        16    Dab2     5.3500
## 3538  16C 2.13        16    Dab2     7.1700
## 3539  16C 2.14        16    Dab2     3.9000
## 3540  16C 2.15        16    Dab2     5.3300
## 3541  16C 2.16        16    Dab2     3.2350
## 3542   16C 3.1        16    Dab2     2.2250
## 3543   16C 3.2        16    Dab2     2.2200
## 3544   16C 3.3        16    Dab2     2.5050
## 3545   16C 3.4        16    Dab2     5.2750
## 3546   16C 3.5        16    Dab2     6.1375
## 3547   16C 3.6        16    Dab2     5.3100
## 3548   16C 3.7        16    Dab2     4.8050
## 3549   16C 3.8        16    Dab2     4.3800
## 3550   16C 3.9        16    Dab2     5.8600
## 3551  16C 3.10        16    Dab2     2.1750
## 3552  16C 3.11        16    Dab2     4.4300
## 3553  16C 3.12        16    Dab2     5.5550
## 3554  16C 3.13        16    Dab2     4.3200
## 3555  16C 3.14        16    Dab2     5.8725
## 3556  16C 3.15        16    Dab2     5.7350
## 3557   16C 4.1        16    Dab2     4.3450
## 3558   16C 4.2        16    Dab2     4.6650
## 3559   16C 4.3        16    Dab2     1.0450
## 3560   16C 4.4        16    Dab2     3.5400
## 3561   16C 4.5        16    Dab2     2.9950
## 3562   16C 4.6        16    Dab2     3.3750
## 3563   16C 4.7        16    Dab2     5.5550
## 3564   16C 4.8        16    Dab2     4.7350
## 3565   16C 4.9        16    Dab2     8.7450
## 3566  16C 4.10        16    Dab2     3.4400
## 3567  16C 4.11        16    Dab2     1.8750
## 3568  16C 4.12        16    Dab2     1.9500
## 3569  16C 4.13        16    Dab2     3.0850
## 3570  16C 4.14        16    Dab2     2.1150
## 3571  16C 4.15        16    Dab2     4.0700
## 3572  16C 4.16        16    Dab2     5.2950
## 3573   16C 5.1        16    Dab2     4.0050
## 3574   16C 5.2        16    Dab2     3.5350
## 3575   16C 5.3        16    Dab2     3.6250
## 3576   16C 5.4        16    Dab2     2.4200
## 3577   16C 5.5        16    Dab2     0.2950
## 3578   16C 5.6        16    Dab2     3.9150
## 3579   16C 5.7        16    Dab2     0.9450
## 3580   16C 5.8        16    Dab2     3.4600
## 3581   16C 5.9        16    Dab2     3.0450
## 3582  16C 5.10        16    Dab2     3.3700
## 3583  16C 5.11        16    Dab2     5.0000
## 3584  16C 5.12        16    Dab2     6.5450
## 3585   32C 1.1        32    Dab2     3.2250
## 3586   32C 1.2        32    Dab2     5.9200
## 3587   32C 1.3        32    Dab2     1.6000
## 3588   32C 1.4        32    Dab2     1.0150
## 3589   32C 1.5        32    Dab2    13.7700
## 3590   32C 1.6        32    Dab2     6.9250
## 3591   32C 1.7        32    Dab2     3.5250
## 3592   32C 1.8        32    Dab2     8.7750
## 3593   32C 1.9        32    Dab2    10.3150
## 3594  32C 1.10        32    Dab2     5.7150
## 3595  32C 1.11        32    Dab2     2.5300
## 3596  32C 1.12        32    Dab2     2.5500
## 3597  32C 1.13        32    Dab2     5.8550
## 3598  32C 1.14        32    Dab2     3.3250
## 3599  32C 1.15        32    Dab2     8.9750
## 3600  32C 1.16        32    Dab2     6.2050
## 3601  32C 1.17        32    Dab2     6.3850
## 3602  32C 1.18        32    Dab2    10.0200
## 3603  32C 1.19        32    Dab2     7.2700
## 3604  32C 1.20        32    Dab2     6.7450
## 3605  32C 1.21        32    Dab2     8.8350
## 3606   32C 2.1        32    Dab2     1.1500
## 3607   32C 2.2        32    Dab2     5.0300
## 3608   32C 2.3        32    Dab2     3.0150
## 3609   32C 2.4        32    Dab2     6.9800
## 3610   32C 2.5        32    Dab2     8.1400
## 3611   32C 2.6        32    Dab2     4.3350
## 3612   32C 2.7        32    Dab2     3.9800
## 3613   32C 2.8        32    Dab2    11.7000
## 3614   32C 2.9        32    Dab2     2.5050
## 3615  32C 2.10        32    Dab2     2.1500
## 3616  32C 2.11        32    Dab2    13.7800
## 3617  32C 2.12        32    Dab2     4.8000
## 3618  32C 2.13        32    Dab2     8.8000
## 3619  32C 2.14        32    Dab2    12.5700
## 3620  32C 2.15        32    Dab2     7.7800
## 3621  32C 2.16        32    Dab2     5.6650
## 3622   32C 3.1        32    Dab2     2.5850
## 3623   32C 3.2        32    Dab2     3.5900
## 3624   32C 3.3        32    Dab2     2.3700
## 3625   32C 3.4        32    Dab2     4.0500
## 3626   32C 3.5        32    Dab2     5.3350
## 3627   32C 3.6        32    Dab2    13.4350
## 3628   32C 3.7        32    Dab2    13.9050
## 3629   32C 3.8        32    Dab2     9.4850
## 3630   32C 4.1        32    Dab2     0.9000
## 3631   32C 4.2        32    Dab2     1.8750
## 3632   32C 4.3        32    Dab2     5.3950
## 3633   32C 4.4        32    Dab2    11.5300
## 3634   32C 4.5        32    Dab2    14.4500
## 3635   32C 4.6        32    Dab2    13.2950
## 3636   32C 4.7        32    Dab2     3.8450
## 3637   32C 4.8        32    Dab2     3.3050
## 3638  32C 4.10        32    Dab2     4.2050
## 3639  32C 4.11        32    Dab2     6.8900
## 3640  32C 4.12        32    Dab2    -0.7850
## 3641  32C 4.13        32    Dab2     2.8300
## 3642  32C 4.14        32    Dab2     6.7150
## 3643  32C 4.15        32    Dab2    10.1350
## 3644  32C 4.16        32    Dab2     9.6200
## 3645  32C 4.17        32    Dab2     5.8800
## 3646  32C 4.18        32    Dab2     3.7600
## 3647  32C 4.19        32    Dab2     2.9400
## 3648  32C 4.20        32    Dab2     6.4650
## 3649  32C 4.21        32    Dab2    10.9550
## 3650  32C 4.22        32    Dab2    11.2100
## 3651  32C 4.23        32    Dab2     3.6650
## 3652  32C 4.24        32    Dab2    14.3350
## 3653   32C 5.1        32    Dab2     4.3875
## 3654   32C 5.2        32    Dab2     4.5700
## 3655   32C 5.3        32    Dab2    13.1450
## 3656   32C 5.4        32    Dab2     4.1500
## 3657   32C 5.5        32    Dab2    11.8000
## 3658   32C 5.6        32    Dab2     3.4550
## 3659   32C 5.7        32    Dab2     3.1500
## 3660   32C 5.8        32    Dab2    13.5850
## 3661   32C 5.9        32    Dab2     3.1300
## 3662  32C 5.10        32    Dab2     9.6225
## 3663  32C 5.11        32    Dab2     6.9850
## 3664  32C 5.12        32    Dab2     8.5550
## 3665  32C 5.13        32    Dab2     3.3750
## 3666  32C 5.14        32    Dab2     0.7250
## 3667  32C 5.15        32    Dab2     4.8600
## 3668  32C 5.16        32    Dab2     2.5950
## 3669  32C 5.17        32    Dab2     3.3850
## 3670  32C 5.18        32    Dab2     5.6550
## 3671  32C 5.19        32    Dab2    10.0550
## 3672  32C 5.20        32    Dab2     4.9750
## 3673  32C 5.21        32    Dab2     2.8800
## 3674  32C 5.22        32    Dab2     1.9950
## 3675  32C 5.23        32    Dab2     2.2200
## 3676   32C 6.1        32    Dab2     8.4150
## 3677   32C 6.2        32    Dab2    -0.9650
## 3678   32C 6.3        32    Dab2     3.3200
## 3679   32C 6.4        32    Dab2    10.4450
## 3680   32C 6.6        32    Dab2     2.7100
## 3681   32C 6.7        32    Dab2     5.4800
## 3682   32C 7.1        32    Dab2     2.2150
## 3683   32C 7.2        32    Dab2    12.0500
## 3684   32C 7.3        32    Dab2     0.8700
## 3685   32C 7.4        32    Dab2     1.8700
## 3686   32C 7.5        32    Dab2     6.5350
## 3687   32C 7.6        32    Dab2    12.4600
## 3688   32C 7.8        32    Dab2     4.2500
## 3689   32C 8.1        32    Dab2     4.5150
## 3690   32C 8.2        32    Dab2     5.5250
## 3691   32C 8.4        32    Dab2     4.9300
## 3692   32C 8.5        32    Dab2     9.8900
## 3693   32C 8.6        32    Dab2     1.5800
## 3694   64C 1.1        64    Dab2     2.7900
## 3695   64C 1.2        64    Dab2     1.6750
## 3696   64C 1.3        64    Dab2    13.7700
## 3697   64C 1.4        64    Dab2     4.0850
## 3698   64C 1.5        64    Dab2     2.6750
## 3699   64C 1.6        64    Dab2    13.6850
## 3700   64C 1.7        64    Dab2     7.1750
## 3701   64C 1.8        64    Dab2     2.4450
## 3702   64C 1.9        64    Dab2     1.8900
## 3703  64C 1.10        64    Dab2     2.5400
## 3704  64C 1.11        64    Dab2     3.3250
## 3705  64C 1.12        64    Dab2     5.9150
## 3706  64C 1.13        64    Dab2    10.4850
## 3707  64C 1.14        64    Dab2     3.3450
## 3708  64C 1.15        64    Dab2     3.7950
## 3709  64C 1.16        64    Dab2     5.4600
## 3710  64C 1.17        64    Dab2     3.0200
## 3711  64C 1.18        64    Dab2     2.9150
## 3712  64C 1.19        64    Dab2     4.5950
## 3713  64C 1.20        64    Dab2     2.2400
## 3714  64C 1.21        64    Dab2     7.3300
## 3715  64C 1.22        64    Dab2    13.1050
## 3716  64C 1.23        64    Dab2    12.5900
## 3717  64C 1.24        64    Dab2     6.0700
## 3718  64C 1.25        64    Dab2     3.2950
## 3719  64C 1.26        64    Dab2     7.4400
## 3720  64C 1.27        64    Dab2     2.3700
## 3721  64C 1.28        64    Dab2     3.6250
## 3722  64C 1.29        64    Dab2     4.7600
## 3723  64C 1.30        64    Dab2     7.2100
## 3724  64C 1.31        64    Dab2     6.2700
## 3725  64C 1.32        64    Dab2     4.6700
## 3726  64C 1.33        64    Dab2     3.4300
## 3727  64C 1.34        64    Dab2     6.3800
## 3728  64C 1.35        64    Dab2     1.8650
## 3729  64C 1.36        64    Dab2     1.7850
## 3730  64C 1.37        64    Dab2     4.3800
## 3731  64C 1.38        64    Dab2     2.0900
## 3732  64C 1.39        64    Dab2     5.3800
## 3733  64C 1.40        64    Dab2    14.3550
## 3734  64C 1.41        64    Dab2     6.3650
## 3735  64C 1.42        64    Dab2     4.5950
## 3736  64C 1.43        64    Dab2    14.1850
## 3737  64C 1.44        64    Dab2     5.3600
## 3738  64C 1.45        64    Dab2     4.6750
## 3739  64C 1.46        64    Dab2     2.7150
## 3740  64C 1.47        64    Dab2     2.9500
## 3741  64C 1.48        64    Dab2     5.3700
## 3742   64C 2.1        64    Dab2     4.4150
## 3743   64C 2.2        64    Dab2     3.8350
## 3744   64C 2.3        64    Dab2     5.3550
## 3745   64C 2.4        64    Dab2     5.8350
## 3746   64C 2.5        64    Dab2     4.9700
## 3747   64C 2.6        64    Dab2     0.6750
## 3748   64C 2.7        64    Dab2     7.9900
## 3749   64C 2.8        64    Dab2     5.1250
## 3750   64C 2.9        64    Dab2     5.7350
## 3751  64C 2.10        64    Dab2     4.7400
## 3752  64C 2.11        64    Dab2     7.2000
## 3753  64C 2.12        64    Dab2     5.2600
## 3754  64C 2.13        64    Dab2     4.7600
## 3755  64C 2.14        64    Dab2     4.0450
## 3756  64C 2.15        64    Dab2     1.8950
## 3757  64C 2.16        64    Dab2     5.3200
## 3758  64C 2.17        64    Dab2     3.2850
## 3759  64C 2.18        64    Dab2     5.2250
## 3760  64C 2.19        64    Dab2     6.1375
## 3761  64C 2.20        64    Dab2     6.3200
## 3762  64C 2.21        64    Dab2     5.9850
## 3763  64C 2.22        64    Dab2     5.3400
## 3764  64C 2.23        64    Dab2     3.7300
## 3765  64C 2.24        64    Dab2     3.6850
## 3766  64C 2.25        64    Dab2     5.9100
## 3767   64C 3.1        64    Dab2     6.8750
## 3768   64C 3.2        64    Dab2     4.7100
## 3769   64C 3.3        64    Dab2     4.7725
## 3770   64C 3.4        64    Dab2     6.1550
## 3771   64C 3.5        64    Dab2     3.2750
## 3772   64C 3.6        64    Dab2     4.7250
## 3773   64C 3.7        64    Dab2     1.8150
## 3774   64C 3.8        64    Dab2     5.3600
## 3775   64C 4.1        64    Dab2     6.2550
## 3776  64C 4.1b        64    Dab2    12.5650
## 3777   64C 4.2        64    Dab2    11.2550
## 3778   64C 4.3        64    Dab2     9.5850
## 3779   64C 4.4        64    Dab2    13.3050
## 3780   64C 4.5        64    Dab2    11.1000
## 3781   64C 4.6        64    Dab2     6.2050
## 3782   64C 4.7        64    Dab2     1.3800
## 3783   64C 4.8        64    Dab2     7.1950
## 3784   64C 4.9        64    Dab2     1.3650
## 3785  64C 4.10        64    Dab2     7.4500
## 3786  64C 4.11        64    Dab2    13.7550
## 3787  64C 4.12        64    Dab2     4.8350
## 3788  64C 4.13        64    Dab2     4.0450
## 3789  64C 4.14        64    Dab2     2.6150
## 3790  64C 4.15        64    Dab2     4.0600
## 3791  64C 4.16        64    Dab2    -0.6150
## 3792  64C 4.17        64    Dab2     4.2150
## 3793  64C 4.18        64    Dab2    -0.3050
## 3794  64C 4.19        64    Dab2     3.0600
## 3795  64C 4.20        64    Dab2     4.2850
## 3796  64C 4.21        64    Dab2     4.1900
## 3797  64C 4.22        64    Dab2     4.3800
## 3798  64C 4.23        64    Dab2     4.1950
## 3799  64C 4.24        64    Dab2     4.4550
## 3800  64C 4.25        64    Dab2     0.8700
## 3801  64C 4.26        64    Dab2     4.7700
## 3802  64C 4.27        64    Dab2     2.3150
## 3803  64C 4.28        64    Dab2     8.3000
## 3804  64C 4.29        64    Dab2     3.5550
## 3805  64C 4.30        64    Dab2     6.3550
## 3806  64C 4.31        64    Dab2     5.5550
## 3807  64C 4.32        64    Dab2     9.5250
## 3808  64C 4.33        64    Dab2     2.2250
## 3809  64C 4.34        64    Dab2     2.8000
## 3810  64C 4.35        64    Dab2     2.5800
## 3811  64C 4.36        64    Dab2     1.7350
## 3812  64C 4.37        64    Dab2     4.0850
## 3813  64C 4.38        64    Dab2     4.6050
## 3814  64C 4.39        64    Dab2     5.7450
## 3815   64C 5.1        64    Dab2     3.5350
## 3816   64C 5.2        64    Dab2     2.8100
## 3817   64C 5.3        64    Dab2     0.3500
## 3818   64C 5.4        64    Dab2     2.8650
## 3819   64C 5.5        64    Dab2     3.8550
## 3820   64C 5.6        64    Dab2     1.6400
## 3821   64C 5.7        64    Dab2     4.3400
## 3822   64C 5.8        64    Dab2     9.1250
## 3823   64C 5.9        64    Dab2     2.5500
## 3824  64C 5.10        64    Dab2     4.4600
## 3825  64C 5.11        64    Dab2     4.3950
## 3826  64C 5.12        64    Dab2     3.5800
## 3827  64C 5.13        64    Dab2     2.5100
## 3828  64C 5.14        64    Dab2     3.1050
## 3829  64C 5.15        64    Dab2     4.9200
## 3830  64C 5.16        64    Dab2     9.9800
## 3831   64C 6.1        64    Dab2     7.4700
## 3832   64C 6.2        64    Dab2     8.5900
## 3833   64C 6.3        64    Dab2     9.3000
## 3834   64C 6.4        64    Dab2    13.1200
## 3835   64C 6.5        64    Dab2    11.7850
## 3836   64C 6.6        64    Dab2     6.3450
## 3837   64C 6.7        64    Dab2     1.0300
## 3838   64C 6.8        64    Dab2     6.3400
## 3839   64C 7.1        64    Dab2     7.3900
## 3840   64C 7.2        64    Dab2     4.0450
## 3841   64C 7.3        64    Dab2     9.1250
## 3842   64C 7.4        64    Dab2     5.7450
## 3843   64C 7.5        64    Dab2     7.5050
## 3844   64C 7.6        64    Dab2     3.0100
## 3845   64C 7.7        64    Dab2     3.9050
## 3846   64C 7.8        64    Dab2     5.2950
## 3847   64C 7.9        64    Dab2     2.8600
## 3848  64C 7.10        64    Dab2     5.5900
## 3849  64C 7.11        64    Dab2     4.0150
## 3850  64C 7.12        64    Dab2     4.7750
## 3851  64C 7.13        64    Dab2     4.4950
## 3852  64C 7.14        64    Dab2     6.2750
## 3853    2C 1.1         2   DppaI     4.9550
## 3854    2C 1.2         2   DppaI     4.2850
## 3855    2C 2.1         2   DppaI     6.6750
## 3856    2C 2.2         2   DppaI     5.4550
## 3857    2C 3.1         2   DppaI     7.5350
## 3858    2C 3.2         2   DppaI     8.6450
## 3859    2C 4.1         2   DppaI     8.8500
## 3860    2C 5.1         2   DppaI     6.1650
## 3861    2C 5.2         2   DppaI     7.2000
## 3862    2C 6.1         2   DppaI     5.9500
## 3863    2C 6.2         2   DppaI     4.4250
## 3864    2C 7.1         2   DppaI     6.3800
## 3865    2C 7.2         2   DppaI     5.7000
## 3866    2C 8.1         2   DppaI    10.3100
## 3867    2C 8.2         2   DppaI     8.3550
## 3868    2C 9.1         2   DppaI     8.2000
## 3869    2C 9.2         2   DppaI     7.4800
## 3870   2C 10.1         2   DppaI     6.2800
## 3871   2C 10.2         2   DppaI     5.5250
## 3872    4C 1.1         4   DppaI     6.8850
## 3873    4C 1.2         4   DppaI    12.5800
## 3874    4C 1.3         4   DppaI    12.3000
## 3875    4C 1.4         4   DppaI    13.1150
## 3876    4C 2.1         4   DppaI    13.6125
## 3877    4C 2.2         4   DppaI    13.8100
## 3878    4C 2.3         4   DppaI    10.0700
## 3879    4C 3.1         4   DppaI    12.8450
## 3880    4C 3.2         4   DppaI    10.6250
## 3881    4C 3.3         4   DppaI    12.3050
## 3882    4C 3.4         4   DppaI    10.4200
## 3883    4C 4.1         4   DppaI    13.2600
## 3884    4C 4.2         4   DppaI    13.1450
## 3885    4C 4.3         4   DppaI    11.0500
## 3886    4C 4.4         4   DppaI    12.9800
## 3887    4C 5.1         4   DppaI    13.5250
## 3888    4C 5.2         4   DppaI     9.2550
## 3889    4C 5.3         4   DppaI    10.2250
## 3890    4C 5.4         4   DppaI     9.0750
## 3891    4C 6.1         4   DppaI     7.2400
## 3892    4C 6.2         4   DppaI    11.2100
## 3893    4C 6.3         4   DppaI    10.4800
## 3894    4C 6.4         4   DppaI    12.7400
## 3895    8C 1.1         8   DppaI    13.5000
## 3896    8C 1.2         8   DppaI    11.9650
## 3897    8C 1.3         8   DppaI    11.8900
## 3898    8C 1.4         8   DppaI     9.5050
## 3899    8C 1.5         8   DppaI    11.3150
## 3900    8C 2.1         8   DppaI     9.3900
## 3901    8C 2.2         8   DppaI    14.7350
## 3902    8C 2.3         8   DppaI    13.8200
## 3903    8C 2.4         8   DppaI    12.9700
## 3904    8C 2.5         8   DppaI    14.8300
## 3905    8C 2.6         8   DppaI    12.7150
## 3906    8C 2.7         8   DppaI    11.5100
## 3907    8C 2.8         8   DppaI     9.2200
## 3908    8C 3.1         8   DppaI    11.2950
## 3909    8C 3.2         8   DppaI    11.0750
## 3910    8C 3.3         8   DppaI    13.3600
## 3911    8C 3.4         8   DppaI    14.2750
## 3912    8C 3.5         8   DppaI    12.7800
## 3913    8C 3.6         8   DppaI    13.2150
## 3914    8C 3.7         8   DppaI    14.4400
## 3915    8C 3.8         8   DppaI    11.8250
## 3916    8C 4.2         8   DppaI    11.0450
## 3917    8C 4.3         8   DppaI     9.8950
## 3918    8C 4.4         8   DppaI    11.5850
## 3919    8C 4.5         8   DppaI    15.2850
## 3920    8C 4.6         8   DppaI    13.8650
## 3921    8C 4.7         8   DppaI    12.3750
## 3922    8C 5.1         8   DppaI    14.8800
## 3923    8C 5.2         8   DppaI    13.5150
## 3924    8C 5.3         8   DppaI    11.9550
## 3925    8C 5.4         8   DppaI    12.0850
## 3926    8C 5.5         8   DppaI     9.1700
## 3927    8C 5.6         8   DppaI    12.4750
## 3928    8C 5.7         8   DppaI    13.4600
## 3929    8C 5.8         8   DppaI     9.6800
## 3930    8C 6.1         8   DppaI    11.5100
## 3931    8C 6.2         8   DppaI    13.9100
## 3932    8C 6.3         8   DppaI    13.7500
## 3933    8C 6.4         8   DppaI    10.6950
## 3934    8C 6.5         8   DppaI    11.4450
## 3935    8C 6.6         8   DppaI    12.3950
## 3936    8C 6.7         8   DppaI    11.3550
## 3937    8C 6.8         8   DppaI    12.2000
## 3938   16C 1.1        16   DppaI     9.3250
## 3939   16C 1.2        16   DppaI    13.4350
## 3940   16C 1.3        16   DppaI     6.1500
## 3941   16C 1.4        16   DppaI     9.8200
## 3942   16C 1.5        16   DppaI    11.5150
## 3943   16C 1.6        16   DppaI     7.8250
## 3944   16C 1.7        16   DppaI    10.1500
## 3945   16C 1.8        16   DppaI     9.5000
## 3946   16C 1.9        16   DppaI    10.9450
## 3947  16C 1.10        16   DppaI    13.8250
## 3948  16C 1.11        16   DppaI     8.6450
## 3949  16C 1.12        16   DppaI    13.1700
## 3950  16C 1.13        16   DppaI    11.2950
## 3951  16C 1.14        16   DppaI     6.2550
## 3952  16C 1.15        16   DppaI    11.2700
## 3953  16C 1.16        16   DppaI     9.4000
## 3954   16C 2.1        16   DppaI    11.2450
## 3955   16C 2.2        16   DppaI    14.8150
## 3956   16C 2.3        16   DppaI    14.1800
## 3957   16C 2.4        16   DppaI    13.3900
## 3958   16C 2.5        16   DppaI    13.9800
## 3959   16C 2.6        16   DppaI    13.1900
## 3960   16C 2.7        16   DppaI    11.6950
## 3961   16C 2.8        16   DppaI    10.4750
## 3962   16C 2.9        16   DppaI    12.1450
## 3963  16C 2.10        16   DppaI    10.5250
## 3964  16C 2.11        16   DppaI    10.8250
## 3965  16C 2.12        16   DppaI    14.2150
## 3966  16C 2.13        16   DppaI    14.1500
## 3967  16C 2.14        16   DppaI    13.2550
## 3968  16C 2.15        16   DppaI     9.6800
## 3969  16C 2.16        16   DppaI    11.2700
## 3970   16C 3.1        16   DppaI    10.7750
## 3971   16C 3.2        16   DppaI    11.6800
## 3972   16C 3.3        16   DppaI    11.8100
## 3973   16C 3.4        16   DppaI    14.4400
## 3974   16C 3.5        16   DppaI    13.7850
## 3975   16C 3.6        16   DppaI     7.9600
## 3976   16C 3.7        16   DppaI    13.2600
## 3977   16C 3.8        16   DppaI     9.3600
## 3978   16C 3.9        16   DppaI    10.9850
## 3979  16C 3.10        16   DppaI     9.6150
## 3980  16C 3.11        16   DppaI    12.5800
## 3981  16C 3.12        16   DppaI     9.2500
## 3982  16C 3.13        16   DppaI    10.9450
## 3983  16C 3.14        16   DppaI    13.6125
## 3984  16C 3.15        16   DppaI    13.8100
## 3985   16C 4.1        16   DppaI    11.9800
## 3986   16C 4.2        16   DppaI    12.8450
## 3987   16C 4.3        16   DppaI    10.6250
## 3988   16C 4.4        16   DppaI    12.3050
## 3989   16C 4.5        16   DppaI    10.4200
## 3990   16C 4.6        16   DppaI    10.4100
## 3991   16C 4.7        16   DppaI    14.1050
## 3992   16C 4.8        16   DppaI    12.3100
## 3993   16C 4.9        16   DppaI    12.9800
## 3994  16C 4.10        16   DppaI    13.5250
## 3995  16C 4.11        16   DppaI     7.0850
## 3996  16C 4.12        16   DppaI    10.2250
## 3997  16C 4.13        16   DppaI    12.6350
## 3998  16C 4.14        16   DppaI    10.8400
## 3999  16C 4.15        16   DppaI    13.0100
## 4000  16C 4.16        16   DppaI    13.7200
## 4001   16C 5.1        16   DppaI    12.7400
## 4002   16C 5.2        16   DppaI     8.3600
## 4003   16C 5.3        16   DppaI     9.6550
## 4004   16C 5.4        16   DppaI     7.1600
## 4005   16C 5.5        16   DppaI     9.5050
## 4006   16C 5.6        16   DppaI    11.3150
## 4007   16C 5.7        16   DppaI     5.9400
## 4008   16C 5.8        16   DppaI    11.4550
## 4009   16C 5.9        16   DppaI     8.4100
## 4010  16C 5.10        16   DppaI    10.3700
## 4011  16C 5.11        16   DppaI     9.0600
## 4012  16C 5.12        16   DppaI    11.6650
## 4013   32C 1.1        32   DppaI     0.8700
## 4014   32C 1.2        32   DppaI     9.2200
## 4015   32C 1.3        32   DppaI     1.2950
## 4016   32C 1.4        32   DppaI     0.2150
## 4017   32C 1.5        32   DppaI    13.3600
## 4018   32C 1.6        32   DppaI     9.4250
## 4019   32C 1.7        32   DppaI     3.3200
## 4020   32C 1.8        32   DppaI    13.2150
## 4021   32C 1.9        32   DppaI     9.3200
## 4022  32C 1.10        32   DppaI     7.8750
## 4023  32C 1.11        32   DppaI     1.2450
## 4024  32C 1.12        32   DppaI    -0.1150
## 4025  32C 1.13        32   DppaI     5.1050
## 4026  32C 1.14        32   DppaI     3.8950
## 4027  32C 1.15        32   DppaI    13.8650
## 4028  32C 1.16        32   DppaI     7.9050
## 4029  32C 1.17        32   DppaI    10.7000
## 4030  32C 1.18        32   DppaI    10.2650
## 4031  32C 1.19        32   DppaI     7.4050
## 4032  32C 1.20        32   DppaI     7.4350
## 4033  32C 1.21        32   DppaI    12.4100
## 4034   32C 2.1        32   DppaI     0.8750
## 4035   32C 2.2        32   DppaI     4.4400
## 4036   32C 2.3        32   DppaI     7.2200
## 4037   32C 2.4        32   DppaI    11.5100
## 4038   32C 2.5        32   DppaI    13.9100
## 4039   32C 2.6        32   DppaI     6.5600
## 4040   32C 2.7        32   DppaI     5.2150
## 4041   32C 2.8        32   DppaI    11.4450
## 4042   32C 2.9        32   DppaI     4.2350
## 4043  32C 2.10        32   DppaI     1.1650
## 4044  32C 2.11        32   DppaI    14.2400
## 4045  32C 2.12        32   DppaI     4.2550
## 4046  32C 2.13        32   DppaI    13.4350
## 4047  32C 2.14        32   DppaI     9.9600
## 4048  32C 2.15        32   DppaI    13.8600
## 4049  32C 2.16        32   DppaI    11.5150
## 4050   32C 3.1        32   DppaI     0.4150
## 4051   32C 3.2        32   DppaI     3.6300
## 4052   32C 3.3        32   DppaI     1.5100
## 4053   32C 3.4        32   DppaI     2.1250
## 4054   32C 3.5        32   DppaI     3.7550
## 4055   32C 3.6        32   DppaI     9.7350
## 4056   32C 3.7        32   DppaI    11.9500
## 4057   32C 3.8        32   DppaI    13.7550
## 4058   32C 4.1        32   DppaI     3.2350
## 4059   32C 4.2        32   DppaI     2.2300
## 4060   32C 4.3        32   DppaI    11.3700
## 4061   32C 4.4        32   DppaI    11.2450
## 4062   32C 4.5        32   DppaI    14.8150
## 4063   32C 4.6        32   DppaI    14.1800
## 4064   32C 4.7        32   DppaI     5.7300
## 4065   32C 4.8        32   DppaI     3.6500
## 4066  32C 4.10        32   DppaI     3.2700
## 4067  32C 4.11        32   DppaI    11.6950
## 4068  32C 4.12        32   DppaI     0.9550
## 4069  32C 4.13        32   DppaI     1.6450
## 4070  32C 4.14        32   DppaI     7.8750
## 4071  32C 4.15        32   DppaI    13.5550
## 4072  32C 4.16        32   DppaI    11.0050
## 4073  32C 4.17        32   DppaI     4.9400
## 4074  32C 4.18        32   DppaI     1.3350
## 4075  32C 4.19        32   DppaI     2.1400
## 4076  32C 4.20        32   DppaI    11.2700
## 4077  32C 4.21        32   DppaI    10.7750
## 4078  32C 4.22        32   DppaI    11.6800
## 4079  32C 4.23        32   DppaI     2.1200
## 4080  32C 4.24        32   DppaI    14.4400
## 4081   32C 5.1        32   DppaI     3.6150
## 4082   32C 5.2        32   DppaI     2.2700
## 4083   32C 5.3        32   DppaI    13.2600
## 4084   32C 5.4        32   DppaI     1.5700
## 4085   32C 5.5        32   DppaI    10.9850
## 4086   32C 5.6        32   DppaI     0.9550
## 4087   32C 5.7        32   DppaI     2.6700
## 4088   32C 5.8        32   DppaI    12.3000
## 4089   32C 5.9        32   DppaI     3.4750
## 4090  32C 5.10        32   DppaI    13.6125
## 4091  32C 5.11        32   DppaI     5.0900
## 4092  32C 5.12        32   DppaI     8.1400
## 4093  32C 5.13        32   DppaI     2.6050
## 4094  32C 5.14        32   DppaI     0.6250
## 4095  32C 5.15        32   DppaI     2.7650
## 4096  32C 5.16        32   DppaI    -1.3800
## 4097  32C 5.17        32   DppaI     2.3600
## 4098  32C 5.18        32   DppaI     4.1450
## 4099  32C 5.19        32   DppaI    12.3100
## 4100  32C 5.20        32   DppaI     4.6300
## 4101  32C 5.21        32   DppaI     4.9250
## 4102  32C 5.22        32   DppaI    -0.4650
## 4103  32C 5.23        32   DppaI     1.0850
## 4104   32C 6.1        32   DppaI    12.6350
## 4105   32C 6.2        32   DppaI     0.1600
## 4106   32C 6.3        32   DppaI     3.0250
## 4107   32C 6.4        32   DppaI    13.7200
## 4108   32C 6.6        32   DppaI     2.1000
## 4109   32C 6.7        32   DppaI     6.2650
## 4110   32C 7.1        32   DppaI     0.9050
## 4111   32C 7.2        32   DppaI    11.8900
## 4112   32C 7.3        32   DppaI    -1.6450
## 4113   32C 7.4        32   DppaI     1.3300
## 4114   32C 7.5        32   DppaI     9.3900
## 4115   32C 7.6        32   DppaI    12.3400
## 4116   32C 7.8        32   DppaI     4.7600
## 4117   32C 8.1        32   DppaI     3.4050
## 4118   32C 8.2        32   DppaI     4.5350
## 4119   32C 8.4        32   DppaI     7.3450
## 4120   32C 8.5        32   DppaI    11.5100
## 4121   32C 8.6        32   DppaI    -0.3800
## 4122   64C 1.1        64   DppaI    11.3150
## 4123   64C 1.2        64   DppaI     1.8650
## 4124   64C 1.3        64   DppaI    13.3600
## 4125   64C 1.4        64   DppaI    14.2750
## 4126   64C 1.5        64   DppaI     9.2800
## 4127   64C 1.6        64   DppaI    13.2150
## 4128   64C 1.7        64   DppaI    14.4400
## 4129   64C 1.8        64   DppaI     2.0750
## 4130   64C 1.9        64   DppaI    11.0450
## 4131  64C 1.10        64   DppaI     0.9550
## 4132  64C 1.11        64   DppaI    11.5850
## 4133  64C 1.12        64   DppaI     6.5650
## 4134  64C 1.13        64   DppaI    13.8650
## 4135  64C 1.14        64   DppaI     4.5850
## 4136  64C 1.15        64   DppaI     7.9700
## 4137  64C 1.16        64   DppaI     3.7150
## 4138  64C 1.17        64   DppaI     1.6250
## 4139  64C 1.18        64   DppaI     3.0650
## 4140  64C 1.19        64   DppaI     3.3900
## 4141  64C 1.20        64   DppaI     1.7950
## 4142  64C 1.21        64   DppaI    13.4600
## 4143  64C 1.22        64   DppaI    13.4100
## 4144  64C 1.23        64   DppaI    11.5100
## 4145  64C 1.24        64   DppaI     4.5000
## 4146  64C 1.25        64   DppaI     4.0300
## 4147  64C 1.26        64   DppaI    10.9950
## 4148  64C 1.27        64   DppaI     0.0750
## 4149  64C 1.28        64   DppaI     1.4950
## 4150  64C 1.29        64   DppaI     1.3150
## 4151  64C 1.30        64   DppaI     4.7100
## 4152  64C 1.31        64   DppaI     1.7050
## 4153  64C 1.32        64   DppaI     2.1950
## 4154  64C 1.33        64   DppaI    -1.0000
## 4155  64C 1.34        64   DppaI     6.0600
## 4156  64C 1.35        64   DppaI    -0.6550
## 4157  64C 1.36        64   DppaI    -0.0750
## 4158  64C 1.37        64   DppaI     1.9800
## 4159  64C 1.38        64   DppaI     0.5700
## 4160  64C 1.39        64   DppaI     2.8550
## 4161  64C 1.40        64   DppaI    13.8250
## 4162  64C 1.41        64   DppaI    12.7650
## 4163  64C 1.42        64   DppaI    13.1700
## 4164  64C 1.43        64   DppaI    13.7550
## 4165  64C 1.44        64   DppaI     2.5250
## 4166  64C 1.45        64   DppaI     3.2200
## 4167  64C 1.46        64   DppaI    -0.6500
## 4168  64C 1.47        64   DppaI     0.6350
## 4169  64C 1.48        64   DppaI     3.4250
## 4170   64C 2.1        64   DppaI     2.7400
## 4171   64C 2.2        64   DppaI     3.3800
## 4172   64C 2.3        64   DppaI     5.8800
## 4173   64C 2.4        64   DppaI     4.6900
## 4174   64C 2.5        64   DppaI    11.6950
## 4175   64C 2.6        64   DppaI     3.3650
## 4176   64C 2.7        64   DppaI    12.1450
## 4177   64C 2.8        64   DppaI     7.3750
## 4178   64C 2.9        64   DppaI     2.7150
## 4179  64C 2.10        64   DppaI     2.5450
## 4180  64C 2.11        64   DppaI     3.8600
## 4181  64C 2.12        64   DppaI     1.8950
## 4182  64C 2.13        64   DppaI     4.6800
## 4183  64C 2.14        64   DppaI     0.2800
## 4184  64C 2.15        64   DppaI     0.2050
## 4185  64C 2.16        64   DppaI     7.2100
## 4186  64C 2.17        64   DppaI    11.8100
## 4187  64C 2.18        64   DppaI     2.0300
## 4188  64C 2.19        64   DppaI     2.6350
## 4189  64C 2.20        64   DppaI     2.7600
## 4190  64C 2.21        64   DppaI     2.9800
## 4191  64C 2.22        64   DppaI     2.0900
## 4192  64C 2.23        64   DppaI     2.0750
## 4193  64C 2.24        64   DppaI    -1.7350
## 4194  64C 2.25        64   DppaI     0.8300
## 4195   64C 3.1        64   DppaI     5.2100
## 4196   64C 3.2        64   DppaI     3.4550
## 4197   64C 3.3        64   DppaI     4.3325
## 4198   64C 3.4        64   DppaI     4.6700
## 4199   64C 3.5        64   DppaI    11.9800
## 4200   64C 3.6        64   DppaI     2.9750
## 4201   64C 3.7        64   DppaI     1.4050
## 4202   64C 3.8        64   DppaI     3.0250
## 4203   64C 4.1        64   DppaI    10.4200
## 4204  64C 4.1b        64   DppaI    13.2600
## 4205   64C 4.2        64   DppaI     8.8350
## 4206   64C 4.3        64   DppaI     5.0600
## 4207   64C 4.4        64   DppaI    12.9800
## 4208   64C 4.5        64   DppaI    13.5250
## 4209   64C 4.6        64   DppaI     9.2550
## 4210   64C 4.7        64   DppaI     0.3050
## 4211   64C 4.8        64   DppaI    12.6350
## 4212   64C 4.9        64   DppaI     1.4100
## 4213  64C 4.10        64   DppaI    13.0100
## 4214  64C 4.11        64   DppaI    13.7200
## 4215  64C 4.12        64   DppaI     2.8500
## 4216  64C 4.13        64   DppaI     2.9900
## 4217  64C 4.14        64   DppaI     1.9950
## 4218  64C 4.15        64   DppaI     3.3100
## 4219  64C 4.16        64   DppaI    -1.6350
## 4220  64C 4.17        64   DppaI     2.7050
## 4221  64C 4.18        64   DppaI    -1.3600
## 4222  64C 4.19        64   DppaI     3.5250
## 4223  64C 4.20        64   DppaI     2.4600
## 4224  64C 4.21        64   DppaI     3.5900
## 4225  64C 4.22        64   DppaI     4.2900
## 4226  64C 4.23        64   DppaI     1.7450
## 4227  64C 4.24        64   DppaI     2.2900
## 4228  64C 4.25        64   DppaI    -1.1500
## 4229  64C 4.26        64   DppaI    11.3150
## 4230  64C 4.27        64   DppaI    -0.0450
## 4231  64C 4.28        64   DppaI     6.3000
## 4232  64C 4.29        64   DppaI     3.2250
## 4233  64C 4.30        64   DppaI     6.8900
## 4234  64C 4.31        64   DppaI     3.3950
## 4235  64C 4.32        64   DppaI    10.4200
## 4236  64C 4.33        64   DppaI     1.2650
## 4237  64C 4.34        64   DppaI    -0.0150
## 4238  64C 4.35        64   DppaI     9.8950
## 4239  64C 4.36        64   DppaI    -1.0850
## 4240  64C 4.37        64   DppaI     2.8750
## 4241  64C 4.38        64   DppaI     2.3350
## 4242  64C 4.39        64   DppaI     2.5450
## 4243   64C 5.1        64   DppaI     6.6700
## 4244   64C 5.2        64   DppaI    13.5150
## 4245   64C 5.3        64   DppaI    11.9550
## 4246   64C 5.4        64   DppaI     4.4150
## 4247   64C 5.5        64   DppaI    12.4100
## 4248   64C 5.6        64   DppaI    12.4750
## 4249   64C 5.7        64   DppaI    13.4600
## 4250   64C 5.8        64   DppaI     9.3900
## 4251   64C 5.9        64   DppaI    11.5100
## 4252  64C 5.10        64   DppaI    13.9100
## 4253  64C 5.11        64   DppaI     3.2500
## 4254  64C 5.12        64   DppaI     2.7550
## 4255  64C 5.13        64   DppaI     1.6150
## 4256  64C 5.14        64   DppaI     1.7850
## 4257  64C 5.15        64   DppaI     6.6250
## 4258  64C 5.16        64   DppaI     6.2700
## 4259   64C 6.1        64   DppaI    12.6150
## 4260   64C 6.2        64   DppaI     8.9150
## 4261   64C 6.3        64   DppaI     9.9600
## 4262   64C 6.4        64   DppaI    13.8600
## 4263   64C 6.5        64   DppaI    11.5150
## 4264   64C 6.6        64   DppaI    11.6750
## 4265   64C 6.7        64   DppaI    12.6600
## 4266   64C 6.8        64   DppaI    11.7300
## 4267   64C 7.1        64   DppaI    13.2150
## 4268   64C 7.2        64   DppaI    13.8250
## 4269   64C 7.3        64   DppaI    10.2550
## 4270   64C 7.4        64   DppaI    13.1700
## 4271   64C 7.5        64   DppaI    13.7550
## 4272   64C 7.6        64   DppaI    11.6550
## 4273   64C 7.7        64   DppaI     8.3300
## 4274   64C 7.8        64   DppaI    11.3700
## 4275   64C 7.9        64   DppaI    11.2450
## 4276  64C 7.10        64   DppaI     5.0550
## 4277  64C 7.11        64   DppaI     3.6700
## 4278  64C 7.12        64   DppaI     3.0100
## 4279  64C 7.13        64   DppaI     4.6500
## 4280  64C 7.14        64   DppaI     3.1400
## 4281    2C 1.1         2   Eomes    10.1150
## 4282    2C 1.2         2   Eomes    11.0150
## 4283    2C 2.1         2   Eomes     8.6800
## 4284    2C 2.2         2   Eomes     9.3550
## 4285    2C 3.1         2   Eomes    12.8150
## 4286    2C 3.2         2   Eomes    11.6600
## 4287    2C 4.1         2   Eomes    10.9500
## 4288    2C 5.1         2   Eomes    11.1450
## 4289    2C 5.2         2   Eomes     8.1050
## 4290    2C 6.1         2   Eomes     8.9200
## 4291    2C 6.2         2   Eomes     5.4500
## 4292    2C 7.1         2   Eomes    11.6000
## 4293    2C 7.2         2   Eomes    12.0600
## 4294    2C 8.1         2   Eomes    11.0000
## 4295    2C 8.2         2   Eomes    11.8375
## 4296    2C 9.1         2   Eomes     8.9450
## 4297    2C 9.2         2   Eomes     9.5000
## 4298   2C 10.1         2   Eomes    12.1200
## 4299   2C 10.2         2   Eomes     6.9150
## 4300    4C 1.1         4   Eomes     9.0650
## 4301    4C 1.2         4   Eomes    12.8250
## 4302    4C 1.3         4   Eomes    13.2950
## 4303    4C 1.4         4   Eomes    13.6250
## 4304    4C 2.1         4   Eomes    12.0575
## 4305    4C 2.2         4   Eomes    14.2550
## 4306    4C 2.3         4   Eomes    12.1000
## 4307    4C 3.1         4   Eomes    12.7000
## 4308    4C 3.2         4   Eomes    10.3550
## 4309    4C 3.3         4   Eomes     9.9000
## 4310    4C 3.4         4   Eomes    10.7950
## 4311    4C 4.1         4   Eomes    10.4050
## 4312    4C 4.2         4   Eomes    13.5600
## 4313    4C 4.3         4   Eomes    12.7325
## 4314    4C 4.4         4   Eomes    12.4950
## 4315    4C 5.1         4   Eomes     7.9250
## 4316    4C 5.2         4   Eomes    12.4200
## 4317    4C 5.3         4   Eomes     9.0550
## 4318    4C 5.4         4   Eomes    12.3650
## 4319    4C 6.1         4   Eomes    11.6550
## 4320    4C 6.2         4   Eomes    12.8950
## 4321    4C 6.3         4   Eomes    13.8650
## 4322    4C 6.4         4   Eomes    12.5000
## 4323    8C 1.1         8   Eomes    11.9550
## 4324    8C 1.2         8   Eomes    13.1550
## 4325    8C 1.3         8   Eomes    11.4100
## 4326    8C 1.4         8   Eomes     9.5850
## 4327    8C 1.5         8   Eomes     7.5500
## 4328    8C 2.1         8   Eomes     4.3750
## 4329    8C 2.2         8   Eomes     8.0150
## 4330    8C 2.3         8   Eomes    10.2250
## 4331    8C 2.4         8   Eomes    12.8700
## 4332    8C 2.5         8   Eomes    15.0900
## 4333    8C 2.6         8   Eomes    10.2550
## 4334    8C 2.7         8   Eomes     7.3050
## 4335    8C 2.8         8   Eomes    10.5950
## 4336    8C 3.1         8   Eomes     7.8450
## 4337    8C 3.2         8   Eomes    10.8700
## 4338    8C 3.3         8   Eomes     7.6650
## 4339    8C 3.4         8   Eomes     8.7950
## 4340    8C 3.5         8   Eomes     7.4900
## 4341    8C 3.6         8   Eomes     8.9250
## 4342    8C 3.7         8   Eomes    13.0000
## 4343    8C 3.8         8   Eomes     7.0400
## 4344    8C 4.2         8   Eomes    11.9500
## 4345    8C 4.3         8   Eomes     9.8250
## 4346    8C 4.4         8   Eomes    10.6400
## 4347    8C 4.5         8   Eomes    11.0200
## 4348    8C 4.6         8   Eomes     9.8150
## 4349    8C 4.7         8   Eomes     8.1350
## 4350    8C 5.1         8   Eomes    14.4300
## 4351    8C 5.2         8   Eomes    13.4450
## 4352    8C 5.3         8   Eomes     7.4700
## 4353    8C 5.4         8   Eomes     7.9900
## 4354    8C 5.5         8   Eomes     6.3750
## 4355    8C 5.6         8   Eomes     6.7400
## 4356    8C 5.7         8   Eomes    10.4050
## 4357    8C 5.8         8   Eomes     9.4000
## 4358    8C 6.1         8   Eomes     9.1300
## 4359    8C 6.2         8   Eomes    13.3300
## 4360    8C 6.3         8   Eomes    13.0200
## 4361    8C 6.4         8   Eomes    10.5400
## 4362    8C 6.5         8   Eomes    10.4250
## 4363    8C 6.6         8   Eomes    12.3600
## 4364    8C 6.7         8   Eomes     8.5350
## 4365    8C 6.8         8   Eomes    13.5250
## 4366   16C 1.1        16   Eomes    10.2650
## 4367   16C 1.2        16   Eomes     8.1450
## 4368   16C 1.3        16   Eomes    10.2500
## 4369   16C 1.4        16   Eomes     5.9550
## 4370   16C 1.5        16   Eomes     4.3550
## 4371   16C 1.6        16   Eomes     3.3250
## 4372   16C 1.7        16   Eomes     7.4100
## 4373   16C 1.8        16   Eomes     4.4800
## 4374   16C 1.9        16   Eomes     7.4150
## 4375  16C 1.10        16   Eomes     9.8450
## 4376  16C 1.11        16   Eomes     5.8800
## 4377  16C 1.12        16   Eomes     8.0400
## 4378  16C 1.13        16   Eomes     8.5550
## 4379  16C 1.14        16   Eomes     6.3800
## 4380  16C 1.15        16   Eomes     4.2400
## 4381  16C 1.16        16   Eomes     7.0450
## 4382   16C 2.1        16   Eomes    10.0600
## 4383   16C 2.2        16   Eomes     9.5150
## 4384   16C 2.3        16   Eomes    13.7550
## 4385   16C 2.4        16   Eomes     9.5150
## 4386   16C 2.5        16   Eomes     9.0150
## 4387   16C 2.6        16   Eomes     5.7100
## 4388   16C 2.7        16   Eomes     7.2250
## 4389   16C 2.8        16   Eomes     6.4250
## 4390   16C 2.9        16   Eomes     7.6300
## 4391  16C 2.10        16   Eomes     7.1150
## 4392  16C 2.11        16   Eomes     9.1750
## 4393  16C 2.12        16   Eomes    13.9300
## 4394  16C 2.13        16   Eomes     7.7700
## 4395  16C 2.14        16   Eomes     8.0250
## 4396  16C 2.15        16   Eomes     9.0950
## 4397  16C 2.16        16   Eomes     8.6100
## 4398   16C 3.1        16   Eomes    11.5800
## 4399   16C 3.2        16   Eomes    11.6000
## 4400   16C 3.3        16   Eomes    12.6300
## 4401   16C 3.4        16   Eomes    13.2800
## 4402   16C 3.5        16   Eomes    12.2975
## 4403   16C 3.6        16   Eomes     8.8050
## 4404   16C 3.7        16   Eomes    11.5000
## 4405   16C 3.8        16   Eomes     9.7200
## 4406   16C 3.9        16   Eomes     8.0750
## 4407  16C 3.10        16   Eomes     9.0650
## 4408  16C 3.11        16   Eomes    12.3950
## 4409  16C 3.12        16   Eomes     9.4150
## 4410  16C 3.13        16   Eomes    12.3250
## 4411  16C 3.14        16   Eomes     7.2675
## 4412  16C 3.15        16   Eomes    12.9550
## 4413   16C 4.1        16   Eomes    12.2000
## 4414   16C 4.2        16   Eomes     7.9100
## 4415   16C 4.3        16   Eomes     6.2750
## 4416   16C 4.4        16   Eomes     8.8600
## 4417   16C 4.5        16   Eomes     9.6050
## 4418   16C 4.6        16   Eomes    12.8150
## 4419   16C 4.7        16   Eomes     7.8500
## 4420   16C 4.8        16   Eomes     9.2225
## 4421   16C 4.9        16   Eomes     8.5250
## 4422  16C 4.10        16   Eomes     7.4050
## 4423  16C 4.11        16   Eomes     7.7200
## 4424  16C 4.12        16   Eomes     5.6350
## 4425  16C 4.13        16   Eomes    10.3050
## 4426  16C 4.14        16   Eomes     7.7550
## 4427  16C 4.15        16   Eomes     8.3950
## 4428  16C 4.16        16   Eomes    13.8650
## 4429   16C 5.1        16   Eomes     7.1100
## 4430   16C 5.2        16   Eomes    11.0050
## 4431   16C 5.3        16   Eomes     6.2450
## 4432   16C 5.4        16   Eomes     5.0800
## 4433   16C 5.5        16   Eomes     5.2350
## 4434   16C 5.6        16   Eomes     4.5800
## 4435   16C 5.7        16   Eomes     6.2150
## 4436   16C 5.8        16   Eomes     7.8950
## 4437   16C 5.9        16   Eomes     8.1850
## 4438  16C 5.10        16   Eomes    12.8700
## 4439  16C 5.11        16   Eomes    11.1000
## 4440  16C 5.12        16   Eomes     7.5750
## 4441   32C 1.1        32   Eomes     1.2150
## 4442   32C 1.2        32   Eomes     5.1050
## 4443   32C 1.3        32   Eomes     3.9750
## 4444   32C 1.4        32   Eomes     2.6600
## 4445   32C 1.5        32   Eomes     7.7150
## 4446   32C 1.6        32   Eomes     9.0250
## 4447   32C 1.7        32   Eomes     5.4800
## 4448   32C 1.8        32   Eomes    13.1350
## 4449   32C 1.9        32   Eomes     7.5800
## 4450  32C 1.10        32   Eomes    11.9200
## 4451  32C 1.11        32   Eomes     5.4000
## 4452  32C 1.12        32   Eomes     4.7950
## 4453  32C 1.13        32   Eomes     7.2200
## 4454  32C 1.14        32   Eomes     7.2500
## 4455  32C 1.15        32   Eomes     8.1050
## 4456  32C 1.16        32   Eomes     7.3850
## 4457  32C 1.17        32   Eomes     9.5400
## 4458  32C 1.18        32   Eomes     8.5850
## 4459  32C 1.19        32   Eomes    11.9400
## 4460  32C 1.20        32   Eomes     7.5000
## 4461  32C 1.21        32   Eomes     8.7950
## 4462   32C 2.1        32   Eomes     6.6000
## 4463   32C 2.2        32   Eomes    10.7950
## 4464   32C 2.3        32   Eomes     6.7500
## 4465   32C 2.4        32   Eomes     6.9000
## 4466   32C 2.5        32   Eomes     9.9800
## 4467   32C 2.6        32   Eomes     8.5400
## 4468   32C 2.7        32   Eomes     6.4400
## 4469   32C 2.8        32   Eomes     8.1550
## 4470   32C 2.9        32   Eomes    11.7600
## 4471  32C 2.10        32   Eomes     3.8350
## 4472  32C 2.11        32   Eomes    10.0550
## 4473  32C 2.12        32   Eomes     6.7450
## 4474  32C 2.13        32   Eomes     8.9950
## 4475  32C 2.14        32   Eomes     9.5900
## 4476  32C 2.15        32   Eomes     7.8450
## 4477  32C 2.16        32   Eomes     8.0250
## 4478   32C 3.1        32   Eomes     1.2050
## 4479   32C 3.2        32   Eomes     8.8100
## 4480   32C 3.3        32   Eomes     4.8300
## 4481   32C 3.4        32   Eomes     9.0150
## 4482   32C 3.5        32   Eomes     7.1250
## 4483   32C 3.6        32   Eomes     6.2100
## 4484   32C 3.7        32   Eomes    11.5500
## 4485   32C 3.8        32   Eomes    10.6450
## 4486   32C 4.1        32   Eomes     4.2600
## 4487   32C 4.2        32   Eomes     4.2100
## 4488   32C 4.3        32   Eomes    12.3250
## 4489   32C 4.4        32   Eomes     9.4500
## 4490   32C 4.5        32   Eomes    12.4750
## 4491   32C 4.6        32   Eomes    10.0150
## 4492   32C 4.7        32   Eomes     9.9450
## 4493   32C 4.8        32   Eomes     6.9150
## 4494  32C 4.10        32   Eomes     6.1600
## 4495  32C 4.11        32   Eomes     9.8550
## 4496  32C 4.12        32   Eomes     6.1550
## 4497  32C 4.13        32   Eomes    12.5300
## 4498  32C 4.14        32   Eomes     8.2550
## 4499  32C 4.15        32   Eomes    11.8550
## 4500  32C 4.16        32   Eomes     9.1500
## 4501  32C 4.17        32   Eomes    10.4400
## 4502  32C 4.18        32   Eomes     5.2250
## 4503  32C 4.19        32   Eomes     3.3150
## 4504  32C 4.20        32   Eomes     9.4400
## 4505  32C 4.21        32   Eomes     7.5600
## 4506  32C 4.22        32   Eomes     8.2400
## 4507  32C 4.23        32   Eomes     4.6500
## 4508  32C 4.24        32   Eomes    10.6000
## 4509   32C 5.1        32   Eomes     9.3975
## 4510   32C 5.2        32   Eomes     7.6650
## 4511   32C 5.3        32   Eomes     5.3000
## 4512   32C 5.4        32   Eomes     3.3300
## 4513   32C 5.5        32   Eomes    10.9750
## 4514   32C 5.6        32   Eomes     2.7750
## 4515   32C 5.7        32   Eomes     6.2550
## 4516   32C 5.8        32   Eomes     9.1350
## 4517   32C 5.9        32   Eomes     6.1850
## 4518  32C 5.10        32   Eomes    12.0575
## 4519  32C 5.11        32   Eomes    13.5550
## 4520  32C 5.12        32   Eomes    12.2000
## 4521  32C 5.13        32   Eomes     4.7600
## 4522  32C 5.14        32   Eomes     3.8450
## 4523  32C 5.15        32   Eomes     4.9400
## 4524  32C 5.16        32   Eomes     3.7350
## 4525  32C 5.17        32   Eomes     7.5250
## 4526  32C 5.18        32   Eomes     8.1400
## 4527  32C 5.19        32   Eomes     7.2225
## 4528  32C 5.20        32   Eomes     9.4750
## 4529  32C 5.21        32   Eomes     6.1350
## 4530  32C 5.22        32   Eomes     9.8200
## 4531  32C 5.23        32   Eomes    10.4750
## 4532   32C 6.1        32   Eomes     5.3500
## 4533   32C 6.2        32   Eomes     3.5600
## 4534   32C 6.3        32   Eomes     5.9050
## 4535   32C 6.4        32   Eomes     8.9050
## 4536   32C 6.6        32   Eomes     8.2450
## 4537   32C 6.7        32   Eomes    12.8450
## 4538   32C 7.1        32   Eomes     5.5450
## 4539   32C 7.2        32   Eomes     7.7300
## 4540   32C 7.3        32   Eomes     5.1750
## 4541   32C 7.4        32   Eomes     6.4500
## 4542   32C 7.5        32   Eomes     5.7550
## 4543   32C 7.6        32   Eomes     8.6500
## 4544   32C 7.8        32   Eomes     7.6800
## 4545   32C 8.1        32   Eomes     7.7250
## 4546   32C 8.2        32   Eomes     8.8300
## 4547   32C 8.4        32   Eomes     7.4150
## 4548   32C 8.5        32   Eomes     8.2350
## 4549   32C 8.6        32   Eomes     6.0000
## 4550   64C 1.1        64   Eomes     4.9050
## 4551   64C 1.2        64   Eomes     1.2500
## 4552   64C 1.3        64   Eomes    12.5350
## 4553   64C 1.4        64   Eomes    12.4550
## 4554   64C 1.5        64   Eomes     7.4000
## 4555   64C 1.6        64   Eomes    12.7450
## 4556   64C 1.7        64   Eomes    10.0700
## 4557   64C 1.8        64   Eomes     4.4800
## 4558   64C 1.9        64   Eomes    11.8500
## 4559  64C 1.10        64   Eomes     4.8750
## 4560  64C 1.11        64   Eomes     6.5500
## 4561  64C 1.12        64   Eomes     6.6600
## 4562  64C 1.13        64   Eomes    10.2750
## 4563  64C 1.14        64   Eomes     6.6750
## 4564  64C 1.15        64   Eomes     7.5700
## 4565  64C 1.16        64   Eomes     4.9950
## 4566  64C 1.17        64   Eomes     6.1600
## 4567  64C 1.18        64   Eomes     4.1400
## 4568  64C 1.19        64   Eomes     4.9350
## 4569  64C 1.20        64   Eomes     6.9600
## 4570  64C 1.21        64   Eomes    13.5550
## 4571  64C 1.22        64   Eomes    10.3400
## 4572  64C 1.23        64   Eomes    13.2900
## 4573  64C 1.24        64   Eomes     8.0200
## 4574  64C 1.25        64   Eomes    10.4500
## 4575  64C 1.26        64   Eomes     6.9100
## 4576  64C 1.27        64   Eomes     5.2550
## 4577  64C 1.28        64   Eomes     4.4900
## 4578  64C 1.29        64   Eomes     2.4650
## 4579  64C 1.30        64   Eomes     7.0350
## 4580  64C 1.31        64   Eomes     5.1250
## 4581  64C 1.32        64   Eomes     5.5850
## 4582  64C 1.33        64   Eomes     8.5000
## 4583  64C 1.34        64   Eomes     8.2550
## 4584  64C 1.35        64   Eomes     1.6850
## 4585  64C 1.36        64   Eomes     1.1550
## 4586  64C 1.37        64   Eomes     5.7700
## 4587  64C 1.38        64   Eomes     4.2100
## 4588  64C 1.39        64   Eomes     6.5950
## 4589  64C 1.40        64   Eomes    13.3950
## 4590  64C 1.41        64   Eomes     9.1800
## 4591  64C 1.42        64   Eomes    13.7500
## 4592  64C 1.43        64   Eomes    14.7950
## 4593  64C 1.44        64   Eomes     5.9200
## 4594  64C 1.45        64   Eomes     3.3700
## 4595  64C 1.46        64   Eomes     5.4450
## 4596  64C 1.47        64   Eomes     4.7300
## 4597  64C 1.48        64   Eomes     5.6050
## 4598   64C 2.1        64   Eomes     5.0150
## 4599   64C 2.2        64   Eomes     4.8050
## 4600   64C 2.3        64   Eomes     6.8350
## 4601   64C 2.4        64   Eomes     4.9100
## 4602   64C 2.5        64   Eomes    12.4350
## 4603   64C 2.6        64   Eomes     5.7350
## 4604   64C 2.7        64   Eomes    13.6300
## 4605   64C 2.8        64   Eomes    12.4050
## 4606   64C 2.9        64   Eomes     5.4650
## 4607  64C 2.10        64   Eomes     4.0200
## 4608  64C 2.11        64   Eomes     5.9200
## 4609  64C 2.12        64   Eomes     4.2450
## 4610  64C 2.13        64   Eomes     4.4250
## 4611  64C 2.14        64   Eomes     5.1700
## 4612  64C 2.15        64   Eomes     4.1400
## 4613  64C 2.16        64   Eomes     8.1100
## 4614  64C 2.17        64   Eomes    12.6300
## 4615  64C 2.18        64   Eomes     3.1400
## 4616  64C 2.19        64   Eomes     3.7275
## 4617  64C 2.20        64   Eomes     5.0050
## 4618  64C 2.21        64   Eomes     3.8800
## 4619  64C 2.22        64   Eomes     5.0800
## 4620  64C 2.23        64   Eomes     4.5350
## 4621  64C 2.24        64   Eomes     1.6850
## 4622  64C 2.25        64   Eomes     6.2050
## 4623   64C 3.1        64   Eomes     4.2750
## 4624   64C 3.2        64   Eomes     7.4250
## 4625   64C 3.3        64   Eomes     6.5075
## 4626   64C 3.4        64   Eomes     6.2350
## 4627   64C 3.5        64   Eomes     8.1800
## 4628   64C 3.6        64   Eomes     7.0100
## 4629   64C 3.7        64   Eomes     3.0150
## 4630   64C 3.8        64   Eomes     3.6400
## 4631   64C 4.1        64   Eomes     8.7750
## 4632  64C 4.1b        64   Eomes     7.3350
## 4633   64C 4.2        64   Eomes    10.0800
## 4634   64C 4.3        64   Eomes     8.3625
## 4635   64C 4.4        64   Eomes     8.4650
## 4636   64C 4.5        64   Eomes    11.6150
## 4637   64C 4.6        64   Eomes     7.9700
## 4638   64C 4.7        64   Eomes     1.0450
## 4639   64C 4.8        64   Eomes     6.6450
## 4640   64C 4.9        64   Eomes     3.0450
## 4641  64C 4.10        64   Eomes     7.1950
## 4642  64C 4.11        64   Eomes    13.8650
## 4643  64C 4.12        64   Eomes     1.9700
## 4644  64C 4.13        64   Eomes     3.6850
## 4645  64C 4.14        64   Eomes     5.0050
## 4646  64C 4.15        64   Eomes     2.3700
## 4647  64C 4.16        64   Eomes     0.1950
## 4648  64C 4.17        64   Eomes     3.1200
## 4649  64C 4.18        64   Eomes     1.3450
## 4650  64C 4.19        64   Eomes     2.8050
## 4651  64C 4.20        64   Eomes     3.5850
## 4652  64C 4.21        64   Eomes     4.5900
## 4653  64C 4.22        64   Eomes     5.5600
## 4654  64C 4.23        64   Eomes     6.5850
## 4655  64C 4.24        64   Eomes     2.0150
## 4656  64C 4.25        64   Eomes     2.9850
## 4657  64C 4.26        64   Eomes     6.3250
## 4658  64C 4.27        64   Eomes     2.7700
## 4659  64C 4.28        64   Eomes     5.4650
## 4660  64C 4.29        64   Eomes     4.2150
## 4661  64C 4.30        64   Eomes     6.4100
## 4662  64C 4.31        64   Eomes     2.9750
## 4663  64C 4.32        64   Eomes    13.9900
## 4664  64C 4.33        64   Eomes     2.7700
## 4665  64C 4.34        64   Eomes     0.7000
## 4666  64C 4.35        64   Eomes     5.3550
## 4667  64C 4.36        64   Eomes     2.3300
## 4668  64C 4.37        64   Eomes     4.4600
## 4669  64C 4.38        64   Eomes     3.2950
## 4670  64C 4.39        64   Eomes     5.8250
## 4671   64C 5.1        64   Eomes     4.5400
## 4672   64C 5.2        64   Eomes     7.0950
## 4673   64C 5.3        64   Eomes     4.8100
## 4674   64C 5.4        64   Eomes     1.8400
## 4675   64C 5.5        64   Eomes     7.2650
## 4676   64C 5.6        64   Eomes    12.2600
## 4677   64C 5.7        64   Eomes     8.5450
## 4678   64C 5.8        64   Eomes    10.4400
## 4679   64C 5.9        64   Eomes     7.0600
## 4680  64C 5.10        64   Eomes     8.6900
## 4681  64C 5.11        64   Eomes     2.1300
## 4682  64C 5.12        64   Eomes     2.8000
## 4683  64C 5.13        64   Eomes     0.6950
## 4684  64C 5.14        64   Eomes     1.6600
## 4685  64C 5.15        64   Eomes     5.4250
## 4686  64C 5.16        64   Eomes     9.0550
## 4687   64C 6.1        64   Eomes     9.6250
## 4688   64C 6.2        64   Eomes    13.6650
## 4689   64C 6.3        64   Eomes    15.9200
## 4690   64C 6.4        64   Eomes    12.7750
## 4691   64C 6.5        64   Eomes    11.7950
## 4692   64C 6.6        64   Eomes     4.6650
## 4693   64C 6.7        64   Eomes    11.0400
## 4694   64C 6.8        64   Eomes     6.8200
## 4695   64C 7.1        64   Eomes    10.9650
## 4696   64C 7.2        64   Eomes    10.2750
## 4697   64C 7.3        64   Eomes    10.4200
## 4698   64C 7.4        64   Eomes     8.4100
## 4699   64C 7.5        64   Eomes    12.2050
## 4700   64C 7.6        64   Eomes     7.5100
## 4701   64C 7.7        64   Eomes     6.3300
## 4702   64C 7.8        64   Eomes    12.3250
## 4703   64C 7.9        64   Eomes     8.0400
## 4704  64C 7.10        64   Eomes     6.4450
## 4705  64C 7.11        64   Eomes     6.3750
## 4706  64C 7.12        64   Eomes     2.2350
## 4707  64C 7.13        64   Eomes     6.5250
## 4708  64C 7.14        64   Eomes     4.8300
## 4709    2C 1.1         2   Esrrb     4.9350
## 4710    2C 1.2         2   Esrrb     4.4850
## 4711    2C 2.1         2   Esrrb     2.6950
## 4712    2C 2.2         2   Esrrb     3.6600
## 4713    2C 3.1         2   Esrrb     8.5600
## 4714    2C 3.2         2   Esrrb     6.2750
## 4715    2C 4.1         2   Esrrb     7.0650
## 4716    2C 5.1         2   Esrrb     5.5400
## 4717    2C 5.2         2   Esrrb     5.7700
## 4718    2C 6.1         2   Esrrb     4.0450
## 4719    2C 6.2         2   Esrrb     1.2350
## 4720    2C 7.1         2   Esrrb     4.3250
## 4721    2C 7.2         2   Esrrb     5.7550
## 4722    2C 8.1         2   Esrrb     7.1100
## 4723    2C 8.2         2   Esrrb     9.6450
## 4724    2C 9.1         2   Esrrb     8.6600
## 4725    2C 9.2         2   Esrrb     5.9900
## 4726   2C 10.1         2   Esrrb     6.5250
## 4727   2C 10.2         2   Esrrb     3.8950
## 4728    4C 1.1         4   Esrrb     5.7950
## 4729    4C 1.2         4   Esrrb     6.3550
## 4730    4C 1.3         4   Esrrb     6.8450
## 4731    4C 1.4         4   Esrrb     7.0900
## 4732    4C 2.1         4   Esrrb     6.1350
## 4733    4C 2.2         4   Esrrb     7.8100
## 4734    4C 2.3         4   Esrrb     3.7900
## 4735    4C 3.1         4   Esrrb     5.4850
## 4736    4C 3.2         4   Esrrb     4.2050
## 4737    4C 3.3         4   Esrrb     6.5250
## 4738    4C 3.4         4   Esrrb     6.3450
## 4739    4C 4.1         4   Esrrb     7.9900
## 4740    4C 4.2         4   Esrrb     7.3850
## 4741    4C 4.3         4   Esrrb     6.9325
## 4742    4C 4.4         4   Esrrb     7.6800
## 4743    4C 5.1         4   Esrrb     5.6000
## 4744    4C 5.2         4   Esrrb     5.0900
## 4745    4C 5.3         4   Esrrb     3.0300
## 4746    4C 5.4         4   Esrrb     3.7750
## 4747    4C 6.1         4   Esrrb     2.9700
## 4748    4C 6.2         4   Esrrb     5.8900
## 4749    4C 6.3         4   Esrrb     6.2250
## 4750    4C 6.4         4   Esrrb     3.4825
## 4751    8C 1.1         8   Esrrb     7.8650
## 4752    8C 1.2         8   Esrrb     8.2750
## 4753    8C 1.3         8   Esrrb     5.3050
## 4754    8C 1.4         8   Esrrb     2.2750
## 4755    8C 1.5         8   Esrrb     4.9250
## 4756    8C 2.1         8   Esrrb     3.1550
## 4757    8C 2.2         8   Esrrb     5.1900
## 4758    8C 2.3         8   Esrrb     6.3800
## 4759    8C 2.4         8   Esrrb     6.7100
## 4760    8C 2.5         8   Esrrb     7.0450
## 4761    8C 2.6         8   Esrrb     6.1900
## 4762    8C 2.7         8   Esrrb     3.2950
## 4763    8C 2.8         8   Esrrb     6.8000
## 4764    8C 3.1         8   Esrrb     4.9450
## 4765    8C 3.2         8   Esrrb     5.7600
## 4766    8C 3.3         8   Esrrb     8.0900
## 4767    8C 3.4         8   Esrrb     6.6350
## 4768    8C 3.5         8   Esrrb     4.5700
## 4769    8C 3.6         8   Esrrb     7.7450
## 4770    8C 3.7         8   Esrrb     6.5800
## 4771    8C 3.8         8   Esrrb     5.2400
## 4772    8C 4.2         8   Esrrb     7.9300
## 4773    8C 4.3         8   Esrrb     5.1050
## 4774    8C 4.4         8   Esrrb     5.6200
## 4775    8C 4.5         8   Esrrb     9.4700
## 4776    8C 4.6         8   Esrrb     9.6200
## 4777    8C 4.7         8   Esrrb     5.5350
## 4778    8C 5.1         8   Esrrb     5.9200
## 4779    8C 5.2         8   Esrrb     6.7400
## 4780    8C 5.3         8   Esrrb     4.9050
## 4781    8C 5.4         8   Esrrb     4.5600
## 4782    8C 5.5         8   Esrrb     5.2150
## 4783    8C 5.6         8   Esrrb     3.9800
## 4784    8C 5.7         8   Esrrb     6.9450
## 4785    8C 5.8         8   Esrrb     6.9000
## 4786    8C 6.1         8   Esrrb     7.5150
## 4787    8C 6.2         8   Esrrb     9.2400
## 4788    8C 6.3         8   Esrrb     7.8450
## 4789    8C 6.4         8   Esrrb     5.2350
## 4790    8C 6.5         8   Esrrb     6.7150
## 4791    8C 6.6         8   Esrrb     9.6650
## 4792    8C 6.7         8   Esrrb     6.2600
## 4793    8C 6.8         8   Esrrb     6.0700
## 4794   16C 1.1        16   Esrrb     8.4150
## 4795   16C 1.2        16   Esrrb     8.1050
## 4796   16C 1.3        16   Esrrb     8.3100
## 4797   16C 1.4        16   Esrrb     6.7350
## 4798   16C 1.5        16   Esrrb     6.0150
## 4799   16C 1.6        16   Esrrb     5.9400
## 4800   16C 1.7        16   Esrrb     5.6700
## 4801   16C 1.8        16   Esrrb     5.5500
## 4802   16C 1.9        16   Esrrb     9.0700
## 4803  16C 1.10        16   Esrrb     6.6450
## 4804  16C 1.11        16   Esrrb     5.0000
## 4805  16C 1.12        16   Esrrb     7.6200
## 4806  16C 1.13        16   Esrrb     8.4700
## 4807  16C 1.14        16   Esrrb     5.0600
## 4808  16C 1.15        16   Esrrb     3.8950
## 4809  16C 1.16        16   Esrrb     5.2400
## 4810   16C 2.1        16   Esrrb    12.6600
## 4811   16C 2.2        16   Esrrb    14.2350
## 4812   16C 2.3        16   Esrrb    10.1400
## 4813   16C 2.4        16   Esrrb     9.9350
## 4814   16C 2.5        16   Esrrb     7.5000
## 4815   16C 2.6        16   Esrrb     6.0100
## 4816   16C 2.7        16   Esrrb     5.7950
## 4817   16C 2.8        16   Esrrb     7.1650
## 4818   16C 2.9        16   Esrrb     5.4350
## 4819  16C 2.10        16   Esrrb     5.4800
## 4820  16C 2.11        16   Esrrb     7.0900
## 4821  16C 2.12        16   Esrrb    13.0850
## 4822  16C 2.13        16   Esrrb     9.3850
## 4823  16C 2.14        16   Esrrb     7.4900
## 4824  16C 2.15        16   Esrrb     8.0500
## 4825  16C 2.16        16   Esrrb     5.4850
## 4826   16C 3.1        16   Esrrb     2.0350
## 4827   16C 3.2        16   Esrrb     5.5650
## 4828   16C 3.3        16   Esrrb     4.8350
## 4829   16C 3.4        16   Esrrb     7.8100
## 4830   16C 3.5        16   Esrrb     7.2150
## 4831   16C 3.6        16   Esrrb     9.6400
## 4832   16C 3.7        16   Esrrb     8.5300
## 4833   16C 3.8        16   Esrrb     6.9650
## 4834   16C 3.9        16   Esrrb     5.4350
## 4835  16C 3.10        16   Esrrb     5.1850
## 4836  16C 3.11        16   Esrrb     8.2250
## 4837  16C 3.12        16   Esrrb    13.3750
## 4838  16C 3.13        16   Esrrb     8.3400
## 4839  16C 3.14        16   Esrrb    13.1050
## 4840  16C 3.15        16   Esrrb     7.7700
## 4841   16C 4.1        16   Esrrb     4.5700
## 4842   16C 4.2        16   Esrrb     5.8650
## 4843   16C 4.3        16   Esrrb     3.7350
## 4844   16C 4.4        16   Esrrb     5.1750
## 4845   16C 4.5        16   Esrrb     5.9550
## 4846   16C 4.6        16   Esrrb     6.0400
## 4847   16C 4.7        16   Esrrb     6.9450
## 4848   16C 4.8        16   Esrrb     8.6625
## 4849   16C 4.9        16   Esrrb     5.9900
## 4850  16C 4.10        16   Esrrb     6.8300
## 4851  16C 4.11        16   Esrrb     5.1400
## 4852  16C 4.12        16   Esrrb     3.2800
## 4853  16C 4.13        16   Esrrb     6.5550
## 4854  16C 4.14        16   Esrrb     6.0100
## 4855  16C 4.15        16   Esrrb     6.5200
## 4856  16C 4.16        16   Esrrb     6.6850
## 4857   16C 5.1        16   Esrrb     5.7725
## 4858   16C 5.2        16   Esrrb     8.1950
## 4859   16C 5.3        16   Esrrb     8.7350
## 4860   16C 5.4        16   Esrrb     4.6050
## 4861   16C 5.5        16   Esrrb     2.8250
## 4862   16C 5.6        16   Esrrb     7.2550
## 4863   16C 5.7        16   Esrrb     2.9250
## 4864   16C 5.8        16   Esrrb     7.3500
## 4865   16C 5.9        16   Esrrb     6.0500
## 4866  16C 5.10        16   Esrrb     4.4100
## 4867  16C 5.11        16   Esrrb    10.4750
## 4868  16C 5.12        16   Esrrb     5.7000
## 4869   32C 1.1        32   Esrrb     9.2250
## 4870   32C 1.2        32   Esrrb     5.1400
## 4871   32C 1.3        32   Esrrb    11.3750
## 4872   32C 1.4        32   Esrrb    10.9100
## 4873   32C 1.5        32   Esrrb     7.7700
## 4874   32C 1.6        32   Esrrb     6.5650
## 4875   32C 1.7        32   Esrrb     7.4500
## 4876   32C 1.8        32   Esrrb     8.3650
## 4877   32C 1.9        32   Esrrb     8.5400
## 4878  32C 1.10        32   Esrrb     6.4900
## 4879  32C 1.11        32   Esrrb     7.9500
## 4880  32C 1.12        32   Esrrb    12.1650
## 4881  32C 1.13        32   Esrrb     6.0300
## 4882  32C 1.14        32   Esrrb    14.7500
## 4883  32C 1.15        32   Esrrb     8.2600
## 4884  32C 1.16        32   Esrrb     6.2350
## 4885  32C 1.17        32   Esrrb     7.2600
## 4886  32C 1.18        32   Esrrb     6.7500
## 4887  32C 1.19        32   Esrrb     6.1850
## 4888  32C 1.20        32   Esrrb     5.9600
## 4889  32C 1.21        32   Esrrb     5.1350
## 4890   32C 2.1        32   Esrrb    11.2000
## 4891   32C 2.2        32   Esrrb    14.7350
## 4892   32C 2.3        32   Esrrb    13.0900
## 4893   32C 2.4        32   Esrrb     7.2150
## 4894   32C 2.5        32   Esrrb    12.1600
## 4895   32C 2.6        32   Esrrb    14.4450
## 4896   32C 2.7        32   Esrrb     9.2550
## 4897   32C 2.8        32   Esrrb     6.7650
## 4898   32C 2.9        32   Esrrb    10.7250
## 4899  32C 2.10        32   Esrrb    11.6200
## 4900  32C 2.11        32   Esrrb     8.6000
## 4901  32C 2.12        32   Esrrb    12.9150
## 4902  32C 2.13        32   Esrrb    13.2550
## 4903  32C 2.14        32   Esrrb     9.8200
## 4904  32C 2.15        32   Esrrb     8.5950
## 4905  32C 2.16        32   Esrrb     6.9150
## 4906   32C 3.1        32   Esrrb    11.5100
## 4907   32C 3.2        32   Esrrb    12.4300
## 4908   32C 3.3        32   Esrrb    11.7000
## 4909   32C 3.4        32   Esrrb    14.3100
## 4910   32C 3.5        32   Esrrb    13.5650
## 4911   32C 3.6        32   Esrrb     5.6800
## 4912   32C 3.7        32   Esrrb     7.3800
## 4913   32C 3.8        32   Esrrb     7.6500
## 4914   32C 4.1        32   Esrrb    12.0900
## 4915   32C 4.2        32   Esrrb     9.6850
## 4916   32C 4.3        32   Esrrb     5.1300
## 4917   32C 4.4        32   Esrrb     6.8500
## 4918   32C 4.5        32   Esrrb     8.5650
## 4919   32C 4.6        32   Esrrb     6.1800
## 4920   32C 4.7        32   Esrrb    14.3950
## 4921   32C 4.8        32   Esrrb    10.9500
## 4922  32C 4.10        32   Esrrb    12.7300
## 4923  32C 4.11        32   Esrrb     5.0150
## 4924  32C 4.12        32   Esrrb    11.5450
## 4925  32C 4.13        32   Esrrb    10.8650
## 4926  32C 4.14        32   Esrrb     3.7100
## 4927  32C 4.15        32   Esrrb     6.4900
## 4928  32C 4.16        32   Esrrb     6.2550
## 4929  32C 4.17        32   Esrrb    13.9450
## 4930  32C 4.18        32   Esrrb    13.1700
## 4931  32C 4.19        32   Esrrb    12.1000
## 4932  32C 4.20        32   Esrrb     5.4050
## 4933  32C 4.21        32   Esrrb     0.6950
## 4934  32C 4.22        32   Esrrb     3.1450
## 4935  32C 4.23        32   Esrrb     7.2350
## 4936  32C 4.24        32   Esrrb     5.5600
## 4937   32C 5.1        32   Esrrb    14.3150
## 4938   32C 5.2        32   Esrrb    10.9400
## 4939   32C 5.3        32   Esrrb     5.4500
## 4940   32C 5.4        32   Esrrb     7.1950
## 4941   32C 5.5        32   Esrrb     6.1650
## 4942   32C 5.6        32   Esrrb    11.5250
## 4943   32C 5.7        32   Esrrb    12.4650
## 4944   32C 5.8        32   Esrrb     7.7450
## 4945   32C 5.9        32   Esrrb    13.6300
## 4946  32C 5.10        32   Esrrb     9.3450
## 4947  32C 5.11        32   Esrrb    13.8700
## 4948  32C 5.12        32   Esrrb     5.1300
## 4949  32C 5.13        32   Esrrb    12.5750
## 4950  32C 5.14        32   Esrrb     4.9750
## 4951  32C 5.15        32   Esrrb    11.9650
## 4952  32C 5.16        32   Esrrb    10.7850
## 4953  32C 5.17        32   Esrrb     8.5300
## 4954  32C 5.18        32   Esrrb    13.6550
## 4955  32C 5.19        32   Esrrb     5.8125
## 4956  32C 5.20        32   Esrrb    12.2800
## 4957  32C 5.21        32   Esrrb    13.0100
## 4958  32C 5.22        32   Esrrb    12.2600
## 4959  32C 5.23        32   Esrrb    10.3100
## 4960   32C 6.1        32   Esrrb     4.9650
## 4961   32C 6.2        32   Esrrb     5.4750
## 4962   32C 6.3        32   Esrrb    13.3600
## 4963   32C 6.4        32   Esrrb     9.1050
## 4964   32C 6.6        32   Esrrb    12.0825
## 4965   32C 6.7        32   Esrrb    14.2450
## 4966   32C 7.1        32   Esrrb     9.1100
## 4967   32C 7.2        32   Esrrb     8.2350
## 4968   32C 7.3        32   Esrrb     9.4650
## 4969   32C 7.4        32   Esrrb    11.1450
## 4970   32C 7.5        32   Esrrb     3.3550
## 4971   32C 7.6        32   Esrrb    12.9200
## 4972   32C 7.8        32   Esrrb    13.7500
## 4973   32C 8.1        32   Esrrb    11.4600
## 4974   32C 8.2        32   Esrrb    13.8850
## 4975   32C 8.4        32   Esrrb     9.9200
## 4976   32C 8.5        32   Esrrb     6.1700
## 4977   32C 8.6        32   Esrrb    11.2100
## 4978   64C 1.1        64   Esrrb     9.0250
## 4979   64C 1.2        64   Esrrb    10.9100
## 4980   64C 1.3        64   Esrrb     6.1600
## 4981   64C 1.4        64   Esrrb    13.5550
## 4982   64C 1.5        64   Esrrb     8.1000
## 4983   64C 1.6        64   Esrrb     7.6550
## 4984   64C 1.7        64   Esrrb    10.4000
## 4985   64C 1.8        64   Esrrb    11.8600
## 4986   64C 1.9        64   Esrrb    11.6300
## 4987  64C 1.10        64   Esrrb    12.1650
## 4988  64C 1.11        64   Esrrb     7.3600
## 4989  64C 1.12        64   Esrrb    14.7500
## 4990  64C 1.13        64   Esrrb    14.1500
## 4991  64C 1.14        64   Esrrb    12.2850
## 4992  64C 1.15        64   Esrrb    14.0100
## 4993  64C 1.16        64   Esrrb    13.3200
## 4994  64C 1.17        64   Esrrb    12.5450
## 4995  64C 1.18        64   Esrrb    11.2900
## 4996  64C 1.19        64   Esrrb    11.8950
## 4997  64C 1.20        64   Esrrb    11.2000
## 4998  64C 1.21        64   Esrrb    12.0550
## 4999  64C 1.22        64   Esrrb     7.5700
## 5000  64C 1.23        64   Esrrb     7.6250
## 5001  64C 1.24        64   Esrrb    14.8100
## 5002  64C 1.25        64   Esrrb    14.4450
## 5003  64C 1.26        64   Esrrb    12.3950
## 5004  64C 1.27        64   Esrrb    12.1750
## 5005  64C 1.28        64   Esrrb    12.4150
## 5006  64C 1.29        64   Esrrb    11.6200
## 5007  64C 1.30        64   Esrrb    10.9600
## 5008  64C 1.31        64   Esrrb     8.7450
## 5009  64C 1.32        64   Esrrb    13.2550
## 5010  64C 1.33        64   Esrrb    14.6800
## 5011  64C 1.34        64   Esrrb    13.8750
## 5012  64C 1.35        64   Esrrb    11.1850
## 5013  64C 1.36        64   Esrrb    11.5100
## 5014  64C 1.37        64   Esrrb    12.4300
## 5015  64C 1.38        64   Esrrb    11.7000
## 5016  64C 1.39        64   Esrrb    14.3100
## 5017  64C 1.40        64   Esrrb     6.5950
## 5018  64C 1.41        64   Esrrb     8.9200
## 5019  64C 1.42        64   Esrrb     7.5000
## 5020  64C 1.43        64   Esrrb    10.2600
## 5021  64C 1.44        64   Esrrb     8.2200
## 5022  64C 1.45        64   Esrrb     9.6850
## 5023  64C 1.46        64   Esrrb    11.7400
## 5024  64C 1.47        64   Esrrb    12.6600
## 5025  64C 1.48        64   Esrrb    14.2350
## 5026   64C 2.1        64   Esrrb    12.9600
## 5027   64C 2.2        64   Esrrb    14.3950
## 5028   64C 2.3        64   Esrrb    13.2600
## 5029   64C 2.4        64   Esrrb    12.7300
## 5030   64C 2.5        64   Esrrb    12.4350
## 5031   64C 2.6        64   Esrrb    11.5450
## 5032   64C 2.7        64   Esrrb    10.8650
## 5033   64C 2.8        64   Esrrb    10.9800
## 5034   64C 2.9        64   Esrrb    14.1900
## 5035  64C 2.10        64   Esrrb    13.0850
## 5036  64C 2.11        64   Esrrb    13.9450
## 5037  64C 2.12        64   Esrrb    13.1700
## 5038  64C 2.13        64   Esrrb    12.1000
## 5039  64C 2.14        64   Esrrb     7.3950
## 5040  64C 2.15        64   Esrrb     8.3950
## 5041  64C 2.16        64   Esrrb    11.5650
## 5042  64C 2.17        64   Esrrb    11.3750
## 5043  64C 2.18        64   Esrrb    13.6700
## 5044  64C 2.19        64   Esrrb     9.7150
## 5045  64C 2.20        64   Esrrb    15.2400
## 5046  64C 2.21        64   Esrrb    11.7400
## 5047  64C 2.22        64   Esrrb    12.2750
## 5048  64C 2.23        64   Esrrb    10.6750
## 5049  64C 2.24        64   Esrrb    11.5250
## 5050  64C 2.25        64   Esrrb    12.4650
## 5051   64C 3.1        64   Esrrb    13.3750
## 5052   64C 3.2        64   Esrrb     8.7600
## 5053   64C 3.3        64   Esrrb    13.1050
## 5054   64C 3.4        64   Esrrb    13.8700
## 5055   64C 3.5        64   Esrrb     7.0500
## 5056   64C 3.6        64   Esrrb     8.2350
## 5057   64C 3.7        64   Esrrb    10.4450
## 5058   64C 3.8        64   Esrrb    11.9650
## 5059   64C 4.1        64   Esrrb    10.7850
## 5060  64C 4.1b        64   Esrrb     6.9500
## 5061   64C 4.2        64   Esrrb     7.2150
## 5062   64C 4.3        64   Esrrb    13.4025
## 5063   64C 4.4        64   Esrrb    12.2800
## 5064   64C 4.5        64   Esrrb     9.7400
## 5065   64C 4.6        64   Esrrb     8.3000
## 5066   64C 4.7        64   Esrrb    10.3100
## 5067   64C 4.8        64   Esrrb    11.8050
## 5068   64C 4.9        64   Esrrb    11.2000
## 5069  64C 4.10        64   Esrrb     8.4500
## 5070  64C 4.11        64   Esrrb     6.6850
## 5071  64C 4.12        64   Esrrb    12.0825
## 5072  64C 4.13        64   Esrrb    14.2450
## 5073  64C 4.14        64   Esrrb    13.9850
## 5074  64C 4.15        64   Esrrb    12.0950
## 5075  64C 4.16        64   Esrrb     9.4650
## 5076  64C 4.17        64   Esrrb    11.1450
## 5077  64C 4.18        64   Esrrb     9.7950
## 5078  64C 4.19        64   Esrrb    12.9200
## 5079  64C 4.20        64   Esrrb    13.7500
## 5080  64C 4.21        64   Esrrb    11.4600
## 5081  64C 4.22        64   Esrrb    13.8850
## 5082  64C 4.23        64   Esrrb    13.1300
## 5083  64C 4.24        64   Esrrb    11.7650
## 5084  64C 4.25        64   Esrrb    11.2100
## 5085  64C 4.26        64   Esrrb     6.4250
## 5086  64C 4.27        64   Esrrb    10.9100
## 5087  64C 4.28        64   Esrrb     6.2600
## 5088  64C 4.29        64   Esrrb    13.5550
## 5089  64C 4.30        64   Esrrb    12.1600
## 5090  64C 4.31        64   Esrrb    13.3950
## 5091  64C 4.32        64   Esrrb     7.7600
## 5092  64C 4.33        64   Esrrb    11.8600
## 5093  64C 4.34        64   Esrrb    11.6300
## 5094  64C 4.35        64   Esrrb     7.6650
## 5095  64C 4.36        64   Esrrb    11.1400
## 5096  64C 4.37        64   Esrrb    14.7500
## 5097  64C 4.38        64   Esrrb    10.3200
## 5098  64C 4.39        64   Esrrb    12.2850
## 5099   64C 5.1        64   Esrrb    14.0100
## 5100   64C 5.2        64   Esrrb    13.3200
## 5101   64C 5.3        64   Esrrb     8.7950
## 5102   64C 5.4        64   Esrrb    11.2900
## 5103   64C 5.5        64   Esrrb    11.8950
## 5104   64C 5.6        64   Esrrb     8.2000
## 5105   64C 5.7        64   Esrrb     9.4250
## 5106   64C 5.8        64   Esrrb     6.2400
## 5107   64C 5.9        64   Esrrb    13.3850
## 5108  64C 5.10        64   Esrrb    14.8100
## 5109  64C 5.11        64   Esrrb    14.4450
## 5110  64C 5.12        64   Esrrb    12.3950
## 5111  64C 5.13        64   Esrrb    12.1750
## 5112  64C 5.14        64   Esrrb    12.4150
## 5113  64C 5.15        64   Esrrb    11.6200
## 5114  64C 5.16        64   Esrrb    13.4600
## 5115   64C 6.1        64   Esrrb     8.5850
## 5116   64C 6.2        64   Esrrb     6.2250
## 5117   64C 6.3        64   Esrrb     9.0900
## 5118   64C 6.4        64   Esrrb     8.0150
## 5119   64C 6.5        64   Esrrb     3.9450
## 5120   64C 6.6        64   Esrrb     4.7600
## 5121   64C 6.7        64   Esrrb     6.6700
## 5122   64C 6.8        64   Esrrb     8.8000
## 5123   64C 7.1        64   Esrrb    14.3100
## 5124   64C 7.2        64   Esrrb    13.5650
## 5125   64C 7.3        64   Esrrb     8.2800
## 5126   64C 7.4        64   Esrrb    13.9200
## 5127   64C 7.5        64   Esrrb    14.7300
## 5128   64C 7.6        64   Esrrb    12.0900
## 5129   64C 7.7        64   Esrrb     3.6450
## 5130   64C 7.8        64   Esrrb     7.3000
## 5131   64C 7.9        64   Esrrb    12.6600
## 5132  64C 7.10        64   Esrrb    14.2350
## 5133  64C 7.11        64   Esrrb    12.9600
## 5134  64C 7.12        64   Esrrb    14.3950
## 5135  64C 7.13        64   Esrrb    13.2600
## 5136  64C 7.14        64   Esrrb    12.7300
## 5137    2C 1.1         2    Fgf4     2.3550
## 5138    2C 1.2         2    Fgf4     0.4950
## 5139    2C 2.1         2    Fgf4    11.2100
## 5140    2C 2.2         2    Fgf4     5.7750
## 5141    2C 3.1         2    Fgf4     4.0750
## 5142    2C 3.2         2    Fgf4     4.8575
## 5143    2C 4.1         2    Fgf4     6.7600
## 5144    2C 5.1         2    Fgf4     2.9750
## 5145    2C 5.2         2    Fgf4     3.2500
## 5146    2C 6.1         2    Fgf4     1.2600
## 5147    2C 6.2         2    Fgf4     1.2250
## 5148    2C 7.1         2    Fgf4     1.2100
## 5149    2C 7.2         2    Fgf4     2.7650
## 5150    2C 8.1         2    Fgf4     3.0500
## 5151    2C 8.2         2    Fgf4     2.2225
## 5152    2C 9.1         2    Fgf4     4.8350
## 5153    2C 9.2         2    Fgf4     1.5250
## 5154   2C 10.1         2    Fgf4     2.9350
## 5155   2C 10.2         2    Fgf4     1.1750
## 5156    4C 1.1         4    Fgf4     3.1200
## 5157    4C 1.2         4    Fgf4     3.6250
## 5158    4C 1.3         4    Fgf4     4.1550
## 5159    4C 1.4         4    Fgf4     4.3850
## 5160    4C 2.1         4    Fgf4     4.0450
## 5161    4C 2.2         4    Fgf4     4.6650
## 5162    4C 2.3         4    Fgf4     4.9300
## 5163    4C 3.1         4    Fgf4     1.6150
## 5164    4C 3.2         4    Fgf4     1.6800
## 5165    4C 3.3         4    Fgf4     2.0550
## 5166    4C 3.4         4    Fgf4     3.0650
## 5167    4C 4.1         4    Fgf4     3.8400
## 5168    4C 4.2         4    Fgf4     5.0050
## 5169    4C 4.3         4    Fgf4     3.7150
## 5170    4C 4.4         4    Fgf4     5.6850
## 5171    4C 5.1         4    Fgf4     3.9750
## 5172    4C 5.2         4    Fgf4     4.2700
## 5173    4C 5.3         4    Fgf4     2.3750
## 5174    4C 5.4         4    Fgf4     2.9850
## 5175    4C 6.1         4    Fgf4     0.8150
## 5176    4C 6.2         4    Fgf4     2.5500
## 5177    4C 6.3         4    Fgf4     5.0350
## 5178    4C 6.4         4    Fgf4     4.7600
## 5179    8C 1.1         8    Fgf4     9.4400
## 5180    8C 1.2         8    Fgf4     8.3150
## 5181    8C 1.3         8    Fgf4     9.5050
## 5182    8C 1.4         8    Fgf4     5.3500
## 5183    8C 1.5         8    Fgf4     6.0600
## 5184    8C 2.1         8    Fgf4     5.4250
## 5185    8C 2.2         8    Fgf4    11.9000
## 5186    8C 2.3         8    Fgf4    12.1250
## 5187    8C 2.4         8    Fgf4     8.2750
## 5188    8C 2.5         8    Fgf4     9.2150
## 5189    8C 2.6         8    Fgf4    10.4350
## 5190    8C 2.7         8    Fgf4     7.2050
## 5191    8C 2.8         8    Fgf4     6.2500
## 5192    8C 3.1         8    Fgf4     5.3500
## 5193    8C 3.2         8    Fgf4     6.9050
## 5194    8C 3.3         8    Fgf4     5.6350
## 5195    8C 3.4         8    Fgf4     6.8950
## 5196    8C 3.5         8    Fgf4     5.6950
## 5197    8C 3.6         8    Fgf4     5.1650
## 5198    8C 3.7         8    Fgf4     7.6700
## 5199    8C 3.8         8    Fgf4     5.8800
## 5200    8C 4.2         8    Fgf4     6.9550
## 5201    8C 4.3         8    Fgf4     4.7850
## 5202    8C 4.4         8    Fgf4     6.4500
## 5203    8C 4.5         8    Fgf4    12.1500
## 5204    8C 4.6         8    Fgf4     5.3250
## 5205    8C 4.7         8    Fgf4     3.5300
## 5206    8C 5.1         8    Fgf4     7.9500
## 5207    8C 5.2         8    Fgf4     6.3650
## 5208    8C 5.3         8    Fgf4     4.7300
## 5209    8C 5.4         8    Fgf4     4.9500
## 5210    8C 5.5         8    Fgf4     7.1550
## 5211    8C 5.6         8    Fgf4     7.7900
## 5212    8C 5.7         8    Fgf4     5.5200
## 5213    8C 5.8         8    Fgf4     8.8100
## 5214    8C 6.1         8    Fgf4     7.9100
## 5215    8C 6.2         8    Fgf4     5.4900
## 5216    8C 6.3         8    Fgf4     7.4700
## 5217    8C 6.4         8    Fgf4     3.6850
## 5218    8C 6.5         8    Fgf4     6.0850
## 5219    8C 6.6         8    Fgf4     8.7300
## 5220    8C 6.7         8    Fgf4     5.4500
## 5221    8C 6.8         8    Fgf4     7.8700
## 5222   16C 1.1        16    Fgf4    14.3550
## 5223   16C 1.2        16    Fgf4     8.2050
## 5224   16C 1.3        16    Fgf4     9.2950
## 5225   16C 1.4        16    Fgf4    14.1850
## 5226   16C 1.5        16    Fgf4     6.3800
## 5227   16C 1.6        16    Fgf4     7.9450
## 5228   16C 1.7        16    Fgf4     6.8150
## 5229   16C 1.8        16    Fgf4     6.5500
## 5230   16C 1.9        16    Fgf4    12.5900
## 5231  16C 1.10        16    Fgf4     5.7050
## 5232  16C 1.11        16    Fgf4     9.5050
## 5233  16C 1.12        16    Fgf4     9.4150
## 5234  16C 1.13        16    Fgf4    10.2050
## 5235  16C 1.14        16    Fgf4     6.1100
## 5236  16C 1.15        16    Fgf4     5.0050
## 5237  16C 1.16        16    Fgf4     8.4900
## 5238   16C 2.1        16    Fgf4    12.0050
## 5239   16C 2.2        16    Fgf4    12.3550
## 5240   16C 2.3        16    Fgf4    12.1400
## 5241   16C 2.4        16    Fgf4    10.5200
## 5242   16C 2.5        16    Fgf4     7.1900
## 5243   16C 2.6        16    Fgf4     7.3500
## 5244   16C 2.7        16    Fgf4     7.7350
## 5245   16C 2.8        16    Fgf4     5.6850
## 5246   16C 2.9        16    Fgf4     6.5100
## 5247  16C 2.10        16    Fgf4     7.2750
## 5248  16C 2.11        16    Fgf4    10.7250
## 5249  16C 2.12        16    Fgf4    10.7175
## 5250  16C 2.13        16    Fgf4    13.8200
## 5251  16C 2.14        16    Fgf4     7.3650
## 5252  16C 2.15        16    Fgf4     6.9600
## 5253  16C 2.16        16    Fgf4     6.5400
## 5254   16C 3.1        16    Fgf4     8.0150
## 5255   16C 3.2        16    Fgf4     9.2600
## 5256   16C 3.3        16    Fgf4     9.0750
## 5257   16C 3.4        16    Fgf4    13.3300
## 5258   16C 3.5        16    Fgf4    11.4225
## 5259   16C 3.6        16    Fgf4    14.6150
## 5260   16C 3.7        16    Fgf4    11.9350
## 5261   16C 3.8        16    Fgf4    12.4550
## 5262   16C 3.9        16    Fgf4     7.9850
## 5263  16C 3.10        16    Fgf4     8.3000
## 5264  16C 3.11        16    Fgf4     6.9050
## 5265  16C 3.12        16    Fgf4     8.0350
## 5266  16C 3.13        16    Fgf4    12.0150
## 5267  16C 3.14        16    Fgf4    13.4050
## 5268  16C 3.15        16    Fgf4     9.6050
## 5269   16C 4.1        16    Fgf4    11.1000
## 5270   16C 4.2        16    Fgf4     5.6750
## 5271   16C 4.3        16    Fgf4     6.0700
## 5272   16C 4.4        16    Fgf4     7.1050
## 5273   16C 4.5        16    Fgf4     5.5850
## 5274   16C 4.6        16    Fgf4     6.9600
## 5275   16C 4.7        16    Fgf4    13.7550
## 5276   16C 4.8        16    Fgf4     9.0450
## 5277   16C 4.9        16    Fgf4    13.4150
## 5278  16C 4.10        16    Fgf4     9.0250
## 5279  16C 4.11        16    Fgf4     8.4100
## 5280  16C 4.12        16    Fgf4     9.8150
## 5281  16C 4.13        16    Fgf4     5.5050
## 5282  16C 4.14        16    Fgf4     6.0350
## 5283  16C 4.15        16    Fgf4     7.8500
## 5284  16C 4.16        16    Fgf4     8.7950
## 5285   16C 5.1        16    Fgf4    10.5200
## 5286   16C 5.2        16    Fgf4    10.2200
## 5287   16C 5.3        16    Fgf4    10.2150
## 5288   16C 5.4        16    Fgf4     9.5750
## 5289   16C 5.5        16    Fgf4     4.2800
## 5290   16C 5.6        16    Fgf4     7.7100
## 5291   16C 5.7        16    Fgf4     4.8150
## 5292   16C 5.8        16    Fgf4     9.8000
## 5293   16C 5.9        16    Fgf4     8.0350
## 5294  16C 5.10        16    Fgf4     7.8050
## 5295  16C 5.11        16    Fgf4     8.8650
## 5296  16C 5.12        16    Fgf4     9.2250
## 5297   32C 1.1        32    Fgf4    11.0150
## 5298   32C 1.2        32    Fgf4     4.2900
## 5299   32C 1.3        32    Fgf4    11.5100
## 5300   32C 1.4        32    Fgf4    11.7950
## 5301   32C 1.5        32    Fgf4     5.5050
## 5302   32C 1.6        32    Fgf4    14.8450
## 5303   32C 1.7        32    Fgf4    12.3950
## 5304   32C 1.8        32    Fgf4     8.0450
## 5305   32C 1.9        32    Fgf4     4.8500
## 5306  32C 1.10        32    Fgf4    11.8800
## 5307  32C 1.11        32    Fgf4    11.4450
## 5308  32C 1.12        32    Fgf4    12.2150
## 5309  32C 1.13        32    Fgf4    11.0900
## 5310  32C 1.14        32    Fgf4    14.4500
## 5311  32C 1.15        32    Fgf4     7.7450
## 5312  32C 1.16        32    Fgf4     6.6300
## 5313  32C 1.17        32    Fgf4    14.3600
## 5314  32C 1.18        32    Fgf4     3.9050
## 5315  32C 1.19        32    Fgf4    13.0500
## 5316  32C 1.20        32    Fgf4    11.7000
## 5317  32C 1.21        32    Fgf4    12.4950
## 5318   32C 2.1        32    Fgf4    11.4500
## 5319   32C 2.2        32    Fgf4    13.7800
## 5320   32C 2.3        32    Fgf4    10.9400
## 5321   32C 2.4        32    Fgf4     5.6500
## 5322   32C 2.5        32    Fgf4     9.2900
## 5323   32C 2.6        32    Fgf4    13.1200
## 5324   32C 2.7        32    Fgf4     7.1650
## 5325   32C 2.8        32    Fgf4     8.3950
## 5326   32C 2.9        32    Fgf4     9.1500
## 5327  32C 2.10        32    Fgf4    11.5700
## 5328  32C 2.11        32    Fgf4     9.7600
## 5329  32C 2.12        32    Fgf4    14.3550
## 5330  32C 2.13        32    Fgf4     7.5450
## 5331  32C 2.14        32    Fgf4     4.2550
## 5332  32C 2.15        32    Fgf4     4.1450
## 5333  32C 2.16        32    Fgf4     5.5600
## 5334   32C 3.1        32    Fgf4    11.6050
## 5335   32C 3.2        32    Fgf4    11.8350
## 5336   32C 3.3        32    Fgf4    11.5300
## 5337   32C 3.4        32    Fgf4    14.4500
## 5338   32C 3.5        32    Fgf4    13.2950
## 5339   32C 3.6        32    Fgf4     5.9150
## 5340   32C 3.7        32    Fgf4     4.7950
## 5341   32C 3.8        32    Fgf4     6.8450
## 5342   32C 4.1        32    Fgf4    11.6400
## 5343   32C 4.2        32    Fgf4     8.0150
## 5344   32C 4.3        32    Fgf4     8.9200
## 5345   32C 4.4        32    Fgf4    12.0050
## 5346   32C 4.5        32    Fgf4    14.8450
## 5347   32C 4.6        32    Fgf4     8.2900
## 5348   32C 4.7        32    Fgf4    14.3000
## 5349   32C 4.8        32    Fgf4    13.4700
## 5350  32C 4.10        32    Fgf4    13.1300
## 5351  32C 4.11        32    Fgf4     4.3550
## 5352  32C 4.12        32    Fgf4    10.9550
## 5353  32C 4.13        32    Fgf4    11.2100
## 5354  32C 4.14        32    Fgf4     9.3250
## 5355  32C 4.15        32    Fgf4     9.6250
## 5356  32C 4.16        32    Fgf4    15.2575
## 5357  32C 4.17        32    Fgf4    13.8800
## 5358  32C 4.18        32    Fgf4    10.4650
## 5359  32C 4.19        32    Fgf4    12.6400
## 5360  32C 4.20        32    Fgf4     7.4600
## 5361  32C 4.21        32    Fgf4     7.5550
## 5362  32C 4.22        32    Fgf4     4.1400
## 5363  32C 4.23        32    Fgf4    13.5850
## 5364  32C 4.24        32    Fgf4    10.8600
## 5365   32C 5.1        32    Fgf4    12.5725
## 5366   32C 5.2        32    Fgf4    14.6150
## 5367   32C 5.3        32    Fgf4    11.9350
## 5368   32C 5.4        32    Fgf4     7.0250
## 5369   32C 5.5        32    Fgf4     5.8650
## 5370   32C 5.6        32    Fgf4    11.9300
## 5371   32C 5.7        32    Fgf4    11.3350
## 5372   32C 5.8        32    Fgf4     5.7350
## 5373   32C 5.9        32    Fgf4    14.3750
## 5374  32C 5.10        32    Fgf4    13.4050
## 5375  32C 5.11        32    Fgf4    13.3050
## 5376  32C 5.12        32    Fgf4     2.8100
## 5377  32C 5.13        32    Fgf4    10.8150
## 5378  32C 5.14        32    Fgf4    10.5100
## 5379  32C 5.15        32    Fgf4     5.8350
## 5380  32C 5.16        32    Fgf4    10.1350
## 5381  32C 5.17        32    Fgf4    12.9000
## 5382  32C 5.18        32    Fgf4    13.7550
## 5383  32C 5.19        32    Fgf4     5.7050
## 5384  32C 5.20        32    Fgf4    13.4150
## 5385  32C 5.21        32    Fgf4    11.8150
## 5386  32C 5.22        32    Fgf4    12.0500
## 5387  32C 5.23        32    Fgf4     9.8150
## 5388   32C 6.1        32    Fgf4     4.9050
## 5389   32C 6.2        32    Fgf4     6.5250
## 5390   32C 6.3        32    Fgf4    12.4600
## 5391   32C 6.4        32    Fgf4     9.3200
## 5392   32C 6.6        32    Fgf4    12.9000
## 5393   32C 6.7        32    Fgf4    14.5200
## 5394   32C 7.1        32    Fgf4    13.5050
## 5395   32C 7.2        32    Fgf4     7.7200
## 5396   32C 7.3        32    Fgf4     9.5100
## 5397   32C 7.4        32    Fgf4    11.1900
## 5398   32C 7.5        32    Fgf4     6.7850
## 5399   32C 7.6        32    Fgf4    13.2450
## 5400   32C 7.8        32    Fgf4    13.2950
## 5401   32C 8.1        32    Fgf4    12.5450
## 5402   32C 8.2        32    Fgf4    13.6850
## 5403   32C 8.4        32    Fgf4    14.1950
## 5404   32C 8.5        32    Fgf4     3.8400
## 5405   32C 8.6        32    Fgf4    10.9900
## 5406   64C 1.1        64    Fgf4    11.5100
## 5407   64C 1.2        64    Fgf4    11.7950
## 5408   64C 1.3        64    Fgf4     4.8450
## 5409   64C 1.4        64    Fgf4    14.8450
## 5410   64C 1.5        64    Fgf4    12.3950
## 5411   64C 1.6        64    Fgf4     4.5750
## 5412   64C 1.7        64    Fgf4    14.1900
## 5413   64C 1.8        64    Fgf4    11.8800
## 5414   64C 1.9        64    Fgf4    11.4450
## 5415  64C 1.10        64    Fgf4    12.2150
## 5416  64C 1.11        64    Fgf4    11.0900
## 5417  64C 1.12        64    Fgf4    14.4500
## 5418  64C 1.13        64    Fgf4    13.1050
## 5419  64C 1.14        64    Fgf4    12.5900
## 5420  64C 1.15        64    Fgf4    14.3600
## 5421  64C 1.16        64    Fgf4    13.0350
## 5422  64C 1.17        64    Fgf4    13.0500
## 5423  64C 1.18        64    Fgf4    11.7000
## 5424  64C 1.19        64    Fgf4    12.4950
## 5425  64C 1.20        64    Fgf4    11.4500
## 5426  64C 1.21        64    Fgf4    10.6100
## 5427  64C 1.22        64    Fgf4     5.3800
## 5428  64C 1.23        64    Fgf4     5.3100
## 5429  64C 1.24        64    Fgf4    12.5700
## 5430  64C 1.25        64    Fgf4    13.1200
## 5431  64C 1.26        64    Fgf4    11.7850
## 5432  64C 1.27        64    Fgf4    11.4850
## 5433  64C 1.28        64    Fgf4    12.6200
## 5434  64C 1.29        64    Fgf4    11.5700
## 5435  64C 1.30        64    Fgf4    14.0300
## 5436  64C 1.31        64    Fgf4    14.3550
## 5437  64C 1.32        64    Fgf4    13.4350
## 5438  64C 1.33        64    Fgf4    13.9050
## 5439  64C 1.34        64    Fgf4    14.1850
## 5440  64C 1.35        64    Fgf4    11.8100
## 5441  64C 1.36        64    Fgf4    11.6050
## 5442  64C 1.37        64    Fgf4    11.8350
## 5443  64C 1.38        64    Fgf4    11.5300
## 5444  64C 1.39        64    Fgf4    14.4500
## 5445  64C 1.40        64    Fgf4     4.8550
## 5446  64C 1.41        64    Fgf4    13.6050
## 5447  64C 1.42        64    Fgf4    13.5150
## 5448  64C 1.43        64    Fgf4    14.5650
## 5449  64C 1.44        64    Fgf4    11.6400
## 5450  64C 1.45        64    Fgf4     8.0150
## 5451  64C 1.46        64    Fgf4    12.5600
## 5452  64C 1.47        64    Fgf4    12.0050
## 5453  64C 1.48        64    Fgf4    14.8450
## 5454   64C 2.1        64    Fgf4    13.7700
## 5455   64C 2.2        64    Fgf4    14.3000
## 5456   64C 2.3        64    Fgf4    13.4700
## 5457   64C 2.4        64    Fgf4    13.1300
## 5458   64C 2.5        64    Fgf4    12.3250
## 5459   64C 2.6        64    Fgf4    10.9550
## 5460   64C 2.7        64    Fgf4    11.2100
## 5461   64C 2.8        64    Fgf4     7.9550
## 5462   64C 2.9        64    Fgf4    14.3350
## 5463  64C 2.10        64    Fgf4    15.2575
## 5464  64C 2.11        64    Fgf4    13.8800
## 5465  64C 2.12        64    Fgf4    13.1450
## 5466  64C 2.13        64    Fgf4    12.6400
## 5467  64C 2.14        64    Fgf4    11.8000
## 5468  64C 2.15        64    Fgf4    11.4350
## 5469  64C 2.16        64    Fgf4    12.4900
## 5470  64C 2.17        64    Fgf4    13.5850
## 5471  64C 2.18        64    Fgf4    13.3300
## 5472  64C 2.19        64    Fgf4    12.5725
## 5473  64C 2.20        64    Fgf4    14.6150
## 5474  64C 2.21        64    Fgf4    11.9350
## 5475  64C 2.22        64    Fgf4    12.4550
## 5476  64C 2.23        64    Fgf4    10.0050
## 5477  64C 2.24        64    Fgf4    11.9300
## 5478  64C 2.25        64    Fgf4    11.3350
## 5479   64C 3.1        64    Fgf4    12.5650
## 5480   64C 3.2        64    Fgf4    14.3750
## 5481   64C 3.3        64    Fgf4    13.4050
## 5482   64C 3.4        64    Fgf4    13.3050
## 5483   64C 3.5        64    Fgf4    11.1000
## 5484   64C 3.6        64    Fgf4    10.8150
## 5485   64C 3.7        64    Fgf4    10.5100
## 5486   64C 3.8        64    Fgf4    11.3850
## 5487   64C 4.1        64    Fgf4    10.1350
## 5488  64C 4.1b        64    Fgf4     3.2800
## 5489   64C 4.2        64    Fgf4     5.7950
## 5490   64C 4.3        64    Fgf4    12.7250
## 5491   64C 4.4        64    Fgf4    13.4150
## 5492   64C 4.5        64    Fgf4    11.8150
## 5493   64C 4.6        64    Fgf4    12.0500
## 5494   64C 4.7        64    Fgf4     9.8150
## 5495   64C 4.8        64    Fgf4    10.8950
## 5496   64C 4.9        64    Fgf4     9.9050
## 5497  64C 4.10        64    Fgf4    12.4600
## 5498  64C 4.11        64    Fgf4     4.4450
## 5499  64C 4.12        64    Fgf4    12.9000
## 5500  64C 4.13        64    Fgf4    14.5200
## 5501  64C 4.14        64    Fgf4    13.5050
## 5502  64C 4.15        64    Fgf4    12.7050
## 5503  64C 4.16        64    Fgf4     9.5100
## 5504  64C 4.17        64    Fgf4    11.1900
## 5505  64C 4.18        64    Fgf4    10.9850
## 5506  64C 4.19        64    Fgf4    13.7700
## 5507  64C 4.20        64    Fgf4    13.2950
## 5508  64C 4.21        64    Fgf4    12.5450
## 5509  64C 4.22        64    Fgf4    13.6850
## 5510  64C 4.23        64    Fgf4    14.1950
## 5511  64C 4.24        64    Fgf4    11.0150
## 5512  64C 4.25        64    Fgf4    10.9900
## 5513  64C 4.26        64    Fgf4    11.5100
## 5514  64C 4.27        64    Fgf4    11.7950
## 5515  64C 4.28        64    Fgf4    13.2550
## 5516  64C 4.29        64    Fgf4    14.8450
## 5517  64C 4.30        64    Fgf4    12.3950
## 5518  64C 4.31        64    Fgf4    12.4750
## 5519  64C 4.32        64    Fgf4     5.5900
## 5520  64C 4.33        64    Fgf4    11.8800
## 5521  64C 4.34        64    Fgf4    11.4450
## 5522  64C 4.35        64    Fgf4    12.2150
## 5523  64C 4.36        64    Fgf4    11.0900
## 5524  64C 4.37        64    Fgf4    14.4500
## 5525  64C 4.38        64    Fgf4     5.1650
## 5526  64C 4.39        64    Fgf4    12.5900
## 5527   64C 5.1        64    Fgf4    14.3600
## 5528   64C 5.2        64    Fgf4    13.0350
## 5529   64C 5.3        64    Fgf4    13.0500
## 5530   64C 5.4        64    Fgf4    11.7000
## 5531   64C 5.5        64    Fgf4    12.4950
## 5532   64C 5.6        64    Fgf4    11.4500
## 5533   64C 5.7        64    Fgf4    13.7800
## 5534   64C 5.8        64    Fgf4     6.1100
## 5535   64C 5.9        64    Fgf4    13.9500
## 5536  64C 5.10        64    Fgf4    12.5700
## 5537  64C 5.11        64    Fgf4    13.1200
## 5538  64C 5.12        64    Fgf4    11.7850
## 5539  64C 5.13        64    Fgf4    11.4850
## 5540  64C 5.14        64    Fgf4    12.6200
## 5541  64C 5.15        64    Fgf4    11.5700
## 5542  64C 5.16        64    Fgf4    14.0300
## 5543   64C 6.1        64    Fgf4    14.3550
## 5544   64C 6.2        64    Fgf4     5.0950
## 5545   64C 6.3        64    Fgf4     3.6850
## 5546   64C 6.4        64    Fgf4     4.2450
## 5547   64C 6.5        64    Fgf4     2.6800
## 5548   64C 6.6        64    Fgf4     2.0150
## 5549   64C 6.7        64    Fgf4    11.8350
## 5550   64C 6.8        64    Fgf4     2.2500
## 5551   64C 7.1        64    Fgf4    14.4500
## 5552   64C 7.2        64    Fgf4    13.2950
## 5553   64C 7.3        64    Fgf4     5.2850
## 5554   64C 7.4        64    Fgf4    13.5150
## 5555   64C 7.5        64    Fgf4    14.5650
## 5556   64C 7.6        64    Fgf4    11.6400
## 5557   64C 7.7        64    Fgf4     8.0150
## 5558   64C 7.8        64    Fgf4     4.8100
## 5559   64C 7.9        64    Fgf4    12.0050
## 5560  64C 7.10        64    Fgf4    14.8450
## 5561  64C 7.11        64    Fgf4    13.7700
## 5562  64C 7.12        64    Fgf4    14.3000
## 5563  64C 7.13        64    Fgf4    13.4700
## 5564  64C 7.14        64    Fgf4    13.1300
## 5565    2C 1.1         2   Fgfr2     4.5400
## 5566    2C 1.2         2   Fgfr2     4.3550
## 5567    2C 2.1         2   Fgfr2     6.2100
## 5568    2C 2.2         2   Fgfr2     6.4400
## 5569    2C 3.1         2   Fgfr2     8.4800
## 5570    2C 3.2         2   Fgfr2     7.6950
## 5571    2C 4.1         2   Fgfr2     9.1100
## 5572    2C 5.1         2   Fgfr2     7.7300
## 5573    2C 5.2         2   Fgfr2     5.5700
## 5574    2C 6.1         2   Fgfr2     4.7150
## 5575    2C 6.2         2   Fgfr2     2.9850
## 5576    2C 7.1         2   Fgfr2     7.0100
## 5577    2C 7.2         2   Fgfr2     5.5500
## 5578    2C 8.1         2   Fgfr2     7.4150
## 5579    2C 8.2         2   Fgfr2     9.3125
## 5580    2C 9.1         2   Fgfr2     8.1100
## 5581    2C 9.2         2   Fgfr2     6.5200
## 5582   2C 10.1         2   Fgfr2     7.6450
## 5583   2C 10.2         2   Fgfr2     4.1550
## 5584    4C 1.1         4   Fgfr2     5.8150
## 5585    4C 1.2         4   Fgfr2     7.8700
## 5586    4C 1.3         4   Fgfr2     9.6900
## 5587    4C 1.4         4   Fgfr2    10.1450
## 5588    4C 2.1         4   Fgfr2     7.1500
## 5589    4C 2.2         4   Fgfr2     6.6200
## 5590    4C 2.3         4   Fgfr2     6.1950
## 5591    4C 3.1         4   Fgfr2     1.0550
## 5592    4C 3.2         4   Fgfr2     2.6050
## 5593    4C 3.3         4   Fgfr2     6.0550
## 5594    4C 3.4         4   Fgfr2     4.4300
## 5595    4C 4.1         4   Fgfr2     5.6400
## 5596    4C 4.2         4   Fgfr2     5.7900
## 5597    4C 4.3         4   Fgfr2     5.3700
## 5598    4C 4.4         4   Fgfr2     5.2100
## 5599    4C 5.1         4   Fgfr2     4.5950
## 5600    4C 5.2         4   Fgfr2     4.9800
## 5601    4C 5.3         4   Fgfr2     1.0950
## 5602    4C 5.4         4   Fgfr2     7.5950
## 5603    4C 6.1         4   Fgfr2     0.7500
## 5604    4C 6.2         4   Fgfr2     7.7450
## 5605    4C 6.3         4   Fgfr2     7.7600
## 5606    4C 6.4         4   Fgfr2     6.6600
## 5607    8C 1.1         8   Fgfr2    10.1800
## 5608    8C 1.2         8   Fgfr2     9.2250
## 5609    8C 1.3         8   Fgfr2     4.1400
## 5610    8C 1.4         8   Fgfr2     2.6300
## 5611    8C 1.5         8   Fgfr2     4.4550
## 5612    8C 2.1         8   Fgfr2     3.5050
## 5613    8C 2.2         8   Fgfr2     6.4600
## 5614    8C 2.3         8   Fgfr2     8.8650
## 5615    8C 2.4         8   Fgfr2    12.7800
## 5616    8C 2.5         8   Fgfr2     6.2150
## 5617    8C 2.6         8   Fgfr2     6.8000
## 5618    8C 2.7         8   Fgfr2     5.4450
## 5619    8C 2.8         8   Fgfr2     4.7750
## 5620    8C 3.1         8   Fgfr2     2.1050
## 5621    8C 3.2         8   Fgfr2     6.2250
## 5622    8C 3.3         8   Fgfr2     9.4650
## 5623    8C 3.4         8   Fgfr2     7.5850
## 5624    8C 3.5         8   Fgfr2     5.3150
## 5625    8C 3.6         8   Fgfr2     6.3900
## 5626    8C 3.7         8   Fgfr2     4.9550
## 5627    8C 3.8         8   Fgfr2     4.0750
## 5628    8C 4.2         8   Fgfr2     8.4550
## 5629    8C 4.3         8   Fgfr2     5.3800
## 5630    8C 4.4         8   Fgfr2     6.6850
## 5631    8C 4.5         8   Fgfr2     9.5600
## 5632    8C 4.6         8   Fgfr2     7.3900
## 5633    8C 4.7         8   Fgfr2     5.1800
## 5634    8C 5.1         8   Fgfr2     5.4800
## 5635    8C 5.2         8   Fgfr2     6.6800
## 5636    8C 5.3         8   Fgfr2     6.4950
## 5637    8C 5.4         8   Fgfr2     4.8450
## 5638    8C 5.5         8   Fgfr2     6.5550
## 5639    8C 5.6         8   Fgfr2     4.2250
## 5640    8C 5.7         8   Fgfr2     6.7500
## 5641    8C 5.8         8   Fgfr2     7.0050
## 5642    8C 6.1         8   Fgfr2     6.2150
## 5643    8C 6.2         8   Fgfr2     3.3800
## 5644    8C 6.3         8   Fgfr2     6.2100
## 5645    8C 6.4         8   Fgfr2     3.8350
## 5646    8C 6.5         8   Fgfr2     7.0550
## 5647    8C 6.6         8   Fgfr2     6.9900
## 5648    8C 6.7         8   Fgfr2     4.9300
## 5649    8C 6.8         8   Fgfr2     5.4750
## 5650   16C 1.1        16   Fgfr2     7.7350
## 5651   16C 1.2        16   Fgfr2     5.8150
## 5652   16C 1.3        16   Fgfr2     6.6400
## 5653   16C 1.4        16   Fgfr2     6.8850
## 5654   16C 1.5        16   Fgfr2     5.1350
## 5655   16C 1.6        16   Fgfr2     4.9100
## 5656   16C 1.7        16   Fgfr2     3.3500
## 5657   16C 1.8        16   Fgfr2     3.3850
## 5658   16C 1.9        16   Fgfr2     7.8350
## 5659  16C 1.10        16   Fgfr2     6.7500
## 5660  16C 1.11        16   Fgfr2     5.0500
## 5661  16C 1.12        16   Fgfr2     6.1100
## 5662  16C 1.13        16   Fgfr2     5.8300
## 5663  16C 1.14        16   Fgfr2     3.8650
## 5664  16C 1.15        16   Fgfr2     2.7650
## 5665  16C 1.16        16   Fgfr2     4.0950
## 5666   16C 2.1        16   Fgfr2     3.0750
## 5667   16C 2.2        16   Fgfr2     6.9150
## 5668   16C 2.3        16   Fgfr2     8.7150
## 5669   16C 2.4        16   Fgfr2     7.5700
## 5670   16C 2.5        16   Fgfr2     5.6850
## 5671   16C 2.6        16   Fgfr2     4.1200
## 5672   16C 2.7        16   Fgfr2     7.0200
## 5673   16C 2.8        16   Fgfr2     4.2850
## 5674   16C 2.9        16   Fgfr2     4.3600
## 5675  16C 2.10        16   Fgfr2     4.5900
## 5676  16C 2.11        16   Fgfr2     6.5900
## 5677  16C 2.12        16   Fgfr2     7.1850
## 5678  16C 2.13        16   Fgfr2     6.4600
## 5679  16C 2.14        16   Fgfr2     6.0800
## 5680  16C 2.15        16   Fgfr2     5.5700
## 5681  16C 2.16        16   Fgfr2     5.6050
## 5682   16C 3.1        16   Fgfr2     2.3750
## 5683   16C 3.2        16   Fgfr2     5.6700
## 5684   16C 3.3        16   Fgfr2     5.7200
## 5685   16C 3.4        16   Fgfr2     5.2850
## 5686   16C 3.5        16   Fgfr2     6.1825
## 5687   16C 3.6        16   Fgfr2     6.6700
## 5688   16C 3.7        16   Fgfr2     5.3500
## 5689   16C 3.8        16   Fgfr2     6.5450
## 5690   16C 3.9        16   Fgfr2     4.5650
## 5691  16C 3.10        16   Fgfr2     4.3350
## 5692  16C 3.11        16   Fgfr2     3.6000
## 5693  16C 3.12        16   Fgfr2     7.4100
## 5694  16C 3.13        16   Fgfr2     6.7550
## 5695  16C 3.14        16   Fgfr2     5.8100
## 5696  16C 3.15        16   Fgfr2     5.6100
## 5697   16C 4.1        16   Fgfr2     6.4050
## 5698   16C 4.2        16   Fgfr2     1.2250
## 5699   16C 4.3        16   Fgfr2     2.1750
## 5700   16C 4.4        16   Fgfr2     4.2350
## 5701   16C 4.5        16   Fgfr2     3.1400
## 5702   16C 4.6        16   Fgfr2     6.4700
## 5703   16C 4.7        16   Fgfr2     6.0300
## 5704   16C 4.8        16   Fgfr2     4.8600
## 5705   16C 4.9        16   Fgfr2     6.6900
## 5706  16C 4.10        16   Fgfr2     4.9750
## 5707  16C 4.11        16   Fgfr2     4.0700
## 5708  16C 4.12        16   Fgfr2     1.3750
## 5709  16C 4.13        16   Fgfr2     3.9750
## 5710  16C 4.14        16   Fgfr2     1.7300
## 5711  16C 4.15        16   Fgfr2     6.5850
## 5712  16C 4.16        16   Fgfr2     6.1500
## 5713   16C 5.1        16   Fgfr2     5.2200
## 5714   16C 5.2        16   Fgfr2     8.1700
## 5715   16C 5.3        16   Fgfr2     4.3250
## 5716   16C 5.4        16   Fgfr2     3.3900
## 5717   16C 5.5        16   Fgfr2     2.0000
## 5718   16C 5.6        16   Fgfr2     5.0550
## 5719   16C 5.7        16   Fgfr2     3.7050
## 5720   16C 5.8        16   Fgfr2     5.7900
## 5721   16C 5.9        16   Fgfr2     6.7850
## 5722  16C 5.10        16   Fgfr2     4.7000
## 5723  16C 5.11        16   Fgfr2     6.1450
## 5724  16C 5.12        16   Fgfr2     5.7400
## 5725   32C 1.1        32   Fgfr2     3.2750
## 5726   32C 1.2        32   Fgfr2     8.4350
## 5727   32C 1.3        32   Fgfr2     2.8850
## 5728   32C 1.4        32   Fgfr2     3.2750
## 5729   32C 1.5        32   Fgfr2    15.2850
## 5730   32C 1.6        32   Fgfr2     8.2050
## 5731   32C 1.7        32   Fgfr2     4.9750
## 5732   32C 1.8        32   Fgfr2     9.3900
## 5733   32C 1.9        32   Fgfr2    13.5150
## 5734  32C 1.10        32   Fgfr2     2.7950
## 5735  32C 1.11        32   Fgfr2     4.6450
## 5736  32C 1.12        32   Fgfr2     3.0500
## 5737  32C 1.13        32   Fgfr2     4.3550
## 5738  32C 1.14        32   Fgfr2     4.0900
## 5739  32C 1.15        32   Fgfr2     7.6600
## 5740  32C 1.16        32   Fgfr2     5.1700
## 5741  32C 1.17        32   Fgfr2     5.6000
## 5742  32C 1.18        32   Fgfr2    11.0300
## 5743  32C 1.19        32   Fgfr2     7.6950
## 5744  32C 1.20        32   Fgfr2     3.5550
## 5745  32C 1.21        32   Fgfr2     8.9250
## 5746   32C 2.1        32   Fgfr2     3.5750
## 5747   32C 2.2        32   Fgfr2     7.4400
## 5748   32C 2.3        32   Fgfr2     4.5950
## 5749   32C 2.4        32   Fgfr2     5.7850
## 5750   32C 2.5        32   Fgfr2     7.8400
## 5751   32C 2.6        32   Fgfr2     8.6500
## 5752   32C 2.7        32   Fgfr2     3.7950
## 5753   32C 2.8        32   Fgfr2     3.6250
## 5754   32C 2.9        32   Fgfr2     5.2800
## 5755  32C 2.10        32   Fgfr2     2.7000
## 5756  32C 2.11        32   Fgfr2     7.2050
## 5757  32C 2.12        32   Fgfr2    13.8250
## 5758  32C 2.13        32   Fgfr2     7.7450
## 5759  32C 2.14        32   Fgfr2    13.1700
## 5760  32C 2.15        32   Fgfr2     7.5250
## 5761  32C 2.16        32   Fgfr2     4.2250
## 5762   32C 3.1        32   Fgfr2     3.2700
## 5763   32C 3.2        32   Fgfr2     4.7100
## 5764   32C 3.3        32   Fgfr2     3.2250
## 5765   32C 3.4        32   Fgfr2     7.7350
## 5766   32C 3.5        32   Fgfr2     7.2500
## 5767   32C 3.6        32   Fgfr2    13.3900
## 5768   32C 3.7        32   Fgfr2    10.6100
## 5769   32C 3.8        32   Fgfr2     7.1600
## 5770   32C 4.1        32   Fgfr2     3.2950
## 5771   32C 4.2        32   Fgfr2     3.0950
## 5772   32C 4.3        32   Fgfr2     7.5750
## 5773   32C 4.4        32   Fgfr2     4.2250
## 5774   32C 4.5        32   Fgfr2     7.9550
## 5775   32C 4.6        32   Fgfr2     9.0750
## 5776   32C 4.7        32   Fgfr2     6.7800
## 5777   32C 4.8        32   Fgfr2     4.3850
## 5778  32C 4.10        32   Fgfr2     4.1200
## 5779  32C 4.11        32   Fgfr2    11.2700
## 5780  32C 4.12        32   Fgfr2     4.2850
## 5781  32C 4.13        32   Fgfr2     4.1100
## 5782  32C 4.14        32   Fgfr2     6.9900
## 5783  32C 4.15        32   Fgfr2     7.6800
## 5784  32C 4.16        32   Fgfr2     5.3750
## 5785  32C 4.17        32   Fgfr2     6.0200
## 5786  32C 4.18        32   Fgfr2     4.6800
## 5787  32C 4.19        32   Fgfr2     3.6700
## 5788  32C 4.20        32   Fgfr2     7.4950
## 5789  32C 4.21        32   Fgfr2     4.5550
## 5790  32C 4.22        32   Fgfr2     9.8300
## 5791  32C 4.23        32   Fgfr2     3.5200
## 5792  32C 4.24        32   Fgfr2    13.1150
## 5793   32C 5.1        32   Fgfr2     5.4825
## 5794   32C 5.2        32   Fgfr2     6.7500
## 5795   32C 5.3        32   Fgfr2     7.1700
## 5796   32C 5.4        32   Fgfr2     4.5850
## 5797   32C 5.5        32   Fgfr2     6.5450
## 5798   32C 5.6        32   Fgfr2     5.0850
## 5799   32C 5.7        32   Fgfr2     2.9400
## 5800   32C 5.8        32   Fgfr2    12.3600
## 5801   32C 5.9        32   Fgfr2     5.6950
## 5802  32C 5.10        32   Fgfr2     7.8700
## 5803  32C 5.11        32   Fgfr2     7.0400
## 5804  32C 5.12        32   Fgfr2    13.5250
## 5805  32C 5.13        32   Fgfr2     0.8450
## 5806  32C 5.14        32   Fgfr2     3.6350
## 5807  32C 5.15        32   Fgfr2     5.4350
## 5808  32C 5.16        32   Fgfr2     3.0600
## 5809  32C 5.17        32   Fgfr2     5.1200
## 5810  32C 5.18        32   Fgfr2     5.7000
## 5811  32C 5.19        32   Fgfr2    12.7400
## 5812  32C 5.20        32   Fgfr2     6.6000
## 5813  32C 5.21        32   Fgfr2     4.9350
## 5814  32C 5.22        32   Fgfr2     4.8200
## 5815  32C 5.23        32   Fgfr2     1.7150
## 5816   32C 6.1        32   Fgfr2     6.7800
## 5817   32C 6.2        32   Fgfr2     0.6100
## 5818   32C 6.3        32   Fgfr2     7.5850
## 5819   32C 6.4        32   Fgfr2     9.6500
## 5820   32C 6.6        32   Fgfr2     5.9900
## 5821   32C 6.7        32   Fgfr2     8.3650
## 5822   32C 7.1        32   Fgfr2     5.2800
## 5823   32C 7.2        32   Fgfr2    11.5100
## 5824   32C 7.3        32   Fgfr2     2.8400
## 5825   32C 7.4        32   Fgfr2     4.7650
## 5826   32C 7.5        32   Fgfr2     7.5750
## 5827   32C 7.6        32   Fgfr2     8.0400
## 5828   32C 7.8        32   Fgfr2     6.8000
## 5829   32C 8.1        32   Fgfr2     6.4300
## 5830   32C 8.2        32   Fgfr2     6.9450
## 5831   32C 8.4        32   Fgfr2     8.7350
## 5832   32C 8.5        32   Fgfr2    11.8250
## 5833   32C 8.6        32   Fgfr2     4.8150
## 5834   64C 1.1        64   Fgfr2     0.7850
## 5835   64C 1.2        64   Fgfr2     3.6950
## 5836   64C 1.3        64   Fgfr2    15.2850
## 5837   64C 1.4        64   Fgfr2     6.4950
## 5838   64C 1.5        64   Fgfr2     3.4850
## 5839   64C 1.6        64   Fgfr2    14.8800
## 5840   64C 1.7        64   Fgfr2     5.8050
## 5841   64C 1.8        64   Fgfr2     4.2250
## 5842   64C 1.9        64   Fgfr2     5.5650
## 5843  64C 1.10        64   Fgfr2     4.8900
## 5844  64C 1.11        64   Fgfr2     4.8450
## 5845  64C 1.12        64   Fgfr2     6.2800
## 5846  64C 1.13        64   Fgfr2     9.6800
## 5847  64C 1.14        64   Fgfr2     3.8600
## 5848  64C 1.15        64   Fgfr2     6.2000
## 5849  64C 1.16        64   Fgfr2     5.4600
## 5850  64C 1.17        64   Fgfr2     6.2150
## 5851  64C 1.18        64   Fgfr2     3.7250
## 5852  64C 1.19        64   Fgfr2     5.0650
## 5853  64C 1.20        64   Fgfr2     3.9250
## 5854  64C 1.21        64   Fgfr2    10.7100
## 5855  64C 1.22        64   Fgfr2     7.4450
## 5856  64C 1.23        64   Fgfr2    13.4350
## 5857  64C 1.24        64   Fgfr2     2.8000
## 5858  64C 1.25        64   Fgfr2     6.6700
## 5859  64C 1.26        64   Fgfr2     4.2750
## 5860  64C 1.27        64   Fgfr2     4.6850
## 5861  64C 1.28        64   Fgfr2     5.2700
## 5862  64C 1.29        64   Fgfr2     3.0700
## 5863  64C 1.30        64   Fgfr2     5.6550
## 5864  64C 1.31        64   Fgfr2     6.2350
## 5865  64C 1.32        64   Fgfr2     6.1850
## 5866  64C 1.33        64   Fgfr2     6.0400
## 5867  64C 1.34        64   Fgfr2    10.5550
## 5868  64C 1.35        64   Fgfr2     2.7350
## 5869  64C 1.36        64   Fgfr2     3.5400
## 5870  64C 1.37        64   Fgfr2     3.9700
## 5871  64C 1.38        64   Fgfr2     3.4750
## 5872  64C 1.39        64   Fgfr2     7.2150
## 5873  64C 1.40        64   Fgfr2    13.2100
## 5874  64C 1.41        64   Fgfr2     5.3100
## 5875  64C 1.42        64   Fgfr2     5.9100
## 5876  64C 1.43        64   Fgfr2     6.5700
## 5877  64C 1.44        64   Fgfr2     4.5750
## 5878  64C 1.45        64   Fgfr2     2.8450
## 5879  64C 1.46        64   Fgfr2     4.7750
## 5880  64C 1.47        64   Fgfr2     2.7650
## 5881  64C 1.48        64   Fgfr2     5.8850
## 5882   64C 2.1        64   Fgfr2     6.0150
## 5883   64C 2.2        64   Fgfr2     5.1600
## 5884   64C 2.3        64   Fgfr2     5.2150
## 5885   64C 2.4        64   Fgfr2     3.8900
## 5886   64C 2.5        64   Fgfr2     4.3700
## 5887   64C 2.6        64   Fgfr2     5.0050
## 5888   64C 2.7        64   Fgfr2     4.6100
## 5889   64C 2.8        64   Fgfr2     6.5200
## 5890   64C 2.9        64   Fgfr2     5.8000
## 5891  64C 2.10        64   Fgfr2     4.5450
## 5892  64C 2.11        64   Fgfr2     6.1400
## 5893  64C 2.12        64   Fgfr2     5.5400
## 5894  64C 2.13        64   Fgfr2     4.4800
## 5895  64C 2.14        64   Fgfr2     2.3650
## 5896  64C 2.15        64   Fgfr2     1.9750
## 5897  64C 2.16        64   Fgfr2     6.4400
## 5898  64C 2.17        64   Fgfr2     6.4000
## 5899  64C 2.18        64   Fgfr2     3.7950
## 5900  64C 2.19        64   Fgfr2     5.3625
## 5901  64C 2.20        64   Fgfr2     7.1800
## 5902  64C 2.21        64   Fgfr2     4.4000
## 5903  64C 2.22        64   Fgfr2     5.8750
## 5904  64C 2.23        64   Fgfr2     3.3350
## 5905  64C 2.24        64   Fgfr2     4.6850
## 5906  64C 2.25        64   Fgfr2     3.3200
## 5907   64C 3.1        64   Fgfr2     4.7100
## 5908   64C 3.2        64   Fgfr2     6.1950
## 5909   64C 3.3        64   Fgfr2     5.2100
## 5910   64C 3.4        64   Fgfr2     4.7800
## 5911   64C 3.5        64   Fgfr2     5.6350
## 5912   64C 3.6        64   Fgfr2     1.4650
## 5913   64C 3.7        64   Fgfr2     2.4850
## 5914   64C 3.8        64   Fgfr2     5.0350
## 5915   64C 4.1        64   Fgfr2     3.4300
## 5916  64C 4.1b        64   Fgfr2    10.3900
## 5917   64C 4.2        64   Fgfr2    13.7200
## 5918   64C 4.3        64   Fgfr2     5.0900
## 5919   64C 4.4        64   Fgfr2     8.0900
## 5920   64C 4.5        64   Fgfr2     8.3150
## 5921   64C 4.6        64   Fgfr2     5.1400
## 5922   64C 4.7        64   Fgfr2     1.0450
## 5923   64C 4.8        64   Fgfr2     4.6150
## 5924   64C 4.9        64   Fgfr2     1.7800
## 5925  64C 4.10        64   Fgfr2    10.0850
## 5926  64C 4.11        64   Fgfr2    13.8200
## 5927  64C 4.12        64   Fgfr2     5.2400
## 5928  64C 4.13        64   Fgfr2     5.9300
## 5929  64C 4.14        64   Fgfr2     5.5950
## 5930  64C 4.15        64   Fgfr2     4.0400
## 5931  64C 4.16        64   Fgfr2    -0.3600
## 5932  64C 4.17        64   Fgfr2     4.2350
## 5933  64C 4.18        64   Fgfr2     2.3150
## 5934  64C 4.19        64   Fgfr2     4.8300
## 5935  64C 4.20        64   Fgfr2     5.7550
## 5936  64C 4.21        64   Fgfr2     4.4400
## 5937  64C 4.22        64   Fgfr2     4.4750
## 5938  64C 4.23        64   Fgfr2     6.6000
## 5939  64C 4.24        64   Fgfr2     4.8550
## 5940  64C 4.25        64   Fgfr2     3.1650
## 5941  64C 4.26        64   Fgfr2     1.7950
## 5942  64C 4.27        64   Fgfr2     3.0450
## 5943  64C 4.28        64   Fgfr2     8.2550
## 5944  64C 4.29        64   Fgfr2     5.1250
## 5945  64C 4.30        64   Fgfr2     3.8150
## 5946  64C 4.31        64   Fgfr2     7.5600
## 5947  64C 4.32        64   Fgfr2    13.5150
## 5948  64C 4.33        64   Fgfr2     3.9850
## 5949  64C 4.34        64   Fgfr2     4.0450
## 5950  64C 4.35        64   Fgfr2     4.4200
## 5951  64C 4.36        64   Fgfr2     3.7250
## 5952  64C 4.37        64   Fgfr2     5.6400
## 5953  64C 4.38        64   Fgfr2     4.8400
## 5954  64C 4.39        64   Fgfr2     4.9800
## 5955   64C 5.1        64   Fgfr2     5.6600
## 5956   64C 5.2        64   Fgfr2     7.0600
## 5957   64C 5.3        64   Fgfr2     6.8650
## 5958   64C 5.4        64   Fgfr2     2.9150
## 5959   64C 5.5        64   Fgfr2     5.4550
## 5960   64C 5.6        64   Fgfr2     3.9750
## 5961   64C 5.7        64   Fgfr2     6.8900
## 5962   64C 5.8        64   Fgfr2    12.6150
## 5963   64C 5.9        64   Fgfr2     6.4950
## 5964  64C 5.10        64   Fgfr2     3.0800
## 5965  64C 5.11        64   Fgfr2     4.5900
## 5966  64C 5.12        64   Fgfr2     2.8650
## 5967  64C 5.13        64   Fgfr2     3.3650
## 5968  64C 5.14        64   Fgfr2     3.2200
## 5969  64C 5.15        64   Fgfr2     5.8000
## 5970  64C 5.16        64   Fgfr2     5.7150
## 5971   64C 6.1        64   Fgfr2     5.3250
## 5972   64C 6.2        64   Fgfr2    12.7650
## 5973   64C 6.3        64   Fgfr2    13.1700
## 5974   64C 6.4        64   Fgfr2    13.7550
## 5975   64C 6.5        64   Fgfr2    11.6550
## 5976   64C 6.6        64   Fgfr2    11.2700
## 5977   64C 6.7        64   Fgfr2     3.4200
## 5978   64C 6.8        64   Fgfr2    11.2450
## 5979   64C 7.1        64   Fgfr2     9.9950
## 5980   64C 7.2        64   Fgfr2     6.9300
## 5981   64C 7.3        64   Fgfr2    13.3900
## 5982   64C 7.4        64   Fgfr2     6.5700
## 5983   64C 7.5        64   Fgfr2     6.0700
## 5984   64C 7.6        64   Fgfr2     3.8850
## 5985   64C 7.7        64   Fgfr2     2.6250
## 5986   64C 7.8        64   Fgfr2    12.1450
## 5987   64C 7.9        64   Fgfr2     2.9450
## 5988  64C 7.10        64   Fgfr2     6.2450
## 5989  64C 7.11        64   Fgfr2     6.0650
## 5990  64C 7.12        64   Fgfr2     5.6700
## 5991  64C 7.13        64   Fgfr2     6.5750
## 5992  64C 7.14        64   Fgfr2     5.0300
## 5993    2C 1.1         2     Fn1     5.6900
## 5994    2C 1.2         2     Fn1     7.2500
## 5995    2C 2.1         2     Fn1     6.5900
## 5996    2C 2.2         2     Fn1     6.8500
## 5997    2C 3.1         2     Fn1     9.8900
## 5998    2C 3.2         2     Fn1     6.9975
## 5999    2C 4.1         2     Fn1     9.0350
## 6000    2C 5.1         2     Fn1     8.3600
## 6001    2C 5.2         2     Fn1     7.3200
## 6002    2C 6.1         2     Fn1     5.2050
## 6003    2C 6.2         2     Fn1     4.7450
## 6004    2C 7.1         2     Fn1     6.3250
## 6005    2C 7.2         2     Fn1     7.1350
## 6006    2C 8.1         2     Fn1     8.3650
## 6007    2C 8.2         2     Fn1     6.6575
## 6008    2C 9.1         2     Fn1     9.3050
## 6009    2C 9.2         2     Fn1     6.7300
## 6010   2C 10.1         2     Fn1     6.4500
## 6011   2C 10.2         2     Fn1     4.5050
## 6012    4C 1.1         4     Fn1     7.9900
## 6013    4C 1.2         4     Fn1     6.4350
## 6014    4C 1.3         4     Fn1     6.0750
## 6015    4C 1.4         4     Fn1    13.5600
## 6016    4C 2.1         4     Fn1     6.5325
## 6017    4C 2.2         4     Fn1     8.6050
## 6018    4C 2.3         4     Fn1     5.1250
## 6019    4C 3.1         4     Fn1     6.6600
## 6020    4C 3.2         4     Fn1     5.8850
## 6021    4C 3.3         4     Fn1     7.7650
## 6022    4C 3.4         4     Fn1     6.3950
## 6023    4C 4.1         4     Fn1     9.9050
## 6024    4C 4.2         4     Fn1     8.2350
## 6025    4C 4.3         4     Fn1    12.5000
## 6026    4C 4.4         4     Fn1    12.1750
## 6027    4C 5.1         4     Fn1     7.5150
## 6028    4C 5.2         4     Fn1     5.7500
## 6029    4C 5.3         4     Fn1     2.7650
## 6030    4C 5.4         4     Fn1     5.3800
## 6031    4C 6.1         4     Fn1     5.1750
## 6032    4C 6.2         4     Fn1    10.0850
## 6033    4C 6.3         4     Fn1    10.3150
## 6034    4C 6.4         4     Fn1     7.6800
## 6035    8C 1.1         8     Fn1    11.2300
## 6036    8C 1.2         8     Fn1     9.9950
## 6037    8C 1.3         8     Fn1     6.9050
## 6038    8C 1.4         8     Fn1    10.5950
## 6039    8C 1.5         8     Fn1     6.8050
## 6040    8C 2.1         8     Fn1     8.0100
## 6041    8C 2.2         8     Fn1     8.5550
## 6042    8C 2.3         8     Fn1    10.9850
## 6043    8C 2.4         8     Fn1     7.8700
## 6044    8C 2.5         8     Fn1    10.8250
## 6045    8C 2.6         8     Fn1    10.9400
## 6046    8C 2.7         8     Fn1    11.9200
## 6047    8C 2.8         8     Fn1    11.9500
## 6048    8C 3.1         8     Fn1     9.0850
## 6049    8C 3.2         8     Fn1     7.3600
## 6050    8C 3.3         8     Fn1    14.3400
## 6051    8C 3.4         8     Fn1     9.0850
## 6052    8C 3.5         8     Fn1    10.2450
## 6053    8C 3.6         8     Fn1     9.0300
## 6054    8C 3.7         8     Fn1     8.3650
## 6055    8C 3.8         8     Fn1     8.1900
## 6056    8C 4.2         8     Fn1     7.7000
## 6057    8C 4.3         8     Fn1     8.0550
## 6058    8C 4.4         8     Fn1    10.4600
## 6059    8C 4.5         8     Fn1    13.5550
## 6060    8C 4.6         8     Fn1     9.0400
## 6061    8C 4.7         8     Fn1     8.9400
## 6062    8C 5.1         8     Fn1    14.0200
## 6063    8C 5.2         8     Fn1    13.0200
## 6064    8C 5.3         8     Fn1     6.6600
## 6065    8C 5.4         8     Fn1     6.5950
## 6066    8C 5.5         8     Fn1     6.3900
## 6067    8C 5.6         8     Fn1     6.1450
## 6068    8C 5.7         8     Fn1    10.2150
## 6069    8C 5.8         8     Fn1    10.1050
## 6070    8C 6.1         8     Fn1     9.2750
## 6071    8C 6.2         8     Fn1    10.9600
## 6072    8C 6.3         8     Fn1     7.5850
## 6073    8C 6.4         8     Fn1     7.6750
## 6074    8C 6.5         8     Fn1     3.4550
## 6075    8C 6.6         8     Fn1     7.0600
## 6076    8C 6.7         8     Fn1     6.5700
## 6077    8C 6.8         8     Fn1     9.4450
## 6078   16C 1.1        16     Fn1    10.7050
## 6079   16C 1.2        16     Fn1     6.9400
## 6080   16C 1.3        16     Fn1    12.2300
## 6081   16C 1.4        16     Fn1    10.3250
## 6082   16C 1.5        16     Fn1     7.2100
## 6083   16C 1.6        16     Fn1    11.3000
## 6084   16C 1.7        16     Fn1     9.8350
## 6085   16C 1.8        16     Fn1     6.8300
## 6086   16C 1.9        16     Fn1    11.0250
## 6087  16C 1.10        16     Fn1    11.0450
## 6088  16C 1.11        16     Fn1    12.5350
## 6089  16C 1.12        16     Fn1    10.8150
## 6090  16C 1.13        16     Fn1    12.9500
## 6091  16C 1.14        16     Fn1    12.4350
## 6092  16C 1.15        16     Fn1     8.4450
## 6093  16C 1.16        16     Fn1     9.1500
## 6094   16C 2.1        16     Fn1    12.4050
## 6095   16C 2.2        16     Fn1     8.4350
## 6096   16C 2.3        16     Fn1     9.8600
## 6097   16C 2.4        16     Fn1     9.1000
## 6098   16C 2.5        16     Fn1    13.0850
## 6099   16C 2.6        16     Fn1     7.9850
## 6100   16C 2.7        16     Fn1    11.7900
## 6101   16C 2.8        16     Fn1     7.4400
## 6102   16C 2.9        16     Fn1     6.5600
## 6103  16C 2.10        16     Fn1    12.6300
## 6104  16C 2.11        16     Fn1     7.8800
## 6105  16C 2.12        16     Fn1     8.3975
## 6106  16C 2.13        16     Fn1    10.0250
## 6107  16C 2.14        16     Fn1     8.6700
## 6108  16C 2.15        16     Fn1     9.0100
## 6109  16C 2.16        16     Fn1     7.5750
## 6110   16C 3.1        16     Fn1     4.3350
## 6111   16C 3.2        16     Fn1    12.8250
## 6112   16C 3.3        16     Fn1    13.2950
## 6113   16C 3.4        16     Fn1    13.6250
## 6114   16C 3.5        16     Fn1    12.0575
## 6115   16C 3.6        16     Fn1     9.9250
## 6116   16C 3.7        16     Fn1    12.2000
## 6117   16C 3.8        16     Fn1     9.0500
## 6118   16C 3.9        16     Fn1     6.9150
## 6119  16C 3.10        16     Fn1     8.8000
## 6120  16C 3.11        16     Fn1    10.7950
## 6121  16C 3.12        16     Fn1    10.2550
## 6122  16C 3.13        16     Fn1    13.5600
## 6123  16C 3.14        16     Fn1     9.9925
## 6124  16C 3.15        16     Fn1    13.5650
## 6125   16C 4.1        16     Fn1     7.0650
## 6126   16C 4.2        16     Fn1     8.6000
## 6127   16C 4.3        16     Fn1    10.4750
## 6128   16C 4.4        16     Fn1    12.3650
## 6129   16C 4.5        16     Fn1     8.4950
## 6130   16C 4.6        16     Fn1     9.8050
## 6131   16C 4.7        16     Fn1    13.8650
## 6132   16C 4.8        16     Fn1    12.5000
## 6133   16C 4.9        16     Fn1    10.8050
## 6134  16C 4.10        16     Fn1     8.3150
## 6135  16C 4.11        16     Fn1    11.4100
## 6136  16C 4.12        16     Fn1     4.4150
## 6137  16C 4.13        16     Fn1     7.9200
## 6138  16C 4.14        16     Fn1    10.3450
## 6139  16C 4.15        16     Fn1    13.4050
## 6140  16C 4.16        16     Fn1    14.0950
## 6141   16C 5.1        16     Fn1    10.7300
## 6142   16C 5.2        16     Fn1    11.5100
## 6143   16C 5.3        16     Fn1    14.0750
## 6144   16C 5.4        16     Fn1     8.1550
## 6145   16C 5.5        16     Fn1    10.5950
## 6146   16C 5.6        16     Fn1     8.3650
## 6147   16C 5.7        16     Fn1     6.2200
## 6148   16C 5.8        16     Fn1    12.5350
## 6149   16C 5.9        16     Fn1     9.6950
## 6150  16C 5.10        16     Fn1    12.1200
## 6151  16C 5.11        16     Fn1     8.5250
## 6152  16C 5.12        16     Fn1    10.6300
## 6153   32C 1.1        32     Fn1    11.9200
## 6154   32C 1.2        32     Fn1     4.5200
## 6155   32C 1.3        32     Fn1    12.4350
## 6156   32C 1.4        32     Fn1    10.6400
## 6157   32C 1.5        32     Fn1     6.0300
## 6158   32C 1.6        32     Fn1     4.5550
## 6159   32C 1.7        32     Fn1    12.6950
## 6160   32C 1.8        32     Fn1     6.8800
## 6161   32C 1.9        32     Fn1     5.8150
## 6162  32C 1.10        32     Fn1     5.6800
## 6163  32C 1.11        32     Fn1    11.1700
## 6164  32C 1.12        32     Fn1    11.8150
## 6165  32C 1.13        32     Fn1     5.5900
## 6166  32C 1.14        32     Fn1     9.4150
## 6167  32C 1.15        32     Fn1     4.6200
## 6168  32C 1.16        32     Fn1     5.0200
## 6169  32C 1.17        32     Fn1     8.0500
## 6170  32C 1.18        32     Fn1     4.3400
## 6171  32C 1.19        32     Fn1     6.2500
## 6172  32C 1.20        32     Fn1     4.7350
## 6173  32C 1.21        32     Fn1     4.3300
## 6174   32C 2.1        32     Fn1     7.2350
## 6175   32C 2.2        32     Fn1    10.1350
## 6176   32C 2.3        32     Fn1     9.4950
## 6177   32C 2.4        32     Fn1     7.3350
## 6178   32C 2.5        32     Fn1    10.5800
## 6179   32C 2.6        32     Fn1     9.6950
## 6180   32C 2.7        32     Fn1     7.8050
## 6181   32C 2.8        32     Fn1     3.2950
## 6182   32C 2.9        32     Fn1     8.6900
## 6183  32C 2.10        32     Fn1     7.9700
## 6184  32C 2.11        32     Fn1     7.7550
## 6185  32C 2.12        32     Fn1    14.0350
## 6186  32C 2.13        32     Fn1     5.4600
## 6187  32C 2.14        32     Fn1     4.2800
## 6188  32C 2.15        32     Fn1     6.9650
## 6189  32C 2.16        32     Fn1     4.4000
## 6190   32C 3.1        32     Fn1    11.3000
## 6191   32C 3.2        32     Fn1    12.3250
## 6192   32C 3.3        32     Fn1    11.6700
## 6193   32C 3.4        32     Fn1    14.3350
## 6194   32C 3.5        32     Fn1    13.7550
## 6195   32C 3.6        32     Fn1     4.9150
## 6196   32C 3.7        32     Fn1     5.4050
## 6197   32C 3.8        32     Fn1     3.7600
## 6198   32C 4.1        32     Fn1     7.2950
## 6199   32C 4.2        32     Fn1     7.8950
## 6200   32C 4.3        32     Fn1     6.2000
## 6201   32C 4.4        32     Fn1     4.5850
## 6202   32C 4.5        32     Fn1     6.4250
## 6203   32C 4.6        32     Fn1     5.9200
## 6204   32C 4.7        32     Fn1     8.1600
## 6205   32C 4.8        32     Fn1    12.0950
## 6206  32C 4.10        32     Fn1     9.2050
## 6207  32C 4.11        32     Fn1     2.5000
## 6208  32C 4.12        32     Fn1     6.5500
## 6209  32C 4.13        32     Fn1     7.0600
## 6210  32C 4.14        32     Fn1     5.6900
## 6211  32C 4.15        32     Fn1     4.8200
## 6212  32C 4.16        32     Fn1     4.5375
## 6213  32C 4.17        32     Fn1    12.7250
## 6214  32C 4.18        32     Fn1    12.0700
## 6215  32C 4.19        32     Fn1    12.1200
## 6216  32C 4.20        32     Fn1     3.1350
## 6217  32C 4.21        32     Fn1     1.2750
## 6218  32C 4.22        32     Fn1     3.3050
## 6219  32C 4.23        32     Fn1     7.4050
## 6220  32C 4.24        32     Fn1     5.4750
## 6221   32C 5.1        32     Fn1    12.0575
## 6222   32C 5.2        32     Fn1    14.2550
## 6223   32C 5.3        32     Fn1     7.8000
## 6224   32C 5.4        32     Fn1     9.2600
## 6225   32C 5.5        32     Fn1    10.3550
## 6226   32C 5.6        32     Fn1    12.1400
## 6227   32C 5.7        32     Fn1    10.7950
## 6228   32C 5.8        32     Fn1     4.4850
## 6229   32C 5.9        32     Fn1     8.8700
## 6230  32C 5.10        32     Fn1     5.0825
## 6231  32C 5.11        32     Fn1    13.5650
## 6232  32C 5.12        32     Fn1     4.1250
## 6233  32C 5.13        32     Fn1    12.4200
## 6234  32C 5.14        32     Fn1     6.4350
## 6235  32C 5.15        32     Fn1    12.3650
## 6236  32C 5.16        32     Fn1    11.6550
## 6237  32C 5.17        32     Fn1    12.8950
## 6238  32C 5.18        32     Fn1    13.8650
## 6239  32C 5.19        32     Fn1     5.2800
## 6240  32C 5.20        32     Fn1    11.2050
## 6241  32C 5.21        32     Fn1    13.1550
## 6242  32C 5.22        32     Fn1    11.4100
## 6243  32C 5.23        32     Fn1     9.5850
## 6244   32C 6.1        32     Fn1     3.6550
## 6245   32C 6.2        32     Fn1     8.9850
## 6246   32C 6.3        32     Fn1    13.4050
## 6247   32C 6.4        32     Fn1     7.6900
## 6248   32C 6.6        32     Fn1    12.8700
## 6249   32C 6.7        32     Fn1    15.0900
## 6250   32C 7.1        32     Fn1    12.2400
## 6251   32C 7.2        32     Fn1     3.0400
## 6252   32C 7.3        32     Fn1    10.5950
## 6253   32C 7.4        32     Fn1    11.2950
## 6254   32C 7.5        32     Fn1     3.5950
## 6255   32C 7.6        32     Fn1     5.9000
## 6256   32C 7.8        32     Fn1    13.9250
## 6257   32C 8.1        32     Fn1    12.1200
## 6258   32C 8.2        32     Fn1    13.1350
## 6259   32C 8.4        32     Fn1    11.5250
## 6260   32C 8.5        32     Fn1     7.6850
## 6261   32C 8.6        32     Fn1    11.9500
## 6262   64C 1.1        64     Fn1     6.6550
## 6263   64C 1.2        64     Fn1    10.6400
## 6264   64C 1.3        64     Fn1     6.6300
## 6265   64C 1.4        64     Fn1     7.6150
## 6266   64C 1.5        64     Fn1     7.9050
## 6267   64C 1.6        64     Fn1     5.5600
## 6268   64C 1.7        64     Fn1     8.6250
## 6269   64C 1.8        64     Fn1     7.2300
## 6270   64C 1.9        64     Fn1     6.8400
## 6271  64C 1.10        64     Fn1    11.8150
## 6272  64C 1.11        64     Fn1     7.0200
## 6273  64C 1.12        64     Fn1    13.5550
## 6274  64C 1.13        64     Fn1     6.9300
## 6275  64C 1.14        64     Fn1    13.2900
## 6276  64C 1.15        64     Fn1    14.0200
## 6277  64C 1.16        64     Fn1    13.0200
## 6278  64C 1.17        64     Fn1    12.1900
## 6279  64C 1.18        64     Fn1    11.5150
## 6280  64C 1.19        64     Fn1    10.0800
## 6281  64C 1.20        64     Fn1    11.6750
## 6282  64C 1.21        64     Fn1     7.1450
## 6283  64C 1.22        64     Fn1     5.5550
## 6284  64C 1.23        64     Fn1     5.7450
## 6285  64C 1.24        64     Fn1    15.9200
## 6286  64C 1.25        64     Fn1     6.9950
## 6287  64C 1.26        64     Fn1     4.5050
## 6288  64C 1.27        64     Fn1     9.5250
## 6289  64C 1.28        64     Fn1     9.1700
## 6290  64C 1.29        64     Fn1     7.2900
## 6291  64C 1.30        64     Fn1    14.0950
## 6292  64C 1.31        64     Fn1    13.1450
## 6293  64C 1.32        64     Fn1    11.7500
## 6294  64C 1.33        64     Fn1    13.7500
## 6295  64C 1.34        64     Fn1    14.7950
## 6296  64C 1.35        64     Fn1    11.7000
## 6297  64C 1.36        64     Fn1     7.3700
## 6298  64C 1.37        64     Fn1    12.3250
## 6299  64C 1.38        64     Fn1    11.6700
## 6300  64C 1.39        64     Fn1    14.3350
## 6301  64C 1.40        64     Fn1     5.0950
## 6302  64C 1.41        64     Fn1     6.0650
## 6303  64C 1.42        64     Fn1     7.8050
## 6304  64C 1.43        64     Fn1     5.9700
## 6305  64C 1.44        64     Fn1    12.4350
## 6306  64C 1.45        64     Fn1    11.5450
## 6307  64C 1.46        64     Fn1    13.9600
## 6308  64C 1.47        64     Fn1    12.4050
## 6309  64C 1.48        64     Fn1     9.3350
## 6310   64C 2.1        64     Fn1    13.9300
## 6311   64C 2.2        64     Fn1    13.4500
## 6312   64C 2.3        64     Fn1    13.0850
## 6313   64C 2.4        64     Fn1     8.5150
## 6314   64C 2.5        64     Fn1     5.0300
## 6315   64C 2.6        64     Fn1     8.6200
## 6316   64C 2.7        64     Fn1     4.4800
## 6317   64C 2.8        64     Fn1     5.7400
## 6318   64C 2.9        64     Fn1    13.2800
## 6319  64C 2.10        64     Fn1    12.2975
## 6320  64C 2.11        64     Fn1    12.7250
## 6321  64C 2.12        64     Fn1    12.0700
## 6322  64C 2.13        64     Fn1    12.1200
## 6323  64C 2.14        64     Fn1    11.2750
## 6324  64C 2.15        64     Fn1     9.0650
## 6325  64C 2.16        64     Fn1     6.0650
## 6326  64C 2.17        64     Fn1     9.9350
## 6327  64C 2.18        64     Fn1    13.6250
## 6328  64C 2.19        64     Fn1    12.0575
## 6329  64C 2.20        64     Fn1    14.2550
## 6330  64C 2.21        64     Fn1    12.2000
## 6331  64C 2.22        64     Fn1    12.7000
## 6332  64C 2.23        64     Fn1    10.3550
## 6333  64C 2.24        64     Fn1    12.1400
## 6334  64C 2.25        64     Fn1     5.4650
## 6335   64C 3.1        64     Fn1    12.8150
## 6336   64C 3.2        64     Fn1    13.5600
## 6337   64C 3.3        64     Fn1    12.7325
## 6338   64C 3.4        64     Fn1    13.5650
## 6339   64C 3.5        64     Fn1     8.3050
## 6340   64C 3.6        64     Fn1    12.4200
## 6341   64C 3.7        64     Fn1    10.4750
## 6342   64C 3.8        64     Fn1    12.3650
## 6343   64C 4.1        64     Fn1     3.8950
## 6344  64C 4.1b        64     Fn1     4.3050
## 6345   64C 4.2        64     Fn1     5.0450
## 6346   64C 4.3        64     Fn1     4.9100
## 6347   64C 4.4        64     Fn1     7.5150
## 6348   64C 4.5        64     Fn1     5.5250
## 6349   64C 4.6        64     Fn1     5.8100
## 6350   64C 4.7        64     Fn1     9.5850
## 6351   64C 4.8        64     Fn1     2.4400
## 6352   64C 4.9        64     Fn1    10.3450
## 6353  64C 4.10        64     Fn1     5.8050
## 6354  64C 4.11        64     Fn1     5.2550
## 6355  64C 4.12        64     Fn1    12.8700
## 6356  64C 4.13        64     Fn1    15.0900
## 6357  64C 4.14        64     Fn1    14.0750
## 6358  64C 4.15        64     Fn1     9.1850
## 6359  64C 4.16        64     Fn1     9.9550
## 6360  64C 4.17        64     Fn1    11.2950
## 6361  64C 4.18        64     Fn1    10.8700
## 6362  64C 4.19        64     Fn1    12.5350
## 6363  64C 4.20        64     Fn1    13.9250
## 6364  64C 4.21        64     Fn1    12.1200
## 6365  64C 4.22        64     Fn1    13.1350
## 6366  64C 4.23        64     Fn1    13.9900
## 6367  64C 4.24        64     Fn1    11.9200
## 6368  64C 4.25        64     Fn1    11.9500
## 6369  64C 4.26        64     Fn1     5.9850
## 6370  64C 4.27        64     Fn1    10.6400
## 6371  64C 4.28        64     Fn1     7.0000
## 6372  64C 4.29        64     Fn1    13.3150
## 6373  64C 4.30        64     Fn1     6.4350
## 6374  64C 4.31        64     Fn1    14.4300
## 6375  64C 4.32        64     Fn1     4.3750
## 6376  64C 4.33        64     Fn1    11.9400
## 6377  64C 4.34        64     Fn1    11.1700
## 6378  64C 4.35        64     Fn1     4.7450
## 6379  64C 4.36        64     Fn1    12.2600
## 6380  64C 4.37        64     Fn1    13.5550
## 6381  64C 4.38        64     Fn1     4.9200
## 6382  64C 4.39        64     Fn1    13.2900
## 6383   64C 5.1        64     Fn1    14.0200
## 6384   64C 5.2        64     Fn1    13.0200
## 6385   64C 5.3        64     Fn1     7.9300
## 6386   64C 5.4        64     Fn1    11.5150
## 6387   64C 5.5        64     Fn1     5.3100
## 6388   64C 5.6        64     Fn1     5.8150
## 6389   64C 5.7        64     Fn1    10.7350
## 6390   64C 5.8        64     Fn1     4.3250
## 6391   64C 5.9        64     Fn1    13.6650
## 6392  64C 5.10        64     Fn1     9.6600
## 6393  64C 5.11        64     Fn1    12.7750
## 6394  64C 5.12        64     Fn1    11.7950
## 6395  64C 5.13        64     Fn1     9.5250
## 6396  64C 5.14        64     Fn1    13.1700
## 6397  64C 5.15        64     Fn1    11.3100
## 6398  64C 5.16        64     Fn1    14.0950
## 6399   64C 6.1        64     Fn1     5.4650
## 6400   64C 6.2        64     Fn1     2.2100
## 6401   64C 6.3        64     Fn1     5.7400
## 6402   64C 6.4        64     Fn1     5.5250
## 6403   64C 6.5        64     Fn1     3.4000
## 6404   64C 6.6        64     Fn1     2.5400
## 6405   64C 6.7        64     Fn1     8.2850
## 6406   64C 6.8        64     Fn1     3.2100
## 6407   64C 7.1        64     Fn1    10.9450
## 6408   64C 7.2        64     Fn1     8.9550
## 6409   64C 7.3        64     Fn1     3.8550
## 6410   64C 7.4        64     Fn1     9.4350
## 6411   64C 7.5        64     Fn1     6.8000
## 6412   64C 7.6        64     Fn1     6.2750
## 6413   64C 7.7        64     Fn1     5.9250
## 6414   64C 7.8        64     Fn1     5.9500
## 6415   64C 7.9        64     Fn1     6.6450
## 6416  64C 7.10        64     Fn1    14.1050
## 6417  64C 7.11        64     Fn1    10.2500
## 6418  64C 7.12        64     Fn1    13.4500
## 6419  64C 7.13        64     Fn1    13.0850
## 6420  64C 7.14        64     Fn1    12.2750
## 6421    2C 1.1         2   Gapdh     0.3050
## 6422    2C 1.2         2   Gapdh    -2.7150
## 6423    2C 2.1         2   Gapdh     0.1350
## 6424    2C 2.2         2   Gapdh    -0.0350
## 6425    2C 3.1         2   Gapdh     2.1100
## 6426    2C 3.2         2   Gapdh     3.0750
## 6427    2C 4.1         2   Gapdh     3.4900
## 6428    2C 5.1         2   Gapdh    -0.0300
## 6429    2C 5.2         2   Gapdh     1.2450
## 6430    2C 6.1         2   Gapdh    -0.0850
## 6431    2C 6.2         2   Gapdh    -0.4050
## 6432    2C 7.1         2   Gapdh     0.0250
## 6433    2C 7.2         2   Gapdh     0.8550
## 6434    2C 8.1         2   Gapdh     2.8800
## 6435    2C 8.2         2   Gapdh     1.6150
## 6436    2C 9.1         2   Gapdh     3.0200
## 6437    2C 9.2         2   Gapdh     0.3600
## 6438   2C 10.1         2   Gapdh     3.0950
## 6439   2C 10.2         2   Gapdh     0.0550
## 6440    4C 1.1         4   Gapdh     2.8750
## 6441    4C 1.2         4   Gapdh     2.7650
## 6442    4C 1.3         4   Gapdh     4.0200
## 6443    4C 1.4         4   Gapdh     5.0050
## 6444    4C 2.1         4   Gapdh     4.4025
## 6445    4C 2.2         4   Gapdh     3.3900
## 6446    4C 2.3         4   Gapdh     4.6400
## 6447    4C 3.1         4   Gapdh     3.1800
## 6448    4C 3.2         4   Gapdh     1.1800
## 6449    4C 3.3         4   Gapdh     3.8750
## 6450    4C 3.4         4   Gapdh     3.6800
## 6451    4C 4.1         4   Gapdh     5.1800
## 6452    4C 4.2         4   Gapdh     6.2850
## 6453    4C 4.3         4   Gapdh     4.7325
## 6454    4C 4.4         4   Gapdh     7.7150
## 6455    4C 5.1         4   Gapdh     4.5550
## 6456    4C 5.2         4   Gapdh     1.3850
## 6457    4C 5.3         4   Gapdh    -0.4950
## 6458    4C 5.4         4   Gapdh     1.5150
## 6459    4C 6.1         4   Gapdh    -1.2350
## 6460    4C 6.2         4   Gapdh     2.3800
## 6461    4C 6.3         4   Gapdh     3.5900
## 6462    4C 6.4         4   Gapdh     0.8300
## 6463    8C 1.1         8   Gapdh     3.1550
## 6464    8C 1.2         8   Gapdh     3.3600
## 6465    8C 1.3         8   Gapdh     1.1550
## 6466    8C 1.4         8   Gapdh     1.4600
## 6467    8C 1.5         8   Gapdh     1.7050
## 6468    8C 2.1         8   Gapdh     0.3700
## 6469    8C 2.2         8   Gapdh     3.3800
## 6470    8C 2.3         8   Gapdh     3.6750
## 6471    8C 2.4         8   Gapdh     3.0500
## 6472    8C 2.5         8   Gapdh     3.8450
## 6473    8C 2.6         8   Gapdh     5.0300
## 6474    8C 2.7         8   Gapdh     2.8000
## 6475    8C 2.8         8   Gapdh     2.2100
## 6476    8C 3.1         8   Gapdh     3.9450
## 6477    8C 3.2         8   Gapdh     3.9600
## 6478    8C 3.3         8   Gapdh     5.7700
## 6479    8C 3.4         8   Gapdh     3.9600
## 6480    8C 3.5         8   Gapdh     1.8650
## 6481    8C 3.6         8   Gapdh     4.9800
## 6482    8C 3.7         8   Gapdh     4.3800
## 6483    8C 3.8         8   Gapdh     2.0050
## 6484    8C 4.2         8   Gapdh     2.9700
## 6485    8C 4.3         8   Gapdh     2.0050
## 6486    8C 4.4         8   Gapdh     2.1100
## 6487    8C 4.5         8   Gapdh     5.8450
## 6488    8C 4.6         8   Gapdh     3.0600
## 6489    8C 4.7         8   Gapdh     3.1850
## 6490    8C 5.1         8   Gapdh     3.5000
## 6491    8C 5.2         8   Gapdh     3.2750
## 6492    8C 5.3         8   Gapdh     1.8250
## 6493    8C 5.4         8   Gapdh     2.1250
## 6494    8C 5.5         8   Gapdh     0.6750
## 6495    8C 5.6         8   Gapdh     0.1200
## 6496    8C 5.7         8   Gapdh     3.3200
## 6497    8C 5.8         8   Gapdh     3.1050
## 6498    8C 6.1         8   Gapdh     2.9450
## 6499    8C 6.2         8   Gapdh     4.4000
## 6500    8C 6.3         8   Gapdh     3.7950
## 6501    8C 6.4         8   Gapdh     1.1050
## 6502    8C 6.5         8   Gapdh     1.7300
## 6503    8C 6.6         8   Gapdh     2.6500
## 6504    8C 6.7         8   Gapdh     1.6500
## 6505    8C 6.8         8   Gapdh     3.8500
## 6506   16C 1.1        16   Gapdh     5.2650
## 6507   16C 1.2        16   Gapdh     0.8600
## 6508   16C 1.3        16   Gapdh     3.7800
## 6509   16C 1.4        16   Gapdh     4.6900
## 6510   16C 1.5        16   Gapdh     2.0000
## 6511   16C 1.6        16   Gapdh     0.3050
## 6512   16C 1.7        16   Gapdh     2.6200
## 6513   16C 1.8        16   Gapdh     2.2900
## 6514   16C 1.9        16   Gapdh     3.9950
## 6515  16C 1.10        16   Gapdh     2.4000
## 6516  16C 1.11        16   Gapdh     3.9950
## 6517  16C 1.12        16   Gapdh     2.6200
## 6518  16C 1.13        16   Gapdh     2.4100
## 6519  16C 1.14        16   Gapdh     1.0650
## 6520  16C 1.15        16   Gapdh     0.9550
## 6521  16C 1.16        16   Gapdh     1.9450
## 6522   16C 2.1        16   Gapdh     0.7600
## 6523   16C 2.2        16   Gapdh     4.7100
## 6524   16C 2.3        16   Gapdh     4.3850
## 6525   16C 2.4        16   Gapdh     4.1750
## 6526   16C 2.5        16   Gapdh     3.3800
## 6527   16C 2.6        16   Gapdh    -0.5000
## 6528   16C 2.7        16   Gapdh     3.1250
## 6529   16C 2.8        16   Gapdh     0.1650
## 6530   16C 2.9        16   Gapdh     2.8650
## 6531  16C 2.10        16   Gapdh     2.6950
## 6532  16C 2.11        16   Gapdh     4.7000
## 6533  16C 2.12        16   Gapdh     3.6250
## 6534  16C 2.13        16   Gapdh     4.4700
## 6535  16C 2.14        16   Gapdh     0.7800
## 6536  16C 2.15        16   Gapdh     1.1350
## 6537  16C 2.16        16   Gapdh     2.1550
## 6538   16C 3.1        16   Gapdh     3.2150
## 6539   16C 3.2        16   Gapdh     4.0250
## 6540   16C 3.3        16   Gapdh     5.4150
## 6541   16C 3.4        16   Gapdh     5.7100
## 6542   16C 3.5        16   Gapdh     4.5950
## 6543   16C 3.6        16   Gapdh     4.4400
## 6544   16C 3.7        16   Gapdh     2.4700
## 6545   16C 3.8        16   Gapdh     5.0650
## 6546   16C 3.9        16   Gapdh     4.0850
## 6547  16C 3.10        16   Gapdh     5.1250
## 6548  16C 3.11        16   Gapdh     3.6850
## 6549  16C 3.12        16   Gapdh     4.9100
## 6550  16C 3.13        16   Gapdh     5.8250
## 6551  16C 3.14        16   Gapdh     5.6025
## 6552  16C 3.15        16   Gapdh     3.7300
## 6553   16C 4.1        16   Gapdh     2.4200
## 6554   16C 4.2        16   Gapdh     2.9400
## 6555   16C 4.3        16   Gapdh     1.7600
## 6556   16C 4.4        16   Gapdh     2.8250
## 6557   16C 4.5        16   Gapdh     2.9600
## 6558   16C 4.6        16   Gapdh     1.9900
## 6559   16C 4.7        16   Gapdh     2.4750
## 6560   16C 4.8        16   Gapdh     4.0225
## 6561   16C 4.9        16   Gapdh     3.9750
## 6562  16C 4.10        16   Gapdh     4.6950
## 6563  16C 4.11        16   Gapdh     2.3050
## 6564  16C 4.12        16   Gapdh    -0.3150
## 6565  16C 4.13        16   Gapdh     2.1750
## 6566  16C 4.14        16   Gapdh     0.8750
## 6567  16C 4.15        16   Gapdh     3.6500
## 6568  16C 4.16        16   Gapdh     4.3500
## 6569   16C 5.1        16   Gapdh     2.4800
## 6570   16C 5.2        16   Gapdh     5.5850
## 6571   16C 5.3        16   Gapdh     3.6300
## 6572   16C 5.4        16   Gapdh     0.7950
## 6573   16C 5.5        16   Gapdh     1.2000
## 6574   16C 5.6        16   Gapdh     3.2350
## 6575   16C 5.7        16   Gapdh     0.6500
## 6576   16C 5.8        16   Gapdh     4.4900
## 6577   16C 5.9        16   Gapdh     4.3450
## 6578  16C 5.10        16   Gapdh     2.6000
## 6579  16C 5.11        16   Gapdh     2.7250
## 6580  16C 5.12        16   Gapdh     5.1400
## 6581   32C 1.1        32   Gapdh    -0.0400
## 6582   32C 1.2        32   Gapdh     1.0100
## 6583   32C 1.3        32   Gapdh     0.7350
## 6584   32C 1.4        32   Gapdh    -0.5900
## 6585   32C 1.5        32   Gapdh     3.4800
## 6586   32C 1.6        32   Gapdh     2.2700
## 6587   32C 1.7        32   Gapdh     1.5050
## 6588   32C 1.8        32   Gapdh     1.8300
## 6589   32C 1.9        32   Gapdh     1.5900
## 6590  32C 1.10        32   Gapdh     0.5450
## 6591  32C 1.11        32   Gapdh     0.0700
## 6592  32C 1.12        32   Gapdh     0.4450
## 6593  32C 1.13        32   Gapdh    -0.0200
## 6594  32C 1.14        32   Gapdh     1.3450
## 6595  32C 1.15        32   Gapdh     0.8300
## 6596  32C 1.16        32   Gapdh     1.8450
## 6597  32C 1.17        32   Gapdh     1.9800
## 6598  32C 1.18        32   Gapdh     2.1950
## 6599  32C 1.19        32   Gapdh     0.5850
## 6600  32C 1.20        32   Gapdh     0.4850
## 6601  32C 1.21        32   Gapdh     0.0150
## 6602   32C 2.1        32   Gapdh    -2.4000
## 6603   32C 2.2        32   Gapdh     0.0000
## 6604   32C 2.3        32   Gapdh    -0.6050
## 6605   32C 2.4        32   Gapdh    -0.0050
## 6606   32C 2.5        32   Gapdh     2.1100
## 6607   32C 2.6        32   Gapdh     1.2050
## 6608   32C 2.7        32   Gapdh    -2.4450
## 6609   32C 2.8        32   Gapdh    -1.5800
## 6610   32C 2.9        32   Gapdh    -1.0900
## 6611  32C 2.10        32   Gapdh    -2.1700
## 6612  32C 2.11        32   Gapdh     1.8600
## 6613  32C 2.12        32   Gapdh     0.3650
## 6614  32C 2.13        32   Gapdh    -0.7000
## 6615  32C 2.14        32   Gapdh     0.3100
## 6616  32C 2.15        32   Gapdh     1.3500
## 6617  32C 2.16        32   Gapdh    -1.2700
## 6618   32C 3.1        32   Gapdh    -3.8650
## 6619   32C 3.2        32   Gapdh    -1.3000
## 6620   32C 3.3        32   Gapdh    -0.6700
## 6621   32C 3.4        32   Gapdh     0.9350
## 6622   32C 3.5        32   Gapdh     0.3100
## 6623   32C 3.6        32   Gapdh     1.4850
## 6624   32C 3.7        32   Gapdh     0.0700
## 6625   32C 3.8        32   Gapdh    -0.5300
## 6626   32C 4.1        32   Gapdh    -0.9550
## 6627   32C 4.2        32   Gapdh    -0.1950
## 6628   32C 4.3        32   Gapdh    -2.0950
## 6629   32C 4.4        32   Gapdh    -1.5300
## 6630   32C 4.5        32   Gapdh     2.0900
## 6631   32C 4.6        32   Gapdh     0.6550
## 6632   32C 4.7        32   Gapdh     1.3850
## 6633   32C 4.8        32   Gapdh    -0.0900
## 6634  32C 4.10        32   Gapdh    -0.6900
## 6635  32C 4.11        32   Gapdh    -0.9150
## 6636  32C 4.12        32   Gapdh    -3.4850
## 6637  32C 4.13        32   Gapdh    -0.2250
## 6638  32C 4.14        32   Gapdh    -0.8850
## 6639  32C 4.15        32   Gapdh     0.9600
## 6640  32C 4.16        32   Gapdh     2.1950
## 6641  32C 4.17        32   Gapdh     3.3400
## 6642  32C 4.18        32   Gapdh    -0.3900
## 6643  32C 4.19        32   Gapdh    -0.7350
## 6644  32C 4.20        32   Gapdh    -2.4450
## 6645  32C 4.21        32   Gapdh    -1.1950
## 6646  32C 4.22        32   Gapdh    -1.1750
## 6647  32C 4.23        32   Gapdh     0.6050
## 6648  32C 4.24        32   Gapdh     1.2300
## 6649   32C 5.1        32   Gapdh     0.6850
## 6650   32C 5.2        32   Gapdh     2.3900
## 6651   32C 5.3        32   Gapdh    -0.7800
## 6652   32C 5.4        32   Gapdh     0.2750
## 6653   32C 5.5        32   Gapdh    -0.8450
## 6654   32C 5.6        32   Gapdh     0.4750
## 6655   32C 5.7        32   Gapdh    -0.5350
## 6656   32C 5.8        32   Gapdh     1.0500
## 6657   32C 5.9        32   Gapdh     0.5450
## 6658  32C 5.10        32   Gapdh     2.0425
## 6659  32C 5.11        32   Gapdh     0.3700
## 6660  32C 5.12        32   Gapdh     1.5300
## 6661  32C 5.13        32   Gapdh    -0.4500
## 6662  32C 5.14        32   Gapdh    -1.8300
## 6663  32C 5.15        32   Gapdh    -0.7850
## 6664  32C 5.16        32   Gapdh    -1.6000
## 6665  32C 5.17        32   Gapdh     1.1400
## 6666  32C 5.18        32   Gapdh     0.6050
## 6667  32C 5.19        32   Gapdh    -0.5875
## 6668  32C 5.20        32   Gapdh     1.7550
## 6669  32C 5.21        32   Gapdh     1.4450
## 6670  32C 5.22        32   Gapdh    -0.8450
## 6671  32C 5.23        32   Gapdh    -3.1150
## 6672   32C 6.1        32   Gapdh     0.7900
## 6673   32C 6.2        32   Gapdh    -3.4350
## 6674   32C 6.3        32   Gapdh     1.7900
## 6675   32C 6.4        32   Gapdh     3.2550
## 6676   32C 6.6        32   Gapdh    -0.8000
## 6677   32C 6.7        32   Gapdh     3.4750
## 6678   32C 7.1        32   Gapdh     1.8200
## 6679   32C 7.2        32   Gapdh     1.4100
## 6680   32C 7.3        32   Gapdh     0.1450
## 6681   32C 7.4        32   Gapdh    -0.4450
## 6682   32C 7.5        32   Gapdh     0.1150
## 6683   32C 7.6        32   Gapdh     0.9150
## 6684   32C 7.8        32   Gapdh     1.9800
## 6685   32C 8.1        32   Gapdh     1.3150
## 6686   32C 8.2        32   Gapdh     2.4700
## 6687   32C 8.4        32   Gapdh     3.5100
## 6688   32C 8.5        32   Gapdh     1.0600
## 6689   32C 8.6        32   Gapdh     0.7650
## 6690   64C 1.1        64   Gapdh    -0.1150
## 6691   64C 1.2        64   Gapdh     0.1900
## 6692   64C 1.3        64   Gapdh     4.2600
## 6693   64C 1.4        64   Gapdh     2.6800
## 6694   64C 1.5        64   Gapdh     0.0950
## 6695   64C 1.6        64   Gapdh     3.0300
## 6696   64C 1.7        64   Gapdh     2.1500
## 6697   64C 1.8        64   Gapdh     0.6350
## 6698   64C 1.9        64   Gapdh    -0.3800
## 6699  64C 1.10        64   Gapdh     1.2250
## 6700  64C 1.11        64   Gapdh    -0.5300
## 6701  64C 1.12        64   Gapdh     3.9150
## 6702  64C 1.13        64   Gapdh     2.5500
## 6703  64C 1.14        64   Gapdh     1.0050
## 6704  64C 1.15        64   Gapdh     2.6000
## 6705  64C 1.16        64   Gapdh     2.0150
## 6706  64C 1.17        64   Gapdh     0.6650
## 6707  64C 1.18        64   Gapdh    -0.2450
## 6708  64C 1.19        64   Gapdh     0.6050
## 6709  64C 1.20        64   Gapdh    -1.0100
## 6710  64C 1.21        64   Gapdh     1.1300
## 6711  64C 1.22        64   Gapdh     1.3350
## 6712  64C 1.23        64   Gapdh     1.9350
## 6713  64C 1.24        64   Gapdh     2.4900
## 6714  64C 1.25        64   Gapdh     2.5250
## 6715  64C 1.26        64   Gapdh    -0.9250
## 6716  64C 1.27        64   Gapdh    -0.8900
## 6717  64C 1.28        64   Gapdh    -0.0500
## 6718  64C 1.29        64   Gapdh    -1.2300
## 6719  64C 1.30        64   Gapdh     2.3700
## 6720  64C 1.31        64   Gapdh     1.5350
## 6721  64C 1.32        64   Gapdh    -0.0400
## 6722  64C 1.33        64   Gapdh     2.8800
## 6723  64C 1.34        64   Gapdh     3.6300
## 6724  64C 1.35        64   Gapdh    -1.3600
## 6725  64C 1.36        64   Gapdh    -3.3150
## 6726  64C 1.37        64   Gapdh    -0.1100
## 6727  64C 1.38        64   Gapdh     0.2000
## 6728  64C 1.39        64   Gapdh     2.1850
## 6729  64C 1.40        64   Gapdh    -0.2300
## 6730  64C 1.41        64   Gapdh     2.1250
## 6731  64C 1.42        64   Gapdh     0.4000
## 6732  64C 1.43        64   Gapdh     1.0200
## 6733  64C 1.44        64   Gapdh    -0.3350
## 6734  64C 1.45        64   Gapdh    -0.8850
## 6735  64C 1.46        64   Gapdh    -1.7750
## 6736  64C 1.47        64   Gapdh    -1.2300
## 6737  64C 1.48        64   Gapdh     1.6900
## 6738   64C 2.1        64   Gapdh     0.1250
## 6739   64C 2.2        64   Gapdh     1.2450
## 6740   64C 2.3        64   Gapdh     1.2600
## 6741   64C 2.4        64   Gapdh     1.1400
## 6742   64C 2.5        64   Gapdh    -0.5750
## 6743   64C 2.6        64   Gapdh    -2.6450
## 6744   64C 2.7        64   Gapdh    -0.9350
## 6745   64C 2.8        64   Gapdh    -0.1450
## 6746   64C 2.9        64   Gapdh     0.8400
## 6747  64C 2.10        64   Gapdh     1.8450
## 6748  64C 2.11        64   Gapdh     3.0000
## 6749  64C 2.12        64   Gapdh    -0.6600
## 6750  64C 2.13        64   Gapdh    -0.3450
## 6751  64C 2.14        64   Gapdh    -3.0950
## 6752  64C 2.15        64   Gapdh    -2.2750
## 6753  64C 2.16        64   Gapdh     0.8150
## 6754  64C 2.17        64   Gapdh     4.4650
## 6755  64C 2.18        64   Gapdh    -0.2500
## 6756  64C 2.19        64   Gapdh     0.2850
## 6757  64C 2.20        64   Gapdh     1.6200
## 6758  64C 2.21        64   Gapdh    -0.1400
## 6759  64C 2.22        64   Gapdh     1.1250
## 6760  64C 2.23        64   Gapdh    -1.4250
## 6761  64C 2.24        64   Gapdh     0.2050
## 6762  64C 2.25        64   Gapdh    -0.8350
## 6763   64C 3.1        64   Gapdh     1.4700
## 6764   64C 3.2        64   Gapdh     2.3250
## 6765   64C 3.3        64   Gapdh     1.7925
## 6766   64C 3.4        64   Gapdh     1.2300
## 6767   64C 3.5        64   Gapdh     1.5700
## 6768   64C 3.6        64   Gapdh     0.5500
## 6769   64C 3.7        64   Gapdh    -0.8000
## 6770   64C 3.8        64   Gapdh     0.1150
## 6771   64C 4.1        64   Gapdh    -0.3900
## 6772  64C 4.1b        64   Gapdh     1.9500
## 6773   64C 4.2        64   Gapdh     1.9150
## 6774   64C 4.3        64   Gapdh     1.2125
## 6775   64C 4.4        64   Gapdh     2.8550
## 6776   64C 4.5        64   Gapdh     3.2150
## 6777   64C 4.6        64   Gapdh     1.4950
## 6778   64C 4.7        64   Gapdh    -2.2350
## 6779   64C 4.8        64   Gapdh     0.3450
## 6780   64C 4.9        64   Gapdh    -1.5450
## 6781  64C 4.10        64   Gapdh     2.2900
## 6782  64C 4.11        64   Gapdh     2.1800
## 6783  64C 4.12        64   Gapdh    -0.5600
## 6784  64C 4.13        64   Gapdh     0.6650
## 6785  64C 4.14        64   Gapdh     0.9900
## 6786  64C 4.15        64   Gapdh     0.4450
## 6787  64C 4.16        64   Gapdh    -2.2100
## 6788  64C 4.17        64   Gapdh    -0.1650
## 6789  64C 4.18        64   Gapdh    -1.4000
## 6790  64C 4.19        64   Gapdh    -0.0500
## 6791  64C 4.20        64   Gapdh     0.8550
## 6792  64C 4.21        64   Gapdh    -0.0400
## 6793  64C 4.22        64   Gapdh     0.9950
## 6794  64C 4.23        64   Gapdh     1.7300
## 6795  64C 4.24        64   Gapdh    -0.4000
## 6796  64C 4.25        64   Gapdh    -0.6300
## 6797  64C 4.26        64   Gapdh    -0.0250
## 6798  64C 4.27        64   Gapdh    -1.3700
## 6799  64C 4.28        64   Gapdh     2.4600
## 6800  64C 4.29        64   Gapdh     1.1800
## 6801  64C 4.30        64   Gapdh     0.0650
## 6802  64C 4.31        64   Gapdh     1.3800
## 6803  64C 4.32        64   Gapdh     0.6000
## 6804  64C 4.33        64   Gapdh    -0.0850
## 6805  64C 4.34        64   Gapdh    -1.5200
## 6806  64C 4.35        64   Gapdh    -1.4850
## 6807  64C 4.36        64   Gapdh    -2.0400
## 6808  64C 4.37        64   Gapdh     1.5050
## 6809  64C 4.38        64   Gapdh    -0.2100
## 6810  64C 4.39        64   Gapdh     1.8550
## 6811   64C 5.1        64   Gapdh     4.1400
## 6812   64C 5.2        64   Gapdh     3.1350
## 6813   64C 5.3        64   Gapdh     0.2650
## 6814   64C 5.4        64   Gapdh     1.5850
## 6815   64C 5.5        64   Gapdh     1.4150
## 6816   64C 5.6        64   Gapdh    -0.0700
## 6817   64C 5.7        64   Gapdh     1.4400
## 6818   64C 5.8        64   Gapdh     1.9950
## 6819   64C 5.9        64   Gapdh     2.3250
## 6820  64C 5.10        64   Gapdh     3.6800
## 6821  64C 5.11        64   Gapdh     3.2450
## 6822  64C 5.12        64   Gapdh     0.6550
## 6823  64C 5.13        64   Gapdh     1.3100
## 6824  64C 5.14        64   Gapdh     1.3900
## 6825  64C 5.15        64   Gapdh     2.4200
## 6826  64C 5.16        64   Gapdh     6.3200
## 6827   64C 6.1        64   Gapdh     1.7850
## 6828   64C 6.2        64   Gapdh     0.4300
## 6829   64C 6.3        64   Gapdh     2.8200
## 6830   64C 6.4        64   Gapdh     3.7700
## 6831   64C 6.5        64   Gapdh     1.4900
## 6832   64C 6.6        64   Gapdh    -1.0650
## 6833   64C 6.7        64   Gapdh     0.3900
## 6834   64C 6.8        64   Gapdh     2.6300
## 6835   64C 7.1        64   Gapdh     5.1050
## 6836   64C 7.2        64   Gapdh     2.6600
## 6837   64C 7.3        64   Gapdh     4.2450
## 6838   64C 7.4        64   Gapdh     2.8400
## 6839   64C 7.5        64   Gapdh     2.0300
## 6840   64C 7.6        64   Gapdh     1.9450
## 6841   64C 7.7        64   Gapdh     0.7450
## 6842   64C 7.8        64   Gapdh    -0.8450
## 6843   64C 7.9        64   Gapdh     0.2900
## 6844  64C 7.10        64   Gapdh     3.7800
## 6845  64C 7.11        64   Gapdh     2.3850
## 6846  64C 7.12        64   Gapdh     2.6050
## 6847  64C 7.13        64   Gapdh     3.1300
## 6848  64C 7.14        64   Gapdh     1.5300
## 6849    2C 1.1         2   Gata3     5.0900
## 6850    2C 1.2         2   Gata3     4.3150
## 6851    2C 2.1         2   Gata3     5.8400
## 6852    2C 2.2         2   Gata3     6.5050
## 6853    2C 3.1         2   Gata3     6.8800
## 6854    2C 3.2         2   Gata3     5.8225
## 6855    2C 4.1         2   Gata3     8.9850
## 6856    2C 5.1         2   Gata3     5.0450
## 6857    2C 5.2         2   Gata3     5.1250
## 6858    2C 6.1         2   Gata3     4.3650
## 6859    2C 6.2         2   Gata3    11.9300
## 6860    2C 7.1         2   Gata3     6.1850
## 6861    2C 7.2         2   Gata3     8.5050
## 6862    2C 8.1         2   Gata3     7.6150
## 6863    2C 8.2         2   Gata3     6.5350
## 6864    2C 9.1         2   Gata3     8.8550
## 6865    2C 9.2         2   Gata3     5.0400
## 6866   2C 10.1         2   Gata3     5.0050
## 6867   2C 10.2         2   Gata3     3.3700
## 6868    4C 1.1         4   Gata3     5.0350
## 6869    4C 1.2         4   Gata3     2.6250
## 6870    4C 1.3         4   Gata3    12.9000
## 6871    4C 1.4         4   Gata3     6.9050
## 6872    4C 2.1         4   Gata3     5.4150
## 6873    4C 2.2         4   Gata3     6.5450
## 6874    4C 2.3         4   Gata3     5.2450
## 6875    4C 3.1         4   Gata3     4.4100
## 6876    4C 3.2         4   Gata3     3.2950
## 6877    4C 3.3         4   Gata3     3.3450
## 6878    4C 3.4         4   Gata3     2.6650
## 6879    4C 4.1         4   Gata3     4.7400
## 6880    4C 4.2         4   Gata3     6.4550
## 6881    4C 4.3         4   Gata3     6.4300
## 6882    4C 4.4         4   Gata3     7.2000
## 6883    4C 5.1         4   Gata3     6.3350
## 6884    4C 5.2         4   Gata3     5.9750
## 6885    4C 5.3         4   Gata3     1.7200
## 6886    4C 5.4         4   Gata3     3.8100
## 6887    4C 6.1         4   Gata3     4.1850
## 6888    4C 6.2         4   Gata3    13.7700
## 6889    4C 6.3         4   Gata3     5.8750
## 6890    4C 6.4         4   Gata3     5.6350
## 6891    8C 1.1         8   Gata3     6.7250
## 6892    8C 1.2         8   Gata3     6.9050
## 6893    8C 1.3         8   Gata3     3.8450
## 6894    8C 1.4         8   Gata3     3.4400
## 6895    8C 1.5         8   Gata3     2.9600
## 6896    8C 2.1         8   Gata3     2.2450
## 6897    8C 2.2         8   Gata3     4.6950
## 6898    8C 2.3         8   Gata3     6.2650
## 6899    8C 2.4         8   Gata3     4.6550
## 6900    8C 2.5         8   Gata3     5.0150
## 6901    8C 2.6         8   Gata3     4.8700
## 6902    8C 2.7         8   Gata3     3.0500
## 6903    8C 2.8         8   Gata3     5.4850
## 6904    8C 3.1         8   Gata3     5.8950
## 6905    8C 3.2         8   Gata3     6.3300
## 6906    8C 3.3         8   Gata3     7.0700
## 6907    8C 3.4         8   Gata3     6.1750
## 6908    8C 3.5         8   Gata3     4.9100
## 6909    8C 3.6         8   Gata3     9.4900
## 6910    8C 3.7         8   Gata3     6.5350
## 6911    8C 3.8         8   Gata3     5.4000
## 6912    8C 4.2         8   Gata3     4.9900
## 6913    8C 4.3         8   Gata3     4.0450
## 6914    8C 4.4         8   Gata3     3.3300
## 6915    8C 4.5         8   Gata3     5.5800
## 6916    8C 4.6         8   Gata3     6.3800
## 6917    8C 4.7         8   Gata3     5.0200
## 6918    8C 5.1         8   Gata3     4.2900
## 6919    8C 5.2         8   Gata3     4.6500
## 6920    8C 5.3         8   Gata3     4.3850
## 6921    8C 5.4         8   Gata3     3.4650
## 6922    8C 5.5         8   Gata3     5.5800
## 6923    8C 5.6         8   Gata3     4.1700
## 6924    8C 5.7         8   Gata3     6.9700
## 6925    8C 5.8         8   Gata3     5.8050
## 6926    8C 6.1         8   Gata3     6.1950
## 6927    8C 6.2         8   Gata3     9.3450
## 6928    8C 6.3         8   Gata3     8.8250
## 6929    8C 6.4         8   Gata3     6.0500
## 6930    8C 6.5         8   Gata3     4.4350
## 6931    8C 6.6         8   Gata3     5.3450
## 6932    8C 6.7         8   Gata3     4.5200
## 6933    8C 6.8         8   Gata3     7.0600
## 6934   16C 1.1        16   Gata3     3.1050
## 6935   16C 1.2        16   Gata3     4.8050
## 6936   16C 1.3        16   Gata3     3.4250
## 6937   16C 1.4        16   Gata3     3.0650
## 6938   16C 1.5        16   Gata3     0.9200
## 6939   16C 1.6        16   Gata3    -3.4050
## 6940   16C 1.7        16   Gata3     0.9400
## 6941   16C 1.8        16   Gata3     0.2350
## 6942   16C 1.9        16   Gata3     3.3150
## 6943  16C 1.10        16   Gata3     3.8500
## 6944  16C 1.11        16   Gata3     2.5300
## 6945  16C 1.12        16   Gata3     1.9300
## 6946  16C 1.13        16   Gata3     1.7600
## 6947  16C 1.14        16   Gata3     0.4850
## 6948  16C 1.15        16   Gata3     1.9750
## 6949  16C 1.16        16   Gata3     0.1200
## 6950   16C 2.1        16   Gata3     2.0750
## 6951   16C 2.2        16   Gata3     3.1550
## 6952   16C 2.3        16   Gata3     6.2075
## 6953   16C 2.4        16   Gata3     1.9300
## 6954   16C 2.5        16   Gata3     2.2850
## 6955   16C 2.6        16   Gata3     1.9700
## 6956   16C 2.7        16   Gata3     5.3700
## 6957   16C 2.8        16   Gata3     0.8650
## 6958   16C 2.9        16   Gata3     3.2600
## 6959  16C 2.10        16   Gata3     3.9650
## 6960  16C 2.11        16   Gata3     3.0700
## 6961  16C 2.12        16   Gata3     1.0325
## 6962  16C 2.13        16   Gata3     5.3650
## 6963  16C 2.14        16   Gata3     0.4850
## 6964  16C 2.15        16   Gata3     2.4850
## 6965  16C 2.16        16   Gata3    -1.0650
## 6966   16C 3.1        16   Gata3     0.0900
## 6967   16C 3.2        16   Gata3     0.1750
## 6968   16C 3.3        16   Gata3     0.6350
## 6969   16C 3.4        16   Gata3     3.7250
## 6970   16C 3.5        16   Gata3     2.3950
## 6971   16C 3.6        16   Gata3     1.4450
## 6972   16C 3.7        16   Gata3    -0.9300
## 6973   16C 3.8        16   Gata3     0.3650
## 6974   16C 3.9        16   Gata3     0.2400
## 6975  16C 3.10        16   Gata3     0.0550
## 6976  16C 3.11        16   Gata3    -0.8550
## 6977  16C 3.12        16   Gata3     0.5300
## 6978  16C 3.13        16   Gata3     2.5350
## 6979  16C 3.14        16   Gata3     2.9650
## 6980  16C 3.15        16   Gata3     2.0350
## 6981   16C 4.1        16   Gata3     4.5350
## 6982   16C 4.2        16   Gata3     2.6200
## 6983   16C 4.3        16   Gata3    -0.0450
## 6984   16C 4.4        16   Gata3     1.2650
## 6985   16C 4.5        16   Gata3    -0.5050
## 6986   16C 4.6        16   Gata3     3.0300
## 6987   16C 4.7        16   Gata3     2.5050
## 6988   16C 4.8        16   Gata3     1.8100
## 6989   16C 4.9        16   Gata3     6.6200
## 6990  16C 4.10        16   Gata3     2.6350
## 6991  16C 4.11        16   Gata3     2.2450
## 6992  16C 4.12        16   Gata3    -1.2000
## 6993  16C 4.13        16   Gata3     0.4700
## 6994  16C 4.14        16   Gata3    -0.6050
## 6995  16C 4.15        16   Gata3     3.0700
## 6996  16C 4.16        16   Gata3     3.5550
## 6997   16C 5.1        16   Gata3     1.6550
## 6998   16C 5.2        16   Gata3     3.2650
## 6999   16C 5.3        16   Gata3     2.3050
## 7000   16C 5.4        16   Gata3    -0.9250
## 7001   16C 5.5        16   Gata3     0.0700
## 7002   16C 5.6        16   Gata3     2.9900
## 7003   16C 5.7        16   Gata3     1.0750
## 7004   16C 5.8        16   Gata3     2.5950
## 7005   16C 5.9        16   Gata3     3.1750
## 7006  16C 5.10        16   Gata3     1.2050
## 7007  16C 5.11        16   Gata3     0.8750
## 7008  16C 5.12        16   Gata3     5.4600
## 7009   32C 1.1        32   Gata3    -0.4700
## 7010   32C 1.2        32   Gata3     4.7750
## 7011   32C 1.3        32   Gata3    -0.1650
## 7012   32C 1.4        32   Gata3    -1.3200
## 7013   32C 1.5        32   Gata3     6.6700
## 7014   32C 1.6        32   Gata3     5.3250
## 7015   32C 1.7        32   Gata3     1.8600
## 7016   32C 1.8        32   Gata3     6.1800
## 7017   32C 1.9        32   Gata3     6.6550
## 7018  32C 1.10        32   Gata3     4.1100
## 7019  32C 1.11        32   Gata3     0.4900
## 7020  32C 1.12        32   Gata3     0.3950
## 7021  32C 1.13        32   Gata3     2.7700
## 7022  32C 1.14        32   Gata3     1.9300
## 7023  32C 1.15        32   Gata3     6.4200
## 7024  32C 1.16        32   Gata3     7.2800
## 7025  32C 1.17        32   Gata3     6.2500
## 7026  32C 1.18        32   Gata3     6.4600
## 7027  32C 1.19        32   Gata3     4.0950
## 7028  32C 1.20        32   Gata3     3.5050
## 7029  32C 1.21        32   Gata3     6.3600
## 7030   32C 2.1        32   Gata3    -1.4600
## 7031   32C 2.2        32   Gata3     2.1700
## 7032   32C 2.3        32   Gata3     1.5550
## 7033   32C 2.4        32   Gata3     4.6550
## 7034   32C 2.5        32   Gata3     6.2650
## 7035   32C 2.6        32   Gata3     2.8450
## 7036   32C 2.7        32   Gata3    -0.0200
## 7037   32C 2.8        32   Gata3     3.3250
## 7038   32C 2.9        32   Gata3    -1.3350
## 7039  32C 2.10        32   Gata3    -1.0300
## 7040  32C 2.11        32   Gata3     7.4200
## 7041  32C 2.12        32   Gata3     1.6250
## 7042  32C 2.13        32   Gata3     5.0550
## 7043  32C 2.14        32   Gata3     6.4750
## 7044  32C 2.15        32   Gata3     5.8350
## 7045  32C 2.16        32   Gata3     3.0800
## 7046   32C 3.1        32   Gata3    -4.9850
## 7047   32C 3.2        32   Gata3     1.2200
## 7048   32C 3.3        32   Gata3    -0.8050
## 7049   32C 3.4        32   Gata3     2.1350
## 7050   32C 3.5        32   Gata3     2.0700
## 7051   32C 3.6        32   Gata3     7.6000
## 7052   32C 3.7        32   Gata3     7.1900
## 7053   32C 3.8        32   Gata3     5.5100
## 7054   32C 4.1        32   Gata3     0.2050
## 7055   32C 4.2        32   Gata3    -0.1950
## 7056   32C 4.3        32   Gata3     5.1500
## 7057   32C 4.4        32   Gata3     4.5950
## 7058   32C 4.5        32   Gata3     6.5350
## 7059   32C 4.6        32   Gata3     7.6575
## 7060   32C 4.7        32   Gata3     1.8200
## 7061   32C 4.8        32   Gata3     0.1350
## 7062  32C 4.10        32   Gata3    -0.1800
## 7063  32C 4.11        32   Gata3     4.1100
## 7064  32C 4.12        32   Gata3     2.2250
## 7065  32C 4.13        32   Gata3     0.1000
## 7066  32C 4.14        32   Gata3     6.4350
## 7067  32C 4.15        32   Gata3     7.0300
## 7068  32C 4.16        32   Gata3     4.9525
## 7069  32C 4.17        32   Gata3     3.4250
## 7070  32C 4.18        32   Gata3    -0.3550
## 7071  32C 4.19        32   Gata3    -0.7050
## 7072  32C 4.20        32   Gata3     1.4650
## 7073  32C 4.21        32   Gata3     4.9600
## 7074  32C 4.22        32   Gata3     5.3050
## 7075  32C 4.23        32   Gata3     0.3950
## 7076  32C 4.24        32   Gata3     9.1650
## 7077   32C 5.1        32   Gata3    -0.2950
## 7078   32C 5.2        32   Gata3     1.1950
## 7079   32C 5.3        32   Gata3     2.4800
## 7080   32C 5.4        32   Gata3    -1.4850
## 7081   32C 5.5        32   Gata3     2.1500
## 7082   32C 5.6        32   Gata3     0.1450
## 7083   32C 5.7        32   Gata3    -2.5850
## 7084   32C 5.8        32   Gata3     6.2200
## 7085   32C 5.9        32   Gata3     0.9150
## 7086  32C 5.10        32   Gata3     6.3650
## 7087  32C 5.11        32   Gata3     1.8450
## 7088  32C 5.12        32   Gata3     4.3350
## 7089  32C 5.13        32   Gata3    -0.5000
## 7090  32C 5.14        32   Gata3    -2.3150
## 7091  32C 5.15        32   Gata3    -0.9350
## 7092  32C 5.16        32   Gata3    -3.1350
## 7093  32C 5.17        32   Gata3    -0.3600
## 7094  32C 5.18        32   Gata3     0.9050
## 7095  32C 5.19        32   Gata3     6.1000
## 7096  32C 5.20        32   Gata3     3.4600
## 7097  32C 5.21        32   Gata3     1.7150
## 7098  32C 5.22        32   Gata3     0.9550
## 7099  32C 5.23        32   Gata3    -2.8400
## 7100   32C 6.1        32   Gata3     4.0900
## 7101   32C 6.2        32   Gata3    -2.2100
## 7102   32C 6.3        32   Gata3     1.6850
## 7103   32C 6.4        32   Gata3     5.0750
## 7104   32C 6.6        32   Gata3     0.3250
## 7105   32C 6.7        32   Gata3     2.9750
## 7106   32C 7.1        32   Gata3     1.6200
## 7107   32C 7.2        32   Gata3    -0.6050
## 7108   32C 7.3        32   Gata3    -0.8600
## 7109   32C 7.4        32   Gata3    -0.3400
## 7110   32C 7.5        32   Gata3     4.6400
## 7111   32C 7.6        32   Gata3     5.7400
## 7112   32C 7.8        32   Gata3     3.3550
## 7113   32C 8.1        32   Gata3     1.2350
## 7114   32C 8.2        32   Gata3     1.2050
## 7115   32C 8.4        32   Gata3     3.5350
## 7116   32C 8.5        32   Gata3     4.0950
## 7117   32C 8.6        32   Gata3    -0.8050
## 7118   64C 1.1        64   Gata3     4.4850
## 7119   64C 1.2        64   Gata3     0.0400
## 7120   64C 1.3        64   Gata3     7.7600
## 7121   64C 1.4        64   Gata3     5.1750
## 7122   64C 1.5        64   Gata3     5.1100
## 7123   64C 1.6        64   Gata3     5.5200
## 7124   64C 1.7        64   Gata3     4.6950
## 7125   64C 1.8        64   Gata3     1.7500
## 7126   64C 1.9        64   Gata3     4.4900
## 7127  64C 1.10        64   Gata3     1.5750
## 7128  64C 1.11        64   Gata3     3.8800
## 7129  64C 1.12        64   Gata3     2.8600
## 7130  64C 1.13        64   Gata3     7.0300
## 7131  64C 1.14        64   Gata3     3.6700
## 7132  64C 1.15        64   Gata3     2.8400
## 7133  64C 1.16        64   Gata3     2.3900
## 7134  64C 1.17        64   Gata3     0.7950
## 7135  64C 1.18        64   Gata3     0.7450
## 7136  64C 1.19        64   Gata3     1.6600
## 7137  64C 1.20        64   Gata3     0.0900
## 7138  64C 1.21        64   Gata3     8.5000
## 7139  64C 1.22        64   Gata3     7.4950
## 7140  64C 1.23        64   Gata3     5.1250
## 7141  64C 1.24        64   Gata3     3.1850
## 7142  64C 1.25        64   Gata3     2.8750
## 7143  64C 1.26        64   Gata3     4.3800
## 7144  64C 1.27        64   Gata3    -0.1350
## 7145  64C 1.28        64   Gata3     0.4450
## 7146  64C 1.29        64   Gata3     0.6000
## 7147  64C 1.30        64   Gata3     3.9000
## 7148  64C 1.31        64   Gata3     1.5750
## 7149  64C 1.32        64   Gata3     1.7050
## 7150  64C 1.33        64   Gata3     2.0650
## 7151  64C 1.34        64   Gata3     5.3750
## 7152  64C 1.35        64   Gata3    -0.5300
## 7153  64C 1.36        64   Gata3    -4.1450
## 7154  64C 1.37        64   Gata3     1.6500
## 7155  64C 1.38        64   Gata3     0.2950
## 7156  64C 1.39        64   Gata3     3.5150
## 7157  64C 1.40        64   Gata3     6.2900
## 7158  64C 1.41        64   Gata3     6.4000
## 7159  64C 1.42        64   Gata3     5.0900
## 7160  64C 1.43        64   Gata3     4.9400
## 7161  64C 1.44        64   Gata3     1.6050
## 7162  64C 1.45        64   Gata3     1.6550
## 7163  64C 1.46        64   Gata3    -0.6700
## 7164  64C 1.47        64   Gata3     0.6450
## 7165  64C 1.48        64   Gata3     2.2350
## 7166   64C 2.1        64   Gata3     4.0175
## 7167   64C 2.2        64   Gata3     0.8000
## 7168   64C 2.3        64   Gata3     2.3050
## 7169   64C 2.4        64   Gata3     0.8000
## 7170   64C 2.5        64   Gata3     4.6000
## 7171   64C 2.6        64   Gata3     2.2350
## 7172   64C 2.7        64   Gata3     6.4500
## 7173   64C 2.8        64   Gata3     4.5050
## 7174   64C 2.9        64   Gata3     1.2100
## 7175  64C 2.10        64   Gata3     0.6025
## 7176  64C 2.11        64   Gata3     3.0050
## 7177  64C 2.12        64   Gata3     0.0350
## 7178  64C 2.13        64   Gata3     1.6350
## 7179  64C 2.14        64   Gata3    -2.6250
## 7180  64C 2.15        64   Gata3    -0.2400
## 7181  64C 2.16        64   Gata3     3.2950
## 7182  64C 2.17        64   Gata3     6.0550
## 7183  64C 2.18        64   Gata3     1.1450
## 7184  64C 2.19        64   Gata3     1.3450
## 7185  64C 2.20        64   Gata3     1.6750
## 7186  64C 2.21        64   Gata3     0.2000
## 7187  64C 2.22        64   Gata3    -0.0750
## 7188  64C 2.23        64   Gata3    -0.4700
## 7189  64C 2.24        64   Gata3    -0.4350
## 7190  64C 2.25        64   Gata3    -0.4850
## 7191   64C 3.1        64   Gata3     2.3600
## 7192   64C 3.2        64   Gata3     2.5550
## 7193   64C 3.3        64   Gata3     1.3850
## 7194   64C 3.4        64   Gata3     2.1450
## 7195   64C 3.5        64   Gata3     3.8050
## 7196   64C 3.6        64   Gata3     2.0300
## 7197   64C 3.7        64   Gata3    -0.7750
## 7198   64C 3.8        64   Gata3     0.4750
## 7199   64C 4.1        64   Gata3     3.3650
## 7200  64C 4.1b        64   Gata3     7.1800
## 7201   64C 4.2        64   Gata3    13.3750
## 7202   64C 4.3        64   Gata3     6.5000
## 7203   64C 4.4        64   Gata3     8.0600
## 7204   64C 4.5        64   Gata3     4.7350
## 7205   64C 4.6        64   Gata3     4.9850
## 7206   64C 4.7        64   Gata3    -2.7900
## 7207   64C 4.8        64   Gata3     5.3400
## 7208   64C 4.9        64   Gata3    -1.0950
## 7209  64C 4.10        64   Gata3     6.7600
## 7210  64C 4.11        64   Gata3    13.2950
## 7211  64C 4.12        64   Gata3     0.5450
## 7212  64C 4.13        64   Gata3     1.1050
## 7213  64C 4.14        64   Gata3     2.2350
## 7214  64C 4.15        64   Gata3    -0.5250
## 7215  64C 4.16        64   Gata3    -0.0400
## 7216  64C 4.17        64   Gata3     0.3600
## 7217  64C 4.18        64   Gata3    -0.8450
## 7218  64C 4.19        64   Gata3     0.1450
## 7219  64C 4.20        64   Gata3     1.7550
## 7220  64C 4.21        64   Gata3     0.9550
## 7221  64C 4.22        64   Gata3     0.0150
## 7222  64C 4.23        64   Gata3     1.2000
## 7223  64C 4.24        64   Gata3     1.2100
## 7224  64C 4.25        64   Gata3     0.1850
## 7225  64C 4.26        64   Gata3     5.8650
## 7226  64C 4.27        64   Gata3    -1.2000
## 7227  64C 4.28        64   Gata3     7.7700
## 7228  64C 4.29        64   Gata3    -0.0050
## 7229  64C 4.30        64   Gata3     6.1000
## 7230  64C 4.31        64   Gata3     1.9700
## 7231  64C 4.32        64   Gata3     6.6450
## 7232  64C 4.33        64   Gata3     1.0400
## 7233  64C 4.34        64   Gata3    -0.9600
## 7234  64C 4.35        64   Gata3     4.6450
## 7235  64C 4.36        64   Gata3    -0.8500
## 7236  64C 4.37        64   Gata3     1.0600
## 7237  64C 4.38        64   Gata3     1.2900
## 7238  64C 4.39        64   Gata3     3.0100
## 7239   64C 5.1        64   Gata3     1.1700
## 7240   64C 5.2        64   Gata3    13.1200
## 7241   64C 5.3        64   Gata3     5.5950
## 7242   64C 5.4        64   Gata3     0.2650
## 7243   64C 5.5        64   Gata3     7.1000
## 7244   64C 5.6        64   Gata3     3.1300
## 7245   64C 5.7        64   Gata3     8.2200
## 7246   64C 5.8        64   Gata3     7.8650
## 7247   64C 5.9        64   Gata3     6.1150
## 7248  64C 5.10        64   Gata3     7.3550
## 7249  64C 5.11        64   Gata3     0.9850
## 7250  64C 5.12        64   Gata3    -1.3900
## 7251  64C 5.13        64   Gata3    -0.5750
## 7252  64C 5.14        64   Gata3    -1.2750
## 7253  64C 5.15        64   Gata3     1.3200
## 7254  64C 5.16        64   Gata3     3.7500
## 7255   64C 6.1        64   Gata3     6.5950
## 7256   64C 6.2        64   Gata3     5.5450
## 7257   64C 6.3        64   Gata3     5.7450
## 7258   64C 6.4        64   Gata3    12.1650
## 7259   64C 6.5        64   Gata3     8.3000
## 7260   64C 6.6        64   Gata3     0.8550
## 7261   64C 6.7        64   Gata3    12.5600
## 7262   64C 6.8        64   Gata3     6.3150
## 7263   64C 7.1        64   Gata3     7.6750
## 7264   64C 7.2        64   Gata3     6.3800
## 7265   64C 7.3        64   Gata3     7.8300
## 7266   64C 7.4        64   Gata3    13.4700
## 7267   64C 7.5        64   Gata3     5.9700
## 7268   64C 7.6        64   Gata3     4.9550
## 7269   64C 7.7        64   Gata3    10.9550
## 7270   64C 7.8        64   Gata3    11.2100
## 7271   64C 7.9        64   Gata3     3.3050
## 7272  64C 7.10        64   Gata3     2.0350
## 7273  64C 7.11        64   Gata3     4.0575
## 7274  64C 7.12        64   Gata3     2.3000
## 7275  64C 7.13        64   Gata3     1.2250
## 7276  64C 7.14        64   Gata3     0.1700
## 7277    2C 1.1         2   Gata4    -3.5050
## 7278    2C 1.2         2   Gata4    -4.6950
## 7279    2C 2.1         2   Gata4     0.5600
## 7280    2C 2.2         2   Gata4     0.2300
## 7281    2C 3.1         2   Gata4    -0.6350
## 7282    2C 3.2         2   Gata4    -0.6975
## 7283    2C 4.1         2   Gata4     1.1000
## 7284    2C 5.1         2   Gata4    -2.5500
## 7285    2C 5.2         2   Gata4    -1.2950
## 7286    2C 6.1         2   Gata4    -3.3250
## 7287    2C 6.2         2   Gata4    -1.5650
## 7288    2C 7.1         2   Gata4    -3.9400
## 7289    2C 7.2         2   Gata4    -0.9500
## 7290    2C 8.1         2   Gata4    -0.3650
## 7291    2C 8.2         2   Gata4    -2.1700
## 7292    2C 9.1         2   Gata4    -1.5000
## 7293    2C 9.2         2   Gata4    -0.9250
## 7294   2C 10.1         2   Gata4    -4.9250
## 7295   2C 10.2         2   Gata4    -3.7850
## 7296    4C 1.1         4   Gata4     0.0850
## 7297    4C 1.2         4   Gata4    -0.6500
## 7298    4C 1.3         4   Gata4    -0.2800
## 7299    4C 1.4         4   Gata4     0.7500
## 7300    4C 2.1         4   Gata4    -0.1500
## 7301    4C 2.2         4   Gata4     0.6700
## 7302    4C 2.3         4   Gata4    -1.1150
## 7303    4C 3.1         4   Gata4    -0.6400
## 7304    4C 3.2         4   Gata4    -2.4250
## 7305    4C 3.3         4   Gata4    -2.0750
## 7306    4C 3.4         4   Gata4    -2.9700
## 7307    4C 4.1         4   Gata4     1.4550
## 7308    4C 4.2         4   Gata4     0.2200
## 7309    4C 4.3         4   Gata4    -0.2100
## 7310    4C 4.4         4   Gata4     1.6900
## 7311    4C 5.1         4   Gata4     0.7850
## 7312    4C 5.2         4   Gata4     0.0600
## 7313    4C 5.3         4   Gata4    -3.0600
## 7314    4C 5.4         4   Gata4    -0.3450
## 7315    4C 6.1         4   Gata4    -1.1050
## 7316    4C 6.2         4   Gata4     0.7000
## 7317    4C 6.3         4   Gata4     2.0050
## 7318    4C 6.4         4   Gata4     0.5900
## 7319    8C 1.1         8   Gata4     4.5550
## 7320    8C 1.2         8   Gata4     4.8900
## 7321    8C 1.3         8   Gata4     2.1350
## 7322    8C 1.4         8   Gata4     1.0250
## 7323    8C 1.5         8   Gata4     0.1650
## 7324    8C 2.1         8   Gata4     1.8850
## 7325    8C 2.2         8   Gata4     5.6950
## 7326    8C 2.3         8   Gata4     2.9150
## 7327    8C 2.4         8   Gata4     4.3550
## 7328    8C 2.5         8   Gata4     6.7300
## 7329    8C 2.6         8   Gata4     3.4250
## 7330    8C 2.7         8   Gata4     0.9450
## 7331    8C 2.8         8   Gata4     2.4450
## 7332    8C 3.1         8   Gata4     0.8200
## 7333    8C 3.2         8   Gata4     3.3550
## 7334    8C 3.3         8   Gata4     2.0500
## 7335    8C 3.4         8   Gata4     0.9000
## 7336    8C 3.5         8   Gata4    -0.9600
## 7337    8C 3.6         8   Gata4     1.7100
## 7338    8C 3.7         8   Gata4     1.7300
## 7339    8C 3.8         8   Gata4     0.6150
## 7340    8C 4.2         8   Gata4     4.9450
## 7341    8C 4.3         8   Gata4     0.2850
## 7342    8C 4.4         8   Gata4     2.3350
## 7343    8C 4.5         8   Gata4     7.8900
## 7344    8C 4.6         8   Gata4     1.2750
## 7345    8C 4.7         8   Gata4     1.6650
## 7346    8C 5.1         8   Gata4    -1.3300
## 7347    8C 5.2         8   Gata4     2.2700
## 7348    8C 5.3         8   Gata4    -1.3350
## 7349    8C 5.4         8   Gata4    -0.3650
## 7350    8C 5.5         8   Gata4     0.6500
## 7351    8C 5.6         8   Gata4    -0.2900
## 7352    8C 5.7         8   Gata4     0.8950
## 7353    8C 5.8         8   Gata4     2.0250
## 7354    8C 6.1         8   Gata4     1.1550
## 7355    8C 6.2         8   Gata4     2.6300
## 7356    8C 6.3         8   Gata4     1.4650
## 7357    8C 6.4         8   Gata4     0.4150
## 7358    8C 6.5         8   Gata4    -0.0200
## 7359    8C 6.6         8   Gata4    -0.5500
## 7360    8C 6.7         8   Gata4    -0.3750
## 7361    8C 6.8         8   Gata4     3.0350
## 7362   16C 1.1        16   Gata4    14.1800
## 7363   16C 1.2        16   Gata4     5.8000
## 7364   16C 1.3        16   Gata4     7.6800
## 7365   16C 1.4        16   Gata4     7.7600
## 7366   16C 1.5        16   Gata4     5.0450
## 7367   16C 1.6        16   Gata4     5.7950
## 7368   16C 1.7        16   Gata4     4.6650
## 7369   16C 1.8        16   Gata4     3.8950
## 7370   16C 1.9        16   Gata4     5.1550
## 7371  16C 1.10        16   Gata4     4.8150
## 7372  16C 1.11        16   Gata4     8.4200
## 7373  16C 1.12        16   Gata4     6.8950
## 7374  16C 1.13        16   Gata4     4.5200
## 7375  16C 1.14        16   Gata4     2.2500
## 7376  16C 1.15        16   Gata4     3.1650
## 7377  16C 1.16        16   Gata4     6.4600
## 7378   16C 2.1        16   Gata4     6.4500
## 7379   16C 2.2        16   Gata4     9.9500
## 7380   16C 2.3        16   Gata4     7.0950
## 7381   16C 2.4        16   Gata4    10.8600
## 7382   16C 2.5        16   Gata4     5.0000
## 7383   16C 2.6        16   Gata4     4.6900
## 7384   16C 2.7        16   Gata4     2.6550
## 7385   16C 2.8        16   Gata4     1.0350
## 7386   16C 2.9        16   Gata4    12.5800
## 7387  16C 2.10        16   Gata4     5.1700
## 7388  16C 2.11        16   Gata4     4.2150
## 7389  16C 2.12        16   Gata4     6.1925
## 7390  16C 2.13        16   Gata4     6.7900
## 7391  16C 2.14        16   Gata4     3.6000
## 7392  16C 2.15        16   Gata4     5.6650
## 7393  16C 2.16        16   Gata4     2.5850
## 7394   16C 3.1        16   Gata4     4.2450
## 7395   16C 3.2        16   Gata4     6.0100
## 7396   16C 3.3        16   Gata4     6.8800
## 7397   16C 3.4        16   Gata4     6.8450
## 7398   16C 3.5        16   Gata4     3.7900
## 7399   16C 3.6        16   Gata4     6.7800
## 7400   16C 3.7        16   Gata4     7.6450
## 7401   16C 3.8        16   Gata4     9.2550
## 7402   16C 3.9        16   Gata4     3.9350
## 7403  16C 3.10        16   Gata4     7.3150
## 7404  16C 3.11        16   Gata4     4.2800
## 7405  16C 3.12        16   Gata4    13.0100
## 7406  16C 3.13        16   Gata4     9.6200
## 7407  16C 3.14        16   Gata4     5.4600
## 7408  16C 3.15        16   Gata4     5.4600
## 7409   16C 4.1        16   Gata4     3.7250
## 7410   16C 4.2        16   Gata4     2.4000
## 7411   16C 4.3        16   Gata4     3.0350
## 7412   16C 4.4        16   Gata4     4.0850
## 7413   16C 4.5        16   Gata4     1.7400
## 7414   16C 4.6        16   Gata4     5.3050
## 7415   16C 4.7        16   Gata4     6.7800
## 7416   16C 4.8        16   Gata4     6.8000
## 7417   16C 4.9        16   Gata4    14.8300
## 7418  16C 4.10        16   Gata4     4.4850
## 7419  16C 4.11        16   Gata4     5.1400
## 7420  16C 4.12        16   Gata4     0.9100
## 7421  16C 4.13        16   Gata4     3.7350
## 7422  16C 4.14        16   Gata4     5.5850
## 7423  16C 4.15        16   Gata4     7.3000
## 7424  16C 4.16        16   Gata4     6.3950
## 7425   16C 5.1        16   Gata4     6.7100
## 7426   16C 5.2        16   Gata4     5.7150
## 7427   16C 5.3        16   Gata4     7.3400
## 7428   16C 5.4        16   Gata4     5.0350
## 7429   16C 5.5        16   Gata4     2.8250
## 7430   16C 5.6        16   Gata4     5.0150
## 7431   16C 5.7        16   Gata4     4.0250
## 7432   16C 5.8        16   Gata4    15.2850
## 7433   16C 5.9        16   Gata4     8.2750
## 7434  16C 5.10        16   Gata4     4.5250
## 7435  16C 5.11        16   Gata4     7.6900
## 7436  16C 5.12        16   Gata4     6.0650
## 7437   32C 1.1        32   Gata4    11.9550
## 7438   32C 1.2        32   Gata4     5.7850
## 7439   32C 1.3        32   Gata4    12.4100
## 7440   32C 1.4        32   Gata4    12.4750
## 7441   32C 1.5        32   Gata4    13.4600
## 7442   32C 1.6        32   Gata4     5.6300
## 7443   32C 1.7        32   Gata4    11.5100
## 7444   32C 1.8        32   Gata4     7.3500
## 7445   32C 1.9        32   Gata4     7.7400
## 7446  32C 1.10        32   Gata4     0.9750
## 7447  32C 1.11        32   Gata4    11.4450
## 7448  32C 1.12        32   Gata4    12.3950
## 7449  32C 1.13        32   Gata4     1.6550
## 7450  32C 1.14        32   Gata4    14.2400
## 7451  32C 1.15        32   Gata4     9.7250
## 7452  32C 1.16        32   Gata4    13.4350
## 7453  32C 1.17        32   Gata4    -0.0600
## 7454  32C 1.18        32   Gata4     8.5200
## 7455  32C 1.19        32   Gata4     5.2550
## 7456  32C 1.20        32   Gata4     1.6750
## 7457  32C 1.21        32   Gata4    12.6600
## 7458   32C 2.1        32   Gata4     9.5600
## 7459   32C 2.2        32   Gata4    13.2150
## 7460   32C 2.3        32   Gata4    10.1850
## 7461   32C 2.4        32   Gata4     6.0550
## 7462   32C 2.5        32   Gata4    13.1700
## 7463   32C 2.6        32   Gata4     7.2050
## 7464   32C 2.7        32   Gata4    11.6550
## 7465   32C 2.8        32   Gata4    11.2700
## 7466   32C 2.9        32   Gata4    11.3700
## 7467  32C 2.10        32   Gata4     7.2250
## 7468  32C 2.11        32   Gata4     6.3850
## 7469  32C 2.12        32   Gata4    14.1800
## 7470  32C 2.13        32   Gata4    13.3900
## 7471  32C 2.14        32   Gata4    13.9800
## 7472  32C 2.15        32   Gata4     4.6100
## 7473  32C 2.16        32   Gata4     5.3250
## 7474   32C 3.1        32   Gata4    10.4750
## 7475   32C 3.2        32   Gata4    12.1450
## 7476   32C 3.3        32   Gata4    10.5250
## 7477   32C 3.4        32   Gata4    13.5550
## 7478   32C 3.5        32   Gata4    10.1850
## 7479   32C 3.6        32   Gata4     7.2300
## 7480   32C 3.7        32   Gata4     6.0750
## 7481   32C 3.8        32   Gata4    12.7900
## 7482   32C 4.1        32   Gata4    11.2700
## 7483   32C 4.2        32   Gata4    10.7750
## 7484   32C 4.3        32   Gata4     6.1300
## 7485   32C 4.4        32   Gata4     2.8100
## 7486   32C 4.5        32   Gata4     4.7900
## 7487   32C 4.6        32   Gata4    13.7850
## 7488   32C 4.7        32   Gata4    13.4000
## 7489   32C 4.8        32   Gata4    13.2600
## 7490  32C 4.10        32   Gata4    11.9000
## 7491  32C 4.11        32   Gata4    10.9850
## 7492  32C 4.12        32   Gata4     9.6150
## 7493  32C 4.13        32   Gata4    12.5800
## 7494  32C 4.14        32   Gata4    12.3000
## 7495  32C 4.15        32   Gata4     6.8250
## 7496  32C 4.16        32   Gata4     2.7225
## 7497  32C 4.17        32   Gata4    13.8100
## 7498  32C 4.18        32   Gata4    11.9800
## 7499  32C 4.19        32   Gata4     8.7350
## 7500  32C 4.20        32   Gata4     5.9150
## 7501  32C 4.21        32   Gata4     5.2150
## 7502  32C 4.22        32   Gata4     6.0200
## 7503  32C 4.23        32   Gata4     8.4200
## 7504  32C 4.24        32   Gata4     9.0250
## 7505   32C 5.1        32   Gata4     8.7200
## 7506   32C 5.2        32   Gata4    12.9800
## 7507   32C 5.3        32   Gata4     8.7250
## 7508   32C 5.4        32   Gata4     9.2550
## 7509   32C 5.5        32   Gata4    10.2250
## 7510   32C 5.6        32   Gata4    12.6350
## 7511   32C 5.7        32   Gata4    10.8400
## 7512   32C 5.8        32   Gata4     4.9100
## 7513   32C 5.9        32   Gata4    13.7200
## 7514  32C 5.10        32   Gata4     8.1700
## 7515  32C 5.11        32   Gata4     8.1500
## 7516  32C 5.12        32   Gata4     5.4750
## 7517  32C 5.13        32   Gata4    11.8900
## 7518  32C 5.14        32   Gata4     5.4450
## 7519  32C 5.15        32   Gata4    11.3150
## 7520  32C 5.16        32   Gata4     3.5400
## 7521  32C 5.17        32   Gata4    14.7350
## 7522  32C 5.18        32   Gata4     7.7900
## 7523  32C 5.19        32   Gata4     8.9200
## 7524  32C 5.20        32   Gata4    14.8300
## 7525  32C 5.21        32   Gata4    12.7150
## 7526  32C 5.22        32   Gata4     6.1100
## 7527  32C 5.23        32   Gata4     9.2200
## 7528   32C 6.1        32   Gata4     4.0200
## 7529   32C 6.2        32   Gata4     7.0250
## 7530   32C 6.3        32   Gata4     7.9250
## 7531   32C 6.4        32   Gata4    14.2750
## 7532   32C 6.6        32   Gata4     8.6850
## 7533   32C 6.7        32   Gata4    13.2150
## 7534   32C 7.1        32   Gata4    14.4400
## 7535   32C 7.2        32   Gata4     6.8450
## 7536   32C 7.3        32   Gata4    11.0450
## 7537   32C 7.4        32   Gata4     9.8950
## 7538   32C 7.5        32   Gata4     5.2350
## 7539   32C 7.6        32   Gata4     6.5950
## 7540   32C 7.8        32   Gata4    13.8650
## 7541   32C 8.1        32   Gata4    12.3750
## 7542   32C 8.2        32   Gata4    14.8800
## 7543   32C 8.4        32   Gata4     5.4500
## 7544   32C 8.5        32   Gata4     6.3450
## 7545   32C 8.6        32   Gata4    12.0850
## 7546   64C 1.1        64   Gata4    -0.5300
## 7547   64C 1.2        64   Gata4     7.7250
## 7548   64C 1.3        64   Gata4     8.9200
## 7549   64C 1.4        64   Gata4     0.6900
## 7550   64C 1.5        64   Gata4    -1.7000
## 7551   64C 1.6        64   Gata4     7.5700
## 7552   64C 1.7        64   Gata4     1.3400
## 7553   64C 1.8        64   Gata4    13.2950
## 7554   64C 1.9        64   Gata4    -0.8650
## 7555  64C 1.10        64   Gata4    12.3950
## 7556  64C 1.11        64   Gata4    -0.9950
## 7557  64C 1.12        64   Gata4    14.2400
## 7558  64C 1.13        64   Gata4    -0.2450
## 7559  64C 1.14        64   Gata4    13.4350
## 7560  64C 1.15        64   Gata4     9.9600
## 7561  64C 1.16        64   Gata4    13.8600
## 7562  64C 1.17        64   Gata4    11.5150
## 7563  64C 1.18        64   Gata4    11.6750
## 7564  64C 1.19        64   Gata4    12.6600
## 7565  64C 1.20        64   Gata4    11.7300
## 7566  64C 1.21        64   Gata4     3.6950
## 7567  64C 1.22        64   Gata4     6.7250
## 7568  64C 1.23        64   Gata4    12.7650
## 7569  64C 1.24        64   Gata4    13.1700
## 7570  64C 1.25        64   Gata4    13.7550
## 7571  64C 1.26        64   Gata4    -0.1950
## 7572  64C 1.27        64   Gata4    11.2700
## 7573  64C 1.28        64   Gata4    11.3700
## 7574  64C 1.29        64   Gata4    11.2450
## 7575  64C 1.30        64   Gata4    14.8150
## 7576  64C 1.31        64   Gata4    14.1800
## 7577  64C 1.32        64   Gata4    13.3900
## 7578  64C 1.33        64   Gata4    13.9800
## 7579  64C 1.34        64   Gata4    13.1900
## 7580  64C 1.35        64   Gata4    11.6950
## 7581  64C 1.36        64   Gata4    10.4750
## 7582  64C 1.37        64   Gata4    12.1450
## 7583  64C 1.38        64   Gata4    10.5250
## 7584  64C 1.39        64   Gata4    13.5550
## 7585  64C 1.40        64   Gata4     6.5350
## 7586  64C 1.41        64   Gata4     1.6400
## 7587  64C 1.42        64   Gata4     0.0350
## 7588  64C 1.43        64   Gata4     1.3400
## 7589  64C 1.44        64   Gata4    11.2700
## 7590  64C 1.45        64   Gata4    10.7750
## 7591  64C 1.46        64   Gata4    11.6800
## 7592  64C 1.47        64   Gata4    11.8100
## 7593  64C 1.48        64   Gata4    14.4400
## 7594   64C 2.1        64   Gata4    13.7850
## 7595   64C 2.2        64   Gata4    13.4000
## 7596   64C 2.3        64   Gata4    13.2600
## 7597   64C 2.4        64   Gata4    11.9000
## 7598   64C 2.5        64   Gata4    -1.4750
## 7599   64C 2.6        64   Gata4     9.6150
## 7600   64C 2.7        64   Gata4     2.0600
## 7601   64C 2.8        64   Gata4     5.2100
## 7602   64C 2.9        64   Gata4    13.1150
## 7603  64C 2.10        64   Gata4    13.6125
## 7604  64C 2.11        64   Gata4    13.8100
## 7605  64C 2.12        64   Gata4    11.9800
## 7606  64C 2.13        64   Gata4    12.8450
## 7607  64C 2.14        64   Gata4    10.6250
## 7608  64C 2.15        64   Gata4    12.3050
## 7609  64C 2.16        64   Gata4    -0.9900
## 7610  64C 2.17        64   Gata4     3.8100
## 7611  64C 2.18        64   Gata4    14.1050
## 7612  64C 2.19        64   Gata4    12.3100
## 7613  64C 2.20        64   Gata4    12.9800
## 7614  64C 2.21        64   Gata4    13.5250
## 7615  64C 2.22        64   Gata4     9.2550
## 7616  64C 2.23        64   Gata4    10.2250
## 7617  64C 2.24        64   Gata4    12.6350
## 7618  64C 2.25        64   Gata4    10.8400
## 7619   64C 3.1        64   Gata4    13.0100
## 7620   64C 3.2        64   Gata4    13.7200
## 7621   64C 3.3        64   Gata4    12.7400
## 7622   64C 3.4        64   Gata4    13.5000
## 7623   64C 3.5        64   Gata4    -0.3150
## 7624   64C 3.6        64   Gata4    11.8900
## 7625   64C 3.7        64   Gata4     9.5050
## 7626   64C 3.8        64   Gata4    11.3150
## 7627   64C 4.1        64   Gata4    -2.5600
## 7628  64C 4.1b        64   Gata4    11.1150
## 7629   64C 4.2        64   Gata4     7.7600
## 7630   64C 4.3        64   Gata4     2.9600
## 7631   64C 4.4        64   Gata4     6.2300
## 7632   64C 4.5        64   Gata4     3.6750
## 7633   64C 4.6        64   Gata4     1.1300
## 7634   64C 4.7        64   Gata4     9.2200
## 7635   64C 4.8        64   Gata4     1.0150
## 7636   64C 4.9        64   Gata4    11.0750
## 7637  64C 4.10        64   Gata4     7.0500
## 7638  64C 4.11        64   Gata4     9.0650
## 7639  64C 4.12        64   Gata4    12.7800
## 7640  64C 4.13        64   Gata4    13.2150
## 7641  64C 4.14        64   Gata4    14.4400
## 7642  64C 4.15        64   Gata4    11.8250
## 7643  64C 4.16        64   Gata4    11.0450
## 7644  64C 4.17        64   Gata4     9.8950
## 7645  64C 4.18        64   Gata4     8.9550
## 7646  64C 4.19        64   Gata4    15.2850
## 7647  64C 4.20        64   Gata4    13.8650
## 7648  64C 4.21        64   Gata4    12.3750
## 7649  64C 4.22        64   Gata4    14.8800
## 7650  64C 4.23        64   Gata4    13.5150
## 7651  64C 4.24        64   Gata4    11.9550
## 7652  64C 4.25        64   Gata4    12.0850
## 7653  64C 4.26        64   Gata4    -0.0900
## 7654  64C 4.27        64   Gata4    12.4750
## 7655  64C 4.28        64   Gata4     2.9400
## 7656  64C 4.29        64   Gata4    13.4100
## 7657  64C 4.30        64   Gata4    -1.0300
## 7658  64C 4.31        64   Gata4    13.9100
## 7659  64C 4.32        64   Gata4     8.5100
## 7660  64C 4.33        64   Gata4    13.2950
## 7661  64C 4.34        64   Gata4    11.4450
## 7662  64C 4.35        64   Gata4     0.0650
## 7663  64C 4.36        64   Gata4    11.3550
## 7664  64C 4.37        64   Gata4    14.2400
## 7665  64C 4.38        64   Gata4    12.6150
## 7666  64C 4.39        64   Gata4    13.4350
## 7667   64C 5.1        64   Gata4     9.9600
## 7668   64C 5.2        64   Gata4     2.2400
## 7669   64C 5.3        64   Gata4    -0.7650
## 7670   64C 5.4        64   Gata4    11.6750
## 7671   64C 5.5        64   Gata4     1.5700
## 7672   64C 5.6        64   Gata4     0.7300
## 7673   64C 5.7        64   Gata4     1.4150
## 7674   64C 5.8        64   Gata4    13.8250
## 7675   64C 5.9        64   Gata4     1.4850
## 7676  64C 5.10        64   Gata4     1.3500
## 7677  64C 5.11        64   Gata4    13.7550
## 7678  64C 5.12        64   Gata4    11.6550
## 7679  64C 5.13        64   Gata4    11.2700
## 7680  64C 5.14        64   Gata4    11.3700
## 7681  64C 5.15        64   Gata4    11.2450
## 7682  64C 5.16        64   Gata4    14.8150
## 7683   64C 6.1        64   Gata4     1.7500
## 7684   64C 6.2        64   Gata4     8.1400
## 7685   64C 6.3        64   Gata4    13.9800
## 7686   64C 6.4        64   Gata4    13.1900
## 7687   64C 6.5        64   Gata4    11.6950
## 7688   64C 6.6        64   Gata4    10.4750
## 7689   64C 6.7        64   Gata4    -0.5650
## 7690   64C 6.8        64   Gata4    10.5250
## 7691   64C 7.1        64   Gata4     5.5150
## 7692   64C 7.2        64   Gata4     2.7850
## 7693   64C 7.3        64   Gata4    14.1500
## 7694   64C 7.4        64   Gata4     1.5650
## 7695   64C 7.5        64   Gata4     0.5400
## 7696   64C 7.6        64   Gata4     1.0200
## 7697   64C 7.7        64   Gata4    -0.9250
## 7698   64C 7.8        64   Gata4     3.3900
## 7699   64C 7.9        64   Gata4    -0.2000
## 7700  64C 7.10        64   Gata4    14.4400
## 7701  64C 7.11        64   Gata4    13.7850
## 7702  64C 7.12        64   Gata4    13.4000
## 7703  64C 7.13        64   Gata4    13.2600
## 7704  64C 7.14        64   Gata4    11.9000
## 7705    2C 1.1         2   Gata6     7.7250
## 7706    2C 1.2         2   Gata6     5.4750
## 7707    2C 2.1         2   Gata6     8.6950
## 7708    2C 2.2         2   Gata6    10.0250
## 7709    2C 3.1         2   Gata6    13.6250
## 7710    2C 3.2         2   Gata6    12.0575
## 7711    2C 4.1         2   Gata6    14.2550
## 7712    2C 5.1         2   Gata6    12.2000
## 7713    2C 5.2         2   Gata6    12.7000
## 7714    2C 6.1         2   Gata6     6.3750
## 7715    2C 6.2         2   Gata6     6.9600
## 7716    2C 7.1         2   Gata6    10.7950
## 7717    2C 7.2         2   Gata6    12.8150
## 7718    2C 8.1         2   Gata6     9.2800
## 7719    2C 8.2         2   Gata6    12.7325
## 7720    2C 9.1         2   Gata6     6.4850
## 7721    2C 9.2         2   Gata6     6.4950
## 7722   2C 10.1         2   Gata6     7.4400
## 7723   2C 10.2         2   Gata6     5.0750
## 7724    4C 1.1         4   Gata6     6.6450
## 7725    4C 1.2         4   Gata6     8.5950
## 7726    4C 1.3         4   Gata6     5.6850
## 7727    4C 1.4         4   Gata6     8.0950
## 7728    4C 2.1         4   Gata6    11.8100
## 7729    4C 2.2         4   Gata6    14.3950
## 7730    4C 2.3         4   Gata6     5.2150
## 7731    4C 3.1         4   Gata6     3.8400
## 7732    4C 3.2         4   Gata6     3.5850
## 7733    4C 3.3         4   Gata6     5.3400
## 7734    4C 3.4         4   Gata6     5.0550
## 7735    4C 4.1         4   Gata6     5.8950
## 7736    4C 4.2         4   Gata6     8.1650
## 7737    4C 4.3         4   Gata6     5.1800
## 7738    4C 4.4         4   Gata6     7.3900
## 7739    4C 5.1         4   Gata6     6.5050
## 7740    4C 5.2         4   Gata6     2.5550
## 7741    4C 5.3         4   Gata6     3.9350
## 7742    4C 5.4         4   Gata6     4.3450
## 7743    4C 6.1         4   Gata6     1.6500
## 7744    4C 6.2         4   Gata6     5.2050
## 7745    4C 6.3         4   Gata6     7.2550
## 7746    4C 6.4         4   Gata6     6.0800
## 7747    8C 1.1         8   Gata6     5.2050
## 7748    8C 1.2         8   Gata6     4.2900
## 7749    8C 1.3         8   Gata6     1.5800
## 7750    8C 1.4         8   Gata6     1.2400
## 7751    8C 1.5         8   Gata6     2.0650
## 7752    8C 2.1         8   Gata6     0.3700
## 7753    8C 2.2         8   Gata6     2.9600
## 7754    8C 2.3         8   Gata6     3.0150
## 7755    8C 2.4         8   Gata6     6.0950
## 7756    8C 2.5         8   Gata6     3.9800
## 7757    8C 2.6         8   Gata6     2.6850
## 7758    8C 2.7         8   Gata6     0.6000
## 7759    8C 2.8         8   Gata6     0.7300
## 7760    8C 3.1         8   Gata6     3.8350
## 7761    8C 3.2         8   Gata6     5.4100
## 7762    8C 3.3         8   Gata6     4.9250
## 7763    8C 3.4         8   Gata6     3.7700
## 7764    8C 3.5         8   Gata6     3.1800
## 7765    8C 3.6         8   Gata6     5.6700
## 7766    8C 3.7         8   Gata6     5.6700
## 7767    8C 3.8         8   Gata6     2.9000
## 7768    8C 4.2         8   Gata6     8.2450
## 7769    8C 4.3         8   Gata6     1.8400
## 7770    8C 4.4         8   Gata6     3.3950
## 7771    8C 4.5         8   Gata6     7.2450
## 7772    8C 4.6         8   Gata6     2.9150
## 7773    8C 4.7         8   Gata6     2.6050
## 7774    8C 5.1         8   Gata6     5.7300
## 7775    8C 5.2         8   Gata6     2.5650
## 7776    8C 5.3         8   Gata6     1.9850
## 7777    8C 5.4         8   Gata6    -0.6950
## 7778    8C 5.5         8   Gata6     3.1900
## 7779    8C 5.6         8   Gata6     2.9900
## 7780    8C 5.7         8   Gata6     5.0050
## 7781    8C 5.8         8   Gata6     3.9250
## 7782    8C 6.1         8   Gata6     3.5600
## 7783    8C 6.2         8   Gata6     4.9700
## 7784    8C 6.3         8   Gata6     4.4950
## 7785    8C 6.4         8   Gata6     3.0400
## 7786    8C 6.5         8   Gata6     2.8700
## 7787    8C 6.6         8   Gata6     1.4550
## 7788    8C 6.7         8   Gata6     3.6700
## 7789    8C 6.8         8   Gata6     6.6850
## 7790   16C 1.1        16   Gata6     5.2650
## 7791   16C 1.2        16   Gata6     2.8250
## 7792   16C 1.3        16   Gata6     3.6850
## 7793   16C 1.4        16   Gata6     2.5200
## 7794   16C 1.5        16   Gata6     2.2750
## 7795   16C 1.6        16   Gata6     2.1150
## 7796   16C 1.7        16   Gata6     3.7800
## 7797   16C 1.8        16   Gata6     3.7150
## 7798   16C 1.9        16   Gata6     3.5650
## 7799  16C 1.10        16   Gata6     4.1700
## 7800  16C 1.11        16   Gata6     3.7200
## 7801  16C 1.12        16   Gata6     3.2650
## 7802  16C 1.13        16   Gata6     2.3050
## 7803  16C 1.14        16   Gata6     1.0300
## 7804  16C 1.15        16   Gata6     1.4800
## 7805  16C 1.16        16   Gata6     1.9400
## 7806   16C 2.1        16   Gata6     3.9900
## 7807   16C 2.2        16   Gata6     4.8800
## 7808   16C 2.3        16   Gata6     2.5575
## 7809   16C 2.4        16   Gata6     2.4250
## 7810   16C 2.5        16   Gata6     2.4200
## 7811   16C 2.6        16   Gata6     1.0200
## 7812   16C 2.7        16   Gata6     1.4250
## 7813   16C 2.8        16   Gata6    -0.9150
## 7814   16C 2.9        16   Gata6     4.4050
## 7815  16C 2.10        16   Gata6     3.0250
## 7816  16C 2.11        16   Gata6     2.7550
## 7817  16C 2.12        16   Gata6     2.1375
## 7818  16C 2.13        16   Gata6     5.1350
## 7819  16C 2.14        16   Gata6     2.0800
## 7820  16C 2.15        16   Gata6     2.7900
## 7821  16C 2.16        16   Gata6    -0.2950
## 7822   16C 3.1        16   Gata6     2.7300
## 7823   16C 3.2        16   Gata6     1.2050
## 7824   16C 3.3        16   Gata6     2.7050
## 7825   16C 3.4        16   Gata6     3.2400
## 7826   16C 3.5        16   Gata6     1.9925
## 7827   16C 3.6        16   Gata6     3.3750
## 7828   16C 3.7        16   Gata6     2.8850
## 7829   16C 3.8        16   Gata6     4.4000
## 7830   16C 3.9        16   Gata6     2.0350
## 7831  16C 3.10        16   Gata6     2.5250
## 7832  16C 3.11        16   Gata6     2.4150
## 7833  16C 3.12        16   Gata6     3.9050
## 7834  16C 3.13        16   Gata6     4.0450
## 7835  16C 3.14        16   Gata6     2.6600
## 7836  16C 3.15        16   Gata6     4.0550
## 7837   16C 4.1        16   Gata6     1.3750
## 7838   16C 4.2        16   Gata6     0.1400
## 7839   16C 4.3        16   Gata6    -2.0750
## 7840   16C 4.4        16   Gata6    -0.1600
## 7841   16C 4.5        16   Gata6    -0.5050
## 7842   16C 4.6        16   Gata6     1.6550
## 7843   16C 4.7        16   Gata6     3.8650
## 7844   16C 4.8        16   Gata6     2.8700
## 7845   16C 4.9        16   Gata6     4.3000
## 7846  16C 4.10        16   Gata6     3.8550
## 7847  16C 4.11        16   Gata6    -1.4450
## 7848  16C 4.12        16   Gata6     0.0850
## 7849  16C 4.13        16   Gata6     1.7650
## 7850  16C 4.14        16   Gata6     0.5900
## 7851  16C 4.15        16   Gata6     1.6650
## 7852  16C 4.16        16   Gata6     4.0250
## 7853   16C 5.1        16   Gata6     1.3300
## 7854   16C 5.2        16   Gata6     2.6750
## 7855   16C 5.3        16   Gata6     3.5500
## 7856   16C 5.4        16   Gata6     0.9800
## 7857   16C 5.5        16   Gata6     1.3700
## 7858   16C 5.6        16   Gata6     1.8350
## 7859   16C 5.7        16   Gata6     0.0700
## 7860   16C 5.8        16   Gata6     4.3800
## 7861   16C 5.9        16   Gata6     2.1850
## 7862  16C 5.10        16   Gata6     1.4650
## 7863  16C 5.11        16   Gata6     4.5900
## 7864  16C 5.12        16   Gata6     2.1350
## 7865   32C 1.1        32   Gata6     3.4100
## 7866   32C 1.2        32   Gata6     1.7400
## 7867   32C 1.3        32   Gata6     4.4350
## 7868   32C 1.4        32   Gata6     5.0000
## 7869   32C 1.5        32   Gata6     4.4450
## 7870   32C 1.6        32   Gata6     3.2400
## 7871   32C 1.7        32   Gata6     5.0900
## 7872   32C 1.8        32   Gata6     4.7000
## 7873   32C 1.9        32   Gata6     6.0700
## 7874  32C 1.10        32   Gata6     2.6900
## 7875  32C 1.11        32   Gata6     3.2950
## 7876  32C 1.12        32   Gata6     3.0400
## 7877  32C 1.13        32   Gata6     1.5850
## 7878  32C 1.14        32   Gata6     6.2550
## 7879  32C 1.15        32   Gata6     2.2850
## 7880  32C 1.16        32   Gata6     3.7450
## 7881  32C 1.17        32   Gata6     5.1100
## 7882  32C 1.18        32   Gata6     4.9550
## 7883  32C 1.19        32   Gata6     1.6150
## 7884  32C 1.20        32   Gata6     0.3050
## 7885  32C 1.21        32   Gata6     3.3000
## 7886   32C 2.1        32   Gata6     1.4800
## 7887   32C 2.2        32   Gata6     5.8850
## 7888   32C 2.3        32   Gata6     6.7850
## 7889   32C 2.4        32   Gata6     1.4700
## 7890   32C 2.5        32   Gata6     9.5600
## 7891   32C 2.6        32   Gata6     6.3950
## 7892   32C 2.7        32   Gata6     1.8700
## 7893   32C 2.8        32   Gata6     2.3900
## 7894   32C 2.9        32   Gata6     3.9350
## 7895  32C 2.10        32   Gata6     4.3000
## 7896  32C 2.11        32   Gata6     5.2750
## 7897  32C 2.12        32   Gata6     6.5550
## 7898  32C 2.13        32   Gata6     5.3750
## 7899  32C 2.14        32   Gata6     3.8450
## 7900  32C 2.15        32   Gata6     5.4100
## 7901  32C 2.16        32   Gata6     2.8850
## 7902   32C 3.1        32   Gata6     3.4450
## 7903   32C 3.2        32   Gata6     4.3200
## 7904   32C 3.3        32   Gata6     3.0350
## 7905   32C 3.4        32   Gata6     5.3250
## 7906   32C 3.5        32   Gata6     6.7200
## 7907   32C 3.6        32   Gata6     3.4600
## 7908   32C 3.7        32   Gata6     3.8550
## 7909   32C 3.8        32   Gata6     1.6850
## 7910   32C 4.1        32   Gata6     2.9200
## 7911   32C 4.2        32   Gata6     3.1600
## 7912   32C 4.3        32   Gata6     2.5400
## 7913   32C 4.4        32   Gata6     2.1800
## 7914   32C 4.5        32   Gata6     4.1400
## 7915   32C 4.6        32   Gata6     2.7475
## 7916   32C 4.7        32   Gata6     5.1550
## 7917   32C 4.8        32   Gata6     4.6300
## 7918  32C 4.10        32   Gata6     3.4000
## 7919  32C 4.11        32   Gata6     1.5450
## 7920  32C 4.12        32   Gata6    -0.2650
## 7921  32C 4.13        32   Gata6     5.1250
## 7922  32C 4.14        32   Gata6     3.0850
## 7923  32C 4.15        32   Gata6     2.6450
## 7924  32C 4.16        32   Gata6     1.9775
## 7925  32C 4.17        32   Gata6     7.2250
## 7926  32C 4.18        32   Gata6     4.9100
## 7927  32C 4.19        32   Gata6     3.8900
## 7928  32C 4.20        32   Gata6     1.9450
## 7929  32C 4.21        32   Gata6     1.5300
## 7930  32C 4.22        32   Gata6     1.2750
## 7931  32C 4.23        32   Gata6     4.0850
## 7932  32C 4.24        32   Gata6     4.0400
## 7933   32C 5.1        32   Gata6     2.9425
## 7934   32C 5.2        32   Gata6     3.3650
## 7935   32C 5.3        32   Gata6     1.5450
## 7936   32C 5.4        32   Gata6     4.2100
## 7937   32C 5.5        32   Gata6     2.4250
## 7938   32C 5.6        32   Gata6     5.0350
## 7939   32C 5.7        32   Gata6     4.3050
## 7940   32C 5.8        32   Gata6     3.3550
## 7941   32C 5.9        32   Gata6     6.3550
## 7942  32C 5.10        32   Gata6     3.5400
## 7943  32C 5.11        32   Gata6     8.4550
## 7944  32C 5.12        32   Gata6     4.9550
## 7945  32C 5.13        32   Gata6     2.7300
## 7946  32C 5.14        32   Gata6     0.5450
## 7947  32C 5.15        32   Gata6     3.2600
## 7948  32C 5.16        32   Gata6     0.3350
## 7949  32C 5.17        32   Gata6     4.4450
## 7950  32C 5.18        32   Gata6     7.8050
## 7951  32C 5.19        32   Gata6     3.0300
## 7952  32C 5.20        32   Gata6     8.6000
## 7953  32C 5.21        32   Gata6     6.4050
## 7954  32C 5.22        32   Gata6     0.5850
## 7955  32C 5.23        32   Gata6     3.6250
## 7956   32C 6.1        32   Gata6     0.9000
## 7957   32C 6.2        32   Gata6     0.3850
## 7958   32C 6.3        32   Gata6     5.2500
## 7959   32C 6.4        32   Gata6     6.3900
## 7960   32C 6.6        32   Gata6     3.0550
## 7961   32C 6.7        32   Gata6     4.5750
## 7962   32C 7.1        32   Gata6     6.0300
## 7963   32C 7.2        32   Gata6     5.7800
## 7964   32C 7.3        32   Gata6     5.0950
## 7965   32C 7.4        32   Gata6     5.6100
## 7966   32C 7.5        32   Gata6     1.4000
## 7967   32C 7.6        32   Gata6     8.4050
## 7968   32C 7.8        32   Gata6     5.9750
## 7969   32C 8.1        32   Gata6     4.7550
## 7970   32C 8.2        32   Gata6     7.8850
## 7971   32C 8.4        32   Gata6     5.2700
## 7972   32C 8.5        32   Gata6     5.5600
## 7973   32C 8.6        32   Gata6     3.1300
## 7974   64C 1.1        64   Gata6     2.8450
## 7975   64C 1.2        64   Gata6     5.7200
## 7976   64C 1.3        64   Gata6    13.5550
## 7977   64C 1.4        64   Gata6     4.3100
## 7978   64C 1.5        64   Gata6     2.9900
## 7979   64C 1.6        64   Gata6    14.0200
## 7980   64C 1.7        64   Gata6     3.6600
## 7981   64C 1.8        64   Gata6     5.7700
## 7982   64C 1.9        64   Gata6     2.8050
## 7983  64C 1.10        64   Gata6     6.1700
## 7984  64C 1.11        64   Gata6     3.0450
## 7985  64C 1.12        64   Gata6     9.0650
## 7986  64C 1.13        64   Gata6     5.6650
## 7987  64C 1.14        64   Gata6     7.3550
## 7988  64C 1.15        64   Gata6     8.7100
## 7989  64C 1.16        64   Gata6    12.7750
## 7990  64C 1.17        64   Gata6     6.3650
## 7991  64C 1.18        64   Gata6     1.3050
## 7992  64C 1.19        64   Gata6     7.3000
## 7993  64C 1.20        64   Gata6     5.9100
## 7994  64C 1.21        64   Gata6     5.3150
## 7995  64C 1.22        64   Gata6    14.0350
## 7996  64C 1.23        64   Gata6    11.7500
## 7997  64C 1.24        64   Gata6     5.4100
## 7998  64C 1.25        64   Gata6     7.5550
## 7999  64C 1.26        64   Gata6     2.0300
## 8000  64C 1.27        64   Gata6     3.5000
## 8001  64C 1.28        64   Gata6     8.1050
## 8002  64C 1.29        64   Gata6     4.6100
## 8003  64C 1.30        64   Gata6     7.8950
## 8004  64C 1.31        64   Gata6    12.3050
## 8005  64C 1.32        64   Gata6    12.5350
## 8006  64C 1.33        64   Gata6     8.3050
## 8007  64C 1.34        64   Gata6    12.9500
## 8008  64C 1.35        64   Gata6     6.1850
## 8009  64C 1.36        64   Gata6     4.9150
## 8010  64C 1.37        64   Gata6     9.0600
## 8011  64C 1.38        64   Gata6     5.2650
## 8012  64C 1.39        64   Gata6     7.1950
## 8013  64C 1.40        64   Gata6    13.9300
## 8014  64C 1.41        64   Gata6     4.5400
## 8015  64C 1.42        64   Gata6     4.2550
## 8016  64C 1.43        64   Gata6     3.3950
## 8017  64C 1.44        64   Gata6     7.2000
## 8018  64C 1.45        64   Gata6     6.6100
## 8019  64C 1.46        64   Gata6     5.6800
## 8020  64C 1.47        64   Gata6     5.7000
## 8021  64C 1.48        64   Gata6     6.6500
## 8022   64C 2.1        64   Gata6     6.5075
## 8023   64C 2.2        64   Gata6     3.7950
## 8024   64C 2.3        64   Gata6     4.9600
## 8025   64C 2.4        64   Gata6     5.9400
## 8026   64C 2.5        64   Gata6     1.5250
## 8027   64C 2.6        64   Gata6     1.0750
## 8028   64C 2.7        64   Gata6     3.4050
## 8029   64C 2.8        64   Gata6     4.1850
## 8030   64C 2.9        64   Gata6     6.0350
## 8031  64C 2.10        64   Gata6     8.1475
## 8032  64C 2.11        64   Gata6     7.8850
## 8033  64C 2.12        64   Gata6     4.2900
## 8034  64C 2.13        64   Gata6     6.0600
## 8035  64C 2.14        64   Gata6     2.8550
## 8036  64C 2.15        64   Gata6     5.0700
## 8037  64C 2.16        64   Gata6     1.8450
## 8038  64C 2.17        64   Gata6     8.3850
## 8039  64C 2.18        64   Gata6    13.5600
## 8040  64C 2.19        64   Gata6     4.8625
## 8041  64C 2.20        64   Gata6     9.7850
## 8042  64C 2.21        64   Gata6     5.1550
## 8043  64C 2.22        64   Gata6     5.4100
## 8044  64C 2.23        64   Gata6     2.8450
## 8045  64C 2.24        64   Gata6     6.3650
## 8046  64C 2.25        64   Gata6     4.0250
## 8047   64C 3.1        64   Gata6    12.8950
## 8048   64C 3.2        64   Gata6     5.5050
## 8049   64C 3.3        64   Gata6     6.7900
## 8050   64C 3.4        64   Gata6     7.3050
## 8051   64C 3.5        64   Gata6     3.8650
## 8052   64C 3.6        64   Gata6     5.6500
## 8053   64C 3.7        64   Gata6     5.9350
## 8054   64C 3.8        64   Gata6     4.6200
## 8055   64C 4.1        64   Gata6     1.1750
## 8056  64C 4.1b        64   Gata6     8.7050
## 8057   64C 4.2        64   Gata6     9.9950
## 8058   64C 4.3        64   Gata6     3.6600
## 8059   64C 4.4        64   Gata6     5.8600
## 8060   64C 4.5        64   Gata6     4.6150
## 8061   64C 4.6        64   Gata6     2.6150
## 8062   64C 4.7        64   Gata6     3.8550
## 8063   64C 4.8        64   Gata6     2.2650
## 8064   64C 4.9        64   Gata6     4.3000
## 8065  64C 4.10        64   Gata6     4.6850
## 8066  64C 4.11        64   Gata6    13.9250
## 8067  64C 4.12        64   Gata6     7.3800
## 8068  64C 4.13        64   Gata6     9.8350
## 8069  64C 4.14        64   Gata6     9.2500
## 8070  64C 4.15        64   Gata6     4.6900
## 8071  64C 4.16        64   Gata6     4.2000
## 8072  64C 4.17        64   Gata6     7.4850
## 8073  64C 4.18        64   Gata6     3.3100
## 8074  64C 4.19        64   Gata6    10.3200
## 8075  64C 4.20        64   Gata6     6.6150
## 8076  64C 4.21        64   Gata6     4.8950
## 8077  64C 4.22        64   Gata6     6.4000
## 8078  64C 4.23        64   Gata6     5.4250
## 8079  64C 4.24        64   Gata6     6.3700
## 8080  64C 4.25        64   Gata6     5.3900
## 8081  64C 4.26        64   Gata6     3.0250
## 8082  64C 4.27        64   Gata6     4.5800
## 8083  64C 4.28        64   Gata6     4.1050
## 8084  64C 4.29        64   Gata6     7.5300
## 8085  64C 4.30        64   Gata6     4.1800
## 8086  64C 4.31        64   Gata6     7.8500
## 8087  64C 4.32        64   Gata6    13.0200
## 8088  64C 4.33        64   Gata6     6.4900
## 8089  64C 4.34        64   Gata6    11.5150
## 8090  64C 4.35        64   Gata6     2.7400
## 8091  64C 4.36        64   Gata6     4.4850
## 8092  64C 4.37        64   Gata6     7.8750
## 8093  64C 4.38        64   Gata6     5.0850
## 8094  64C 4.39        64   Gata6     6.2050
## 8095   64C 5.1        64   Gata6    15.9200
## 8096   64C 5.2        64   Gata6     3.5550
## 8097   64C 5.3        64   Gata6     4.1950
## 8098   64C 5.4        64   Gata6     2.8850
## 8099   64C 5.5        64   Gata6     4.4800
## 8100   64C 5.6        64   Gata6     4.4300
## 8101   64C 5.7        64   Gata6     5.1750
## 8102   64C 5.8        64   Gata6    14.0350
## 8103   64C 5.9        64   Gata6     3.0100
## 8104  64C 5.10        64   Gata6     6.1800
## 8105  64C 5.11        64   Gata6    14.7950
## 8106  64C 5.12        64   Gata6     6.1600
## 8107  64C 5.13        64   Gata6     7.7900
## 8108  64C 5.14        64   Gata6     6.4950
## 8109  64C 5.15        64   Gata6    11.6700
## 8110  64C 5.16        64   Gata6    14.3350
## 8111   64C 6.1        64   Gata6     4.0850
## 8112   64C 6.2        64   Gata6    12.5350
## 8113   64C 6.3        64   Gata6    13.8350
## 8114   64C 6.4        64   Gata6    12.9500
## 8115   64C 6.5        64   Gata6    12.4350
## 8116   64C 6.6        64   Gata6    11.5450
## 8117   64C 6.7        64   Gata6     5.2300
## 8118   64C 6.8        64   Gata6    12.4050
## 8119   64C 7.1        64   Gata6     9.2850
## 8120   64C 7.2        64   Gata6     5.9500
## 8121   64C 7.3        64   Gata6     9.3400
## 8122   64C 7.4        64   Gata6     4.8850
## 8123   64C 7.5        64   Gata6     4.2950
## 8124   64C 7.6        64   Gata6     3.0800
## 8125   64C 7.7        64   Gata6     2.5400
## 8126   64C 7.8        64   Gata6     7.2700
## 8127   64C 7.9        64   Gata6     5.2500
## 8128  64C 7.10        64   Gata6     4.9400
## 8129  64C 7.11        64   Gata6     5.4275
## 8130  64C 7.12        64   Gata6     4.6050
## 8131  64C 7.13        64   Gata6     6.2900
## 8132  64C 7.14        64   Gata6     4.5200
## 8133    2C 1.1         2   Grhl1     1.2850
## 8134    2C 1.2         2   Grhl1     3.5050
## 8135    2C 2.1         2   Grhl1     2.6550
## 8136    2C 2.2         2   Grhl1     4.6450
## 8137    2C 3.1         2   Grhl1     4.4500
## 8138    2C 3.2         2   Grhl1     4.9650
## 8139    2C 4.1         2   Grhl1     5.7100
## 8140    2C 5.1         2   Grhl1     2.8700
## 8141    2C 5.2         2   Grhl1     3.7150
## 8142    2C 6.1         2   Grhl1     2.0450
## 8143    2C 6.2         2   Grhl1     3.2650
## 8144    2C 7.1         2   Grhl1     2.2050
## 8145    2C 7.2         2   Grhl1     3.8600
## 8146    2C 8.1         2   Grhl1     5.6850
## 8147    2C 8.2         2   Grhl1     5.4925
## 8148    2C 9.1         2   Grhl1     5.1200
## 8149    2C 9.2         2   Grhl1     5.1300
## 8150   2C 10.1         2   Grhl1     3.5400
## 8151   2C 10.2         2   Grhl1     2.2200
## 8152    4C 1.1         4   Grhl1     7.8850
## 8153    4C 1.2         4   Grhl1     6.7100
## 8154    4C 1.3         4   Grhl1     7.5000
## 8155    4C 1.4         4   Grhl1    13.4950
## 8156    4C 2.1         4   Grhl1     5.2525
## 8157    4C 2.2         4   Grhl1     9.2350
## 8158    4C 2.3         4   Grhl1     8.2750
## 8159    4C 3.1         4   Grhl1    12.0950
## 8160    4C 3.2         4   Grhl1     5.4050
## 8161    4C 3.3         4   Grhl1     7.0950
## 8162    4C 3.4         4   Grhl1     4.1150
## 8163    4C 4.1         4   Grhl1     8.1900
## 8164    4C 4.2         4   Grhl1    13.7500
## 8165    4C 4.3         4   Grhl1    11.4600
## 8166    4C 4.4         4   Grhl1    11.6950
## 8167    4C 5.1         4   Grhl1    13.1300
## 8168    4C 5.2         4   Grhl1     8.0350
## 8169    4C 5.3         4   Grhl1     5.8100
## 8170    4C 5.4         4   Grhl1     5.9850
## 8171    4C 6.1         4   Grhl1     4.1500
## 8172    4C 6.2         4   Grhl1     7.7900
## 8173    4C 6.3         4   Grhl1     8.2350
## 8174    4C 6.4         4   Grhl1     7.9800
## 8175    8C 1.1         8   Grhl1    13.3950
## 8176    8C 1.2         8   Grhl1    14.0200
## 8177    8C 1.3         8   Grhl1     7.9900
## 8178    8C 1.4         8   Grhl1    11.6300
## 8179    8C 1.5         8   Grhl1     9.9550
## 8180    8C 2.1         8   Grhl1     5.7100
## 8181    8C 2.2         8   Grhl1     9.8900
## 8182    8C 2.3         8   Grhl1    10.2600
## 8183    8C 2.4         8   Grhl1    12.2850
## 8184    8C 2.5         8   Grhl1     9.3800
## 8185    8C 2.6         8   Grhl1    13.3200
## 8186    8C 2.7         8   Grhl1     8.9350
## 8187    8C 2.8         8   Grhl1    11.2900
## 8188    8C 3.1         8   Grhl1    11.8950
## 8189    8C 3.2         8   Grhl1    11.2000
## 8190    8C 3.3         8   Grhl1    10.4950
## 8191    8C 3.4         8   Grhl1     8.2900
## 8192    8C 3.5         8   Grhl1    13.3850
## 8193    8C 3.6         8   Grhl1     9.4000
## 8194    8C 3.7         8   Grhl1    11.1150
## 8195    8C 3.8         8   Grhl1     5.9050
## 8196    8C 4.2         8   Grhl1    12.1750
## 8197    8C 4.3         8   Grhl1    12.4150
## 8198    8C 4.4         8   Grhl1    11.6200
## 8199    8C 4.5         8   Grhl1    13.4600
## 8200    8C 4.6         8   Grhl1     7.8750
## 8201    8C 4.7         8   Grhl1    10.5050
## 8202    8C 5.1         8   Grhl1    10.3400
## 8203    8C 5.2         8   Grhl1     9.8050
## 8204    8C 5.3         8   Grhl1     6.0750
## 8205    8C 5.4         8   Grhl1     5.5100
## 8206    8C 5.5         8   Grhl1     9.3600
## 8207    8C 5.6         8   Grhl1    11.7000
## 8208    8C 5.7         8   Grhl1     8.2300
## 8209    8C 5.8         8   Grhl1     7.7350
## 8210    8C 6.1         8   Grhl1     6.8800
## 8211    8C 6.2         8   Grhl1    13.9200
## 8212    8C 6.3         8   Grhl1    10.2000
## 8213    8C 6.4         8   Grhl1     6.8400
## 8214    8C 6.5         8   Grhl1     5.9450
## 8215    8C 6.6         8   Grhl1     6.6600
## 8216    8C 6.7         8   Grhl1     8.4800
## 8217    8C 6.8         8   Grhl1     9.0950
## 8218   16C 1.1        16   Grhl1    12.9600
## 8219   16C 1.2        16   Grhl1    14.3950
## 8220   16C 1.3        16   Grhl1    13.2600
## 8221   16C 1.4        16   Grhl1     8.5600
## 8222   16C 1.5        16   Grhl1     8.3450
## 8223   16C 1.6        16   Grhl1     7.3850
## 8224   16C 1.7        16   Grhl1     6.7050
## 8225   16C 1.8        16   Grhl1     5.8900
## 8226   16C 1.9        16   Grhl1     8.1300
## 8227  16C 1.10        16   Grhl1    10.7650
## 8228  16C 1.11        16   Grhl1     9.2250
## 8229  16C 1.12        16   Grhl1     6.4900
## 8230  16C 1.13        16   Grhl1     7.2500
## 8231  16C 1.14        16   Grhl1     6.7650
## 8232  16C 1.15        16   Grhl1     1.9450
## 8233  16C 1.16        16   Grhl1     6.4050
## 8234   16C 2.1        16   Grhl1    11.3750
## 8235   16C 2.2        16   Grhl1     8.9800
## 8236   16C 2.3        16   Grhl1    11.1150
## 8237   16C 2.4        16   Grhl1    11.4800
## 8238   16C 2.5        16   Grhl1     6.8800
## 8239   16C 2.6        16   Grhl1     5.7650
## 8240   16C 2.7        16   Grhl1     5.3750
## 8241   16C 2.8        16   Grhl1     8.0350
## 8242   16C 2.9        16   Grhl1    12.4650
## 8243  16C 2.10        16   Grhl1    13.3750
## 8244  16C 2.11        16   Grhl1     9.2000
## 8245  16C 2.12        16   Grhl1     9.0450
## 8246  16C 2.13        16   Grhl1    13.8700
## 8247  16C 2.14        16   Grhl1     6.0500
## 8248  16C 2.15        16   Grhl1    11.1050
## 8249  16C 2.16        16   Grhl1     4.9650
## 8250   16C 3.1        16   Grhl1     5.7450
## 8251   16C 3.2        16   Grhl1     5.1150
## 8252   16C 3.3        16   Grhl1    13.1800
## 8253   16C 3.4        16   Grhl1     8.7950
## 8254   16C 3.5        16   Grhl1     8.0125
## 8255   16C 3.6        16   Grhl1     8.1600
## 8256   16C 3.7        16   Grhl1     7.7100
## 8257   16C 3.8        16   Grhl1     8.9300
## 8258   16C 3.9        16   Grhl1    10.3100
## 8259  16C 3.10        16   Grhl1     5.9950
## 8260  16C 3.11        16   Grhl1     8.5300
## 8261  16C 3.12        16   Grhl1     8.6500
## 8262  16C 3.13        16   Grhl1    13.0650
## 8263  16C 3.14        16   Grhl1     6.2325
## 8264  16C 3.15        16   Grhl1     8.7450
## 8265   16C 4.1        16   Grhl1     9.5750
## 8266   16C 4.2        16   Grhl1     6.8950
## 8267   16C 4.3        16   Grhl1     9.4650
## 8268   16C 4.4        16   Grhl1     5.8050
## 8269   16C 4.5        16   Grhl1     4.5950
## 8270   16C 4.6        16   Grhl1     7.4400
## 8271   16C 4.7        16   Grhl1    13.7500
## 8272   16C 4.8        16   Grhl1     5.7300
## 8273   16C 4.9        16   Grhl1    13.8850
## 8274  16C 4.10        16   Grhl1    13.1300
## 8275  16C 4.11        16   Grhl1    11.7650
## 8276  16C 4.12        16   Grhl1     6.1900
## 8277  16C 4.13        16   Grhl1     5.8050
## 8278  16C 4.14        16   Grhl1     4.0100
## 8279  16C 4.15        16   Grhl1     8.2900
## 8280  16C 4.16        16   Grhl1     9.3850
## 8281   16C 5.1        16   Grhl1     7.6300
## 8282   16C 5.2        16   Grhl1     6.9350
## 8283   16C 5.3        16   Grhl1     9.8900
## 8284   16C 5.4        16   Grhl1     5.9400
## 8285   16C 5.5        16   Grhl1    11.6300
## 8286   16C 5.6        16   Grhl1    12.1650
## 8287   16C 5.7        16   Grhl1     8.1700
## 8288   16C 5.8        16   Grhl1    14.7500
## 8289   16C 5.9        16   Grhl1     8.1800
## 8290  16C 5.10        16   Grhl1    12.2850
## 8291  16C 5.11        16   Grhl1     8.1600
## 8292  16C 5.12        16   Grhl1     9.7000
## 8293   32C 1.1        32   Grhl1     6.2850
## 8294   32C 1.2        32   Grhl1     6.0700
## 8295   32C 1.3        32   Grhl1     4.8050
## 8296   32C 1.4        32   Grhl1     4.0300
## 8297   32C 1.5        32   Grhl1    14.7350
## 8298   32C 1.6        32   Grhl1     7.5800
## 8299   32C 1.7        32   Grhl1     8.3850
## 8300   32C 1.8        32   Grhl1     9.6400
## 8301   32C 1.9        32   Grhl1     9.0350
## 8302  32C 1.10        32   Grhl1    10.3850
## 8303  32C 1.11        32   Grhl1     7.9650
## 8304  32C 1.12        32   Grhl1     6.2850
## 8305  32C 1.13        32   Grhl1     7.2100
## 8306  32C 1.14        32   Grhl1     7.2100
## 8307  32C 1.15        32   Grhl1     8.0250
## 8308  32C 1.16        32   Grhl1    13.2550
## 8309  32C 1.17        32   Grhl1    10.4400
## 8310  32C 1.18        32   Grhl1     8.4750
## 8311  32C 1.19        32   Grhl1    11.1850
## 8312  32C 1.20        32   Grhl1    11.5100
## 8313  32C 1.21        32   Grhl1    12.4300
## 8314   32C 2.1        32   Grhl1     4.1700
## 8315   32C 2.2        32   Grhl1     7.2700
## 8316   32C 2.3        32   Grhl1     7.6250
## 8317   32C 2.4        32   Grhl1     6.0600
## 8318   32C 2.5        32   Grhl1    13.9200
## 8319   32C 2.6        32   Grhl1    11.7100
## 8320   32C 2.7        32   Grhl1     6.1400
## 8321   32C 2.8        32   Grhl1     9.6850
## 8322   32C 2.9        32   Grhl1    11.7400
## 8323  32C 2.10        32   Grhl1     5.7500
## 8324  32C 2.11        32   Grhl1    14.2350
## 8325  32C 2.12        32   Grhl1     7.9400
## 8326  32C 2.13        32   Grhl1    14.3950
## 8327  32C 2.14        32   Grhl1     8.0400
## 8328  32C 2.15        32   Grhl1    12.7300
## 8329  32C 2.16        32   Grhl1     8.5850
## 8330   32C 3.1        32   Grhl1     3.7350
## 8331   32C 3.2        32   Grhl1    10.8650
## 8332   32C 3.3        32   Grhl1     4.7100
## 8333   32C 3.4        32   Grhl1     7.4500
## 8334   32C 3.5        32   Grhl1     7.1950
## 8335   32C 3.6        32   Grhl1    13.9450
## 8336   32C 3.7        32   Grhl1    13.1700
## 8337   32C 3.8        32   Grhl1    12.1000
## 8338   32C 4.1        32   Grhl1     6.3950
## 8339   32C 4.2        32   Grhl1     5.3650
## 8340   32C 4.3        32   Grhl1    11.5650
## 8341   32C 4.4        32   Grhl1    11.3750
## 8342   32C 4.5        32   Grhl1    13.6700
## 8343   32C 4.6        32   Grhl1    14.3150
## 8344   32C 4.7        32   Grhl1    15.2400
## 8345   32C 4.8        32   Grhl1     4.2600
## 8346  32C 4.10        32   Grhl1     5.1750
## 8347  32C 4.11        32   Grhl1    10.6750
## 8348  32C 4.12        32   Grhl1    11.5250
## 8349  32C 4.13        32   Grhl1     9.3250
## 8350  32C 4.14        32   Grhl1    13.3750
## 8351  32C 4.15        32   Grhl1     9.9700
## 8352  32C 4.16        32   Grhl1    13.1050
## 8353  32C 4.17        32   Grhl1    13.8700
## 8354  32C 4.18        32   Grhl1     4.9300
## 8355  32C 4.19        32   Grhl1     5.4750
## 8356  32C 4.20        32   Grhl1    10.4450
## 8357  32C 4.21        32   Grhl1    11.9650
## 8358  32C 4.22        32   Grhl1    10.7850
## 8359  32C 4.23        32   Grhl1     5.7700
## 8360  32C 4.24        32   Grhl1    13.6550
## 8361   32C 5.1        32   Grhl1     8.2525
## 8362   32C 5.2        32   Grhl1     5.6200
## 8363   32C 5.3        32   Grhl1     7.6500
## 8364   32C 5.4        32   Grhl1     5.1800
## 8365   32C 5.5        32   Grhl1     5.4700
## 8366   32C 5.6        32   Grhl1     6.2850
## 8367   32C 5.7        32   Grhl1     4.8700
## 8368   32C 5.8        32   Grhl1     8.9900
## 8369   32C 5.9        32   Grhl1     8.1550
## 8370  32C 5.10        32   Grhl1     6.9925
## 8371  32C 5.11        32   Grhl1    14.2450
## 8372  32C 5.12        32   Grhl1    13.9850
## 8373  32C 5.13        32   Grhl1     7.1650
## 8374  32C 5.14        32   Grhl1     3.1950
## 8375  32C 5.15        32   Grhl1     6.0450
## 8376  32C 5.16        32   Grhl1     4.3550
## 8377  32C 5.17        32   Grhl1    11.7700
## 8378  32C 5.18        32   Grhl1     7.5800
## 8379  32C 5.19        32   Grhl1    11.4600
## 8380  32C 5.20        32   Grhl1    13.8850
## 8381  32C 5.21        32   Grhl1     8.3400
## 8382  32C 5.22        32   Grhl1     6.9350
## 8383  32C 5.23        32   Grhl1     5.2600
## 8384   32C 6.1        32   Grhl1    11.3750
## 8385   32C 6.2        32   Grhl1     3.3000
## 8386   32C 6.3        32   Grhl1     5.8700
## 8387   32C 6.4        32   Grhl1    13.5550
## 8388   32C 6.6        32   Grhl1    12.1600
## 8389   32C 6.7        32   Grhl1     8.9500
## 8390   32C 7.1        32   Grhl1    14.0200
## 8391   32C 7.2        32   Grhl1    11.8600
## 8392   32C 7.3        32   Grhl1     6.7850
## 8393   32C 7.4        32   Grhl1     7.6100
## 8394   32C 7.5        32   Grhl1    11.1400
## 8395   32C 7.6        32   Grhl1    14.7500
## 8396   32C 7.8        32   Grhl1     9.6350
## 8397   32C 8.1        32   Grhl1    12.2850
## 8398   32C 8.2        32   Grhl1    14.0100
## 8399   32C 8.4        32   Grhl1     9.9100
## 8400   32C 8.5        32   Grhl1    12.5450
## 8401   32C 8.6        32   Grhl1     5.2950
## 8402   64C 1.1        64   Grhl1     6.8650
## 8403   64C 1.2        64   Grhl1     4.0300
## 8404   64C 1.3        64   Grhl1    10.5450
## 8405   64C 1.4        64   Grhl1    13.0900
## 8406   64C 1.5        64   Grhl1    13.3850
## 8407   64C 1.6        64   Grhl1    10.2100
## 8408   64C 1.7        64   Grhl1    14.4450
## 8409   64C 1.8        64   Grhl1     6.0250
## 8410   64C 1.9        64   Grhl1     7.4650
## 8411  64C 1.10        64   Grhl1     9.4150
## 8412  64C 1.11        64   Grhl1    11.6200
## 8413  64C 1.12        64   Grhl1     6.9600
## 8414  64C 1.13        64   Grhl1    12.9150
## 8415  64C 1.14        64   Grhl1     8.7850
## 8416  64C 1.15        64   Grhl1     8.9100
## 8417  64C 1.16        64   Grhl1     6.4750
## 8418  64C 1.17        64   Grhl1     7.2350
## 8419  64C 1.18        64   Grhl1     5.5600
## 8420  64C 1.19        64   Grhl1     8.0400
## 8421  64C 1.20        64   Grhl1     7.1200
## 8422  64C 1.21        64   Grhl1    10.5800
## 8423  64C 1.22        64   Grhl1     9.8450
## 8424  64C 1.23        64   Grhl1    11.6700
## 8425  64C 1.24        64   Grhl1    11.8800
## 8426  64C 1.25        64   Grhl1    14.7300
## 8427  64C 1.26        64   Grhl1    12.0900
## 8428  64C 1.27        64   Grhl1     2.7350
## 8429  64C 1.28        64   Grhl1     5.7800
## 8430  64C 1.29        64   Grhl1     4.9200
## 8431  64C 1.30        64   Grhl1     7.9150
## 8432  64C 1.31        64   Grhl1     6.9600
## 8433  64C 1.32        64   Grhl1     9.3450
## 8434  64C 1.33        64   Grhl1     7.4000
## 8435  64C 1.34        64   Grhl1     7.8100
## 8436  64C 1.35        64   Grhl1     5.3250
## 8437  64C 1.36        64   Grhl1     4.4950
## 8438  64C 1.37        64   Grhl1     4.2650
## 8439  64C 1.38        64   Grhl1     4.1200
## 8440  64C 1.39        64   Grhl1     6.8600
## 8441  64C 1.40        64   Grhl1     9.2650
## 8442  64C 1.41        64   Grhl1     9.4750
## 8443  64C 1.42        64   Grhl1    13.1700
## 8444  64C 1.43        64   Grhl1    12.1000
## 8445  64C 1.44        64   Grhl1     5.9650
## 8446  64C 1.45        64   Grhl1     2.8850
## 8447  64C 1.46        64   Grhl1     5.8050
## 8448  64C 1.47        64   Grhl1     4.7850
## 8449  64C 1.48        64   Grhl1     6.5800
## 8450   64C 2.1        64   Grhl1     7.2450
## 8451   64C 2.2        64   Grhl1     7.5200
## 8452   64C 2.3        64   Grhl1     5.5700
## 8453   64C 2.4        64   Grhl1     6.4150
## 8454   64C 2.5        64   Grhl1    10.6750
## 8455   64C 2.6        64   Grhl1     5.7250
## 8456   64C 2.7        64   Grhl1    12.4650
## 8457   64C 2.8        64   Grhl1    13.3750
## 8458   64C 2.9        64   Grhl1     5.9400
## 8459  64C 2.10        64   Grhl1     5.7850
## 8460  64C 2.11        64   Grhl1     6.1300
## 8461  64C 2.12        64   Grhl1     4.8200
## 8462  64C 2.13        64   Grhl1     4.4550
## 8463  64C 2.14        64   Grhl1    10.4450
## 8464  64C 2.15        64   Grhl1     5.7550
## 8465  64C 2.16        64   Grhl1     6.4450
## 8466  64C 2.17        64   Grhl1    13.1800
## 8467  64C 2.18        64   Grhl1     5.2350
## 8468  64C 2.19        64   Grhl1     6.5625
## 8469  64C 2.20        64   Grhl1     3.7900
## 8470  64C 2.21        64   Grhl1     4.8800
## 8471  64C 2.22        64   Grhl1     6.8800
## 8472  64C 2.23        64   Grhl1     5.0300
## 8473  64C 2.24        64   Grhl1     5.2650
## 8474  64C 2.25        64   Grhl1     5.5400
## 8475   64C 3.1        64   Grhl1     6.4000
## 8476   64C 3.2        64   Grhl1     6.7650
## 8477   64C 3.3        64   Grhl1     8.1725
## 8478   64C 3.4        64   Grhl1     8.8450
## 8479   64C 3.5        64   Grhl1    13.9850
## 8480   64C 3.6        64   Grhl1     6.6850
## 8481   64C 3.7        64   Grhl1     4.6050
## 8482   64C 3.8        64   Grhl1     4.3750
## 8483   64C 4.1        64   Grhl1     6.8550
## 8484  64C 4.1b        64   Grhl1    10.2500
## 8485   64C 4.2        64   Grhl1     9.7800
## 8486   64C 4.3        64   Grhl1     7.7400
## 8487   64C 4.4        64   Grhl1    13.8850
## 8488   64C 4.5        64   Grhl1    13.1300
## 8489   64C 4.6        64   Grhl1    11.7650
## 8490   64C 4.7        64   Grhl1     4.8900
## 8491   64C 4.8        64   Grhl1    11.3750
## 8492   64C 4.9        64   Grhl1     4.9700
## 8493  64C 4.10        64   Grhl1    12.5900
## 8494  64C 4.11        64   Grhl1    13.5550
## 8495  64C 4.12        64   Grhl1     4.6000
## 8496  64C 4.13        64   Grhl1     5.5550
## 8497  64C 4.14        64   Grhl1     7.6900
## 8498  64C 4.15        64   Grhl1     5.8600
## 8499  64C 4.16        64   Grhl1     8.2400
## 8500  64C 4.17        64   Grhl1     7.5950
## 8501  64C 4.18        64   Grhl1     3.8600
## 8502  64C 4.19        64   Grhl1     6.7300
## 8503  64C 4.20        64   Grhl1     6.8400
## 8504  64C 4.21        64   Grhl1     5.6750
## 8505  64C 4.22        64   Grhl1     6.7900
## 8506  64C 4.23        64   Grhl1     8.1100
## 8507  64C 4.24        64   Grhl1    12.5450
## 8508  64C 4.25        64   Grhl1     4.6500
## 8509  64C 4.26        64   Grhl1    11.8950
## 8510  64C 4.27        64   Grhl1     4.3700
## 8511  64C 4.28        64   Grhl1    14.7350
## 8512  64C 4.29        64   Grhl1     5.7900
## 8513  64C 4.30        64   Grhl1    13.3850
## 8514  64C 4.31        64   Grhl1     7.5400
## 8515  64C 4.32        64   Grhl1    14.4450
## 8516  64C 4.33        64   Grhl1     5.5950
## 8517  64C 4.34        64   Grhl1     4.7250
## 8518  64C 4.35        64   Grhl1     8.4550
## 8519  64C 4.36        64   Grhl1     4.0900
## 8520  64C 4.37        64   Grhl1     5.1800
## 8521  64C 4.38        64   Grhl1     6.0650
## 8522  64C 4.39        64   Grhl1     9.5750
## 8523   64C 5.1        64   Grhl1     6.9600
## 8524   64C 5.2        64   Grhl1    13.8750
## 8525   64C 5.3        64   Grhl1    11.1850
## 8526   64C 5.4        64   Grhl1     4.4300
## 8527   64C 5.5        64   Grhl1     8.4300
## 8528   64C 5.6        64   Grhl1    11.7000
## 8529   64C 5.7        64   Grhl1    14.3100
## 8530   64C 5.8        64   Grhl1     9.4550
## 8531   64C 5.9        64   Grhl1    11.6700
## 8532  64C 5.10        64   Grhl1    13.9200
## 8533  64C 5.11        64   Grhl1     6.5700
## 8534  64C 5.12        64   Grhl1     4.6700
## 8535  64C 5.13        64   Grhl1     2.1250
## 8536  64C 5.14        64   Grhl1     2.9900
## 8537  64C 5.15        64   Grhl1    12.6600
## 8538  64C 5.16        64   Grhl1     9.5850
## 8539   64C 6.1        64   Grhl1    12.9600
## 8540   64C 6.2        64   Grhl1    14.3950
## 8541   64C 6.3        64   Grhl1     9.5600
## 8542   64C 6.4        64   Grhl1     7.9900
## 8543   64C 6.5        64   Grhl1     9.1750
## 8544   64C 6.6        64   Grhl1    11.5450
## 8545   64C 6.7        64   Grhl1     6.3450
## 8546   64C 6.8        64   Grhl1    10.9800
## 8547   64C 7.1        64   Grhl1     8.8600
## 8548   64C 7.2        64   Grhl1    13.0850
## 8549   64C 7.3        64   Grhl1    13.9450
## 8550   64C 7.4        64   Grhl1    13.1700
## 8551   64C 7.5        64   Grhl1    12.1000
## 8552   64C 7.6        64   Grhl1     8.0050
## 8553   64C 7.7        64   Grhl1     8.3950
## 8554   64C 7.8        64   Grhl1    11.5650
## 8555   64C 7.9        64   Grhl1    11.3750
## 8556  64C 7.10        64   Grhl1     8.2200
## 8557  64C 7.11        64   Grhl1     6.8650
## 8558  64C 7.12        64   Grhl1     6.8400
## 8559  64C 7.13        64   Grhl1     7.4200
## 8560  64C 7.14        64   Grhl1    12.2750
## 8561    2C 1.1         2   Grhl2     0.5450
## 8562    2C 1.2         2   Grhl2     2.7400
## 8563    2C 2.1         2   Grhl2     2.6850
## 8564    2C 2.2         2   Grhl2     3.9850
## 8565    2C 3.1         2   Grhl2     5.0750
## 8566    2C 3.2         2   Grhl2     3.7450
## 8567    2C 4.1         2   Grhl2     4.5350
## 8568    2C 5.1         2   Grhl2     1.8900
## 8569    2C 5.2         2   Grhl2     1.5250
## 8570    2C 6.1         2   Grhl2     1.1100
## 8571    2C 6.2         2   Grhl2     1.9050
## 8572    2C 7.1         2   Grhl2    -0.0050
## 8573    2C 7.2         2   Grhl2     3.8600
## 8574    2C 8.1         2   Grhl2     5.8350
## 8575    2C 8.2         2   Grhl2     3.6650
## 8576    2C 9.1         2   Grhl2     4.6050
## 8577    2C 9.2         2   Grhl2     2.9850
## 8578   2C 10.1         2   Grhl2     3.4200
## 8579   2C 10.2         2   Grhl2     0.7050
## 8580    4C 1.1         4   Grhl2     3.9150
## 8581    4C 1.2         4   Grhl2     3.2450
## 8582    4C 1.3         4   Grhl2     4.5300
## 8583    4C 1.4         4   Grhl2     5.2550
## 8584    4C 2.1         4   Grhl2     5.9100
## 8585    4C 2.2         4   Grhl2     7.8200
## 8586    4C 2.3         4   Grhl2     6.1350
## 8587    4C 3.1         4   Grhl2     4.3550
## 8588    4C 3.2         4   Grhl2     1.4100
## 8589    4C 3.3         4   Grhl2     2.8700
## 8590    4C 3.4         4   Grhl2     3.0950
## 8591    4C 4.1         4   Grhl2     6.3000
## 8592    4C 4.2         4   Grhl2     4.3850
## 8593    4C 4.3         4   Grhl2     3.2250
## 8594    4C 4.4         4   Grhl2     5.5150
## 8595    4C 5.1         4   Grhl2     5.8150
## 8596    4C 5.2         4   Grhl2     3.8750
## 8597    4C 5.3         4   Grhl2     2.4100
## 8598    4C 5.4         4   Grhl2     3.2500
## 8599    4C 6.1         4   Grhl2     1.6750
## 8600    4C 6.2         4   Grhl2     3.5150
## 8601    4C 6.3         4   Grhl2     7.8950
## 8602    4C 6.4         4   Grhl2     4.7250
## 8603    8C 1.1         8   Grhl2     4.8850
## 8604    8C 1.2         8   Grhl2     6.3600
## 8605    8C 1.3         8   Grhl2     3.5400
## 8606    8C 1.4         8   Grhl2     2.9750
## 8607    8C 1.5         8   Grhl2     3.6450
## 8608    8C 2.1         8   Grhl2     2.6900
## 8609    8C 2.2         8   Grhl2     6.3500
## 8610    8C 2.3         8   Grhl2     5.0550
## 8611    8C 2.4         8   Grhl2     5.9400
## 8612    8C 2.5         8   Grhl2     6.4100
## 8613    8C 2.6         8   Grhl2     4.3550
## 8614    8C 2.7         8   Grhl2     5.9100
## 8615    8C 2.8         8   Grhl2     4.2300
## 8616    8C 3.1         8   Grhl2     3.8150
## 8617    8C 3.2         8   Grhl2     4.0400
## 8618    8C 3.3         8   Grhl2     6.4500
## 8619    8C 3.4         8   Grhl2     5.7500
## 8620    8C 3.5         8   Grhl2     5.0500
## 8621    8C 3.6         8   Grhl2     4.4300
## 8622    8C 3.7         8   Grhl2     4.5800
## 8623    8C 3.8         8   Grhl2     3.5750
## 8624    8C 4.2         8   Grhl2     4.9850
## 8625    8C 4.3         8   Grhl2     4.2100
## 8626    8C 4.4         8   Grhl2     5.1700
## 8627    8C 4.5         8   Grhl2     8.0200
## 8628    8C 4.6         8   Grhl2     6.0550
## 8629    8C 4.7         8   Grhl2     4.3150
## 8630    8C 5.1         8   Grhl2     4.6350
## 8631    8C 5.2         8   Grhl2     5.6050
## 8632    8C 5.3         8   Grhl2     2.6400
## 8633    8C 5.4         8   Grhl2     2.5150
## 8634    8C 5.5         8   Grhl2     5.3350
## 8635    8C 5.6         8   Grhl2     4.0500
## 8636    8C 5.7         8   Grhl2     5.6000
## 8637    8C 5.8         8   Grhl2     4.6450
## 8638    8C 6.1         8   Grhl2     5.5950
## 8639    8C 6.2         8   Grhl2     5.2650
## 8640    8C 6.3         8   Grhl2     6.0850
## 8641    8C 6.4         8   Grhl2     4.1500
## 8642    8C 6.5         8   Grhl2    -0.6250
## 8643    8C 6.6         8   Grhl2     4.5300
## 8644    8C 6.7         8   Grhl2     3.9250
## 8645    8C 6.8         8   Grhl2     7.2150
## 8646   16C 1.1        16   Grhl2     7.2200
## 8647   16C 1.2        16   Grhl2     7.2900
## 8648   16C 1.3        16   Grhl2     6.1900
## 8649   16C 1.4        16   Grhl2     4.4300
## 8650   16C 1.5        16   Grhl2     3.7350
## 8651   16C 1.6        16   Grhl2     4.4250
## 8652   16C 1.7        16   Grhl2     2.6800
## 8653   16C 1.8        16   Grhl2     3.9150
## 8654   16C 1.9        16   Grhl2     6.0150
## 8655  16C 1.10        16   Grhl2     7.2375
## 8656  16C 1.11        16   Grhl2     5.3900
## 8657  16C 1.12        16   Grhl2     4.0750
## 8658  16C 1.13        16   Grhl2     4.2200
## 8659  16C 1.14        16   Grhl2     3.4500
## 8660  16C 1.15        16   Grhl2     3.6450
## 8661  16C 1.16        16   Grhl2     4.0600
## 8662   16C 2.1        16   Grhl2     5.3650
## 8663   16C 2.2        16   Grhl2     4.9900
## 8664   16C 2.3        16   Grhl2     7.1725
## 8665   16C 2.4        16   Grhl2     6.9450
## 8666   16C 2.5        16   Grhl2     5.2250
## 8667   16C 2.6        16   Grhl2     3.5550
## 8668   16C 2.7        16   Grhl2     4.0650
## 8669   16C 2.8        16   Grhl2     4.3700
## 8670   16C 2.9        16   Grhl2     3.0550
## 8671  16C 2.10        16   Grhl2     5.0350
## 8672  16C 2.11        16   Grhl2     6.1850
## 8673  16C 2.12        16   Grhl2     5.1950
## 8674  16C 2.13        16   Grhl2     5.8750
## 8675  16C 2.14        16   Grhl2     2.5900
## 8676  16C 2.15        16   Grhl2     2.8350
## 8677  16C 2.16        16   Grhl2     1.7800
## 8678   16C 3.1        16   Grhl2     3.4650
## 8679   16C 3.2        16   Grhl2     2.5950
## 8680   16C 3.3        16   Grhl2     5.7000
## 8681   16C 3.4        16   Grhl2     7.2550
## 8682   16C 3.5        16   Grhl2     5.9650
## 8683   16C 3.6        16   Grhl2     4.6450
## 8684   16C 3.7        16   Grhl2     4.3350
## 8685   16C 3.8        16   Grhl2     4.9100
## 8686   16C 3.9        16   Grhl2     2.0550
## 8687  16C 3.10        16   Grhl2     3.0550
## 8688  16C 3.11        16   Grhl2     2.5150
## 8689  16C 3.12        16   Grhl2     4.9100
## 8690  16C 3.13        16   Grhl2     5.2550
## 8691  16C 3.14        16   Grhl2     5.7900
## 8692  16C 3.15        16   Grhl2     6.7300
## 8693   16C 4.1        16   Grhl2     5.9550
## 8694   16C 4.2        16   Grhl2     4.1150
## 8695   16C 4.3        16   Grhl2     5.6000
## 8696   16C 4.4        16   Grhl2     6.2000
## 8697   16C 4.5        16   Grhl2     4.4850
## 8698   16C 4.6        16   Grhl2     6.9300
## 8699   16C 4.7        16   Grhl2     5.6350
## 8700   16C 4.8        16   Grhl2     4.6550
## 8701   16C 4.9        16   Grhl2     6.0550
## 8702  16C 4.10        16   Grhl2     5.7550
## 8703  16C 4.11        16   Grhl2     3.1050
## 8704  16C 4.12        16   Grhl2     4.6300
## 8705  16C 4.13        16   Grhl2     3.6100
## 8706  16C 4.14        16   Grhl2     6.0650
## 8707  16C 4.15        16   Grhl2     5.7450
## 8708  16C 4.16        16   Grhl2     7.2150
## 8709   16C 5.1        16   Grhl2     4.8450
## 8710   16C 5.2        16   Grhl2     3.7950
## 8711   16C 5.3        16   Grhl2     5.8000
## 8712   16C 5.4        16   Grhl2     3.3500
## 8713   16C 5.5        16   Grhl2     2.8850
## 8714   16C 5.6        16   Grhl2     6.4750
## 8715   16C 5.7        16   Grhl2     3.2600
## 8716   16C 5.8        16   Grhl2     7.0400
## 8717   16C 5.9        16   Grhl2     4.2350
## 8718  16C 5.10        16   Grhl2     4.9600
## 8719  16C 5.11        16   Grhl2     5.3800
## 8720  16C 5.12        16   Grhl2     5.5450
## 8721   32C 1.1        32   Grhl2     5.0000
## 8722   32C 1.2        32   Grhl2     5.0300
## 8723   32C 1.3        32   Grhl2     3.8750
## 8724   32C 1.4        32   Grhl2     2.2300
## 8725   32C 1.5        32   Grhl2     6.0900
## 8726   32C 1.6        32   Grhl2     6.7000
## 8727   32C 1.7        32   Grhl2     6.4500
## 8728   32C 1.8        32   Grhl2     5.7900
## 8729   32C 1.9        32   Grhl2     5.9800
## 8730  32C 1.10        32   Grhl2    11.7850
## 8731  32C 1.11        32   Grhl2     3.4450
## 8732  32C 1.12        32   Grhl2     4.3100
## 8733  32C 1.13        32   Grhl2     4.8400
## 8734  32C 1.14        32   Grhl2     5.7600
## 8735  32C 1.15        32   Grhl2     6.5150
## 8736  32C 1.16        32   Grhl2     5.5350
## 8737  32C 1.17        32   Grhl2     5.8150
## 8738  32C 1.18        32   Grhl2     7.9150
## 8739  32C 1.19        32   Grhl2     5.0900
## 8740  32C 1.20        32   Grhl2     6.6750
## 8741  32C 1.21        32   Grhl2     5.7350
## 8742   32C 2.1        32   Grhl2     2.2000
## 8743   32C 2.2        32   Grhl2     6.6300
## 8744   32C 2.3        32   Grhl2     4.0050
## 8745   32C 2.4        32   Grhl2     5.8950
## 8746   32C 2.5        32   Grhl2     6.6150
## 8747   32C 2.6        32   Grhl2     5.8350
## 8748   32C 2.7        32   Grhl2     2.5400
## 8749   32C 2.8        32   Grhl2     0.0450
## 8750   32C 2.9        32   Grhl2     4.0700
## 8751  32C 2.10        32   Grhl2     2.8550
## 8752  32C 2.11        32   Grhl2     8.2650
## 8753  32C 2.12        32   Grhl2     5.3100
## 8754  32C 2.13        32   Grhl2     9.1600
## 8755  32C 2.14        32   Grhl2     5.8700
## 8756  32C 2.15        32   Grhl2     5.7700
## 8757  32C 2.16        32   Grhl2     4.5450
## 8758   32C 3.1        32   Grhl2     3.2550
## 8759   32C 3.2        32   Grhl2     3.1200
## 8760   32C 3.3        32   Grhl2     3.2450
## 8761   32C 3.4        32   Grhl2     5.3550
## 8762   32C 3.5        32   Grhl2     6.9775
## 8763   32C 3.6        32   Grhl2     6.8200
## 8764   32C 3.7        32   Grhl2     4.6350
## 8765   32C 3.8        32   Grhl2     5.8100
## 8766   32C 4.1        32   Grhl2     2.3700
## 8767   32C 4.2        32   Grhl2     4.9650
## 8768   32C 4.3        32   Grhl2     5.5900
## 8769   32C 4.4        32   Grhl2     6.9050
## 8770   32C 4.5        32   Grhl2     7.6200
## 8771   32C 4.6        32   Grhl2     6.3225
## 8772   32C 4.7        32   Grhl2     7.8750
## 8773   32C 4.8        32   Grhl2     2.6950
## 8774  32C 4.10        32   Grhl2     3.7250
## 8775  32C 4.11        32   Grhl2     3.0150
## 8776  32C 4.12        32   Grhl2     4.5800
## 8777  32C 4.13        32   Grhl2     2.6350
## 8778  32C 4.14        32   Grhl2     6.5850
## 8779  32C 4.15        32   Grhl2     7.7350
## 8780  32C 4.16        32   Grhl2     8.3950
## 8781  32C 4.17        32   Grhl2     5.6650
## 8782  32C 4.18        32   Grhl2     2.1200
## 8783  32C 4.19        32   Grhl2     1.3250
## 8784  32C 4.20        32   Grhl2     3.8300
## 8785  32C 4.21        32   Grhl2     4.6050
## 8786  32C 4.22        32   Grhl2     4.7550
## 8787  32C 4.23        32   Grhl2     4.7600
## 8788  32C 4.24        32   Grhl2     9.1950
## 8789   32C 5.1        32   Grhl2     4.3250
## 8790   32C 5.2        32   Grhl2     5.2450
## 8791   32C 5.3        32   Grhl2     3.5550
## 8792   32C 5.4        32   Grhl2     3.6400
## 8793   32C 5.5        32   Grhl2     2.6350
## 8794   32C 5.6        32   Grhl2     3.0350
## 8795   32C 5.7        32   Grhl2     2.2350
## 8796   32C 5.8        32   Grhl2     7.0200
## 8797   32C 5.9        32   Grhl2     3.9150
## 8798  32C 5.10        32   Grhl2     8.3700
## 8799  32C 5.11        32   Grhl2     5.5900
## 8800  32C 5.12        32   Grhl2     7.5550
## 8801  32C 5.13        32   Grhl2     4.0850
## 8802  32C 5.14        32   Grhl2     0.8800
## 8803  32C 5.15        32   Grhl2     2.6200
## 8804  32C 5.16        32   Grhl2     2.9050
## 8805  32C 5.17        32   Grhl2     6.0400
## 8806  32C 5.18        32   Grhl2     5.4650
## 8807  32C 5.19        32   Grhl2     6.4350
## 8808  32C 5.20        32   Grhl2     6.5650
## 8809  32C 5.21        32   Grhl2     5.9550
## 8810  32C 5.22        32   Grhl2     3.1750
## 8811  32C 5.23        32   Grhl2     2.9500
## 8812   32C 6.1        32   Grhl2     3.3500
## 8813   32C 6.2        32   Grhl2     1.7700
## 8814   32C 6.3        32   Grhl2     4.1400
## 8815   32C 6.4        32   Grhl2     7.9500
## 8816   32C 6.6        32   Grhl2     3.5400
## 8817   32C 6.7        32   Grhl2     4.3500
## 8818   32C 7.1        32   Grhl2     4.8950
## 8819   32C 7.2        32   Grhl2     5.4650
## 8820   32C 7.3        32   Grhl2     3.7200
## 8821   32C 7.4        32   Grhl2     4.1500
## 8822   32C 7.5        32   Grhl2     4.7700
## 8823   32C 7.6        32   Grhl2     7.8650
## 8824   32C 7.8        32   Grhl2     5.0400
## 8825   32C 8.1        32   Grhl2     4.8850
## 8826   32C 8.2        32   Grhl2     6.4700
## 8827   32C 8.4        32   Grhl2     5.6900
## 8828   32C 8.5        32   Grhl2     6.0850
## 8829   32C 8.6        32   Grhl2     3.6200
## 8830   64C 1.1        64   Grhl2     7.1750
## 8831   64C 1.2        64   Grhl2     4.3200
## 8832   64C 1.3        64   Grhl2     6.3400
## 8833   64C 1.4        64   Grhl2     7.2300
## 8834   64C 1.5        64   Grhl2     6.7000
## 8835   64C 1.6        64   Grhl2     5.4000
## 8836   64C 1.7        64   Grhl2     6.9100
## 8837   64C 1.8        64   Grhl2     3.5450
## 8838   64C 1.9        64   Grhl2     7.2250
## 8839  64C 1.10        64   Grhl2     4.2200
## 8840  64C 1.11        64   Grhl2     5.4900
## 8841  64C 1.12        64   Grhl2     5.7500
## 8842  64C 1.13        64   Grhl2     7.6550
## 8843  64C 1.14        64   Grhl2     6.1650
## 8844  64C 1.15        64   Grhl2     6.1350
## 8845  64C 1.16        64   Grhl2     6.9550
## 8846  64C 1.17        64   Grhl2     4.5500
## 8847  64C 1.18        64   Grhl2     3.5050
## 8848  64C 1.19        64   Grhl2     3.5750
## 8849  64C 1.20        64   Grhl2     3.2400
## 8850  64C 1.21        64   Grhl2     9.2400
## 8851  64C 1.22        64   Grhl2     6.8050
## 8852  64C 1.23        64   Grhl2     7.3750
## 8853  64C 1.24        64   Grhl2     5.2650
## 8854  64C 1.25        64   Grhl2     6.7550
## 8855  64C 1.26        64   Grhl2     6.7500
## 8856  64C 1.27        64   Grhl2    -0.5350
## 8857  64C 1.28        64   Grhl2     4.2500
## 8858  64C 1.29        64   Grhl2     2.8850
## 8859  64C 1.30        64   Grhl2     7.0750
## 8860  64C 1.31        64   Grhl2     5.3500
## 8861  64C 1.32        64   Grhl2     6.0700
## 8862  64C 1.33        64   Grhl2     5.1700
## 8863  64C 1.34        64   Grhl2     5.5600
## 8864  64C 1.35        64   Grhl2     3.3750
## 8865  64C 1.36        64   Grhl2     2.1450
## 8866  64C 1.37        64   Grhl2     2.4800
## 8867  64C 1.38        64   Grhl2     2.5450
## 8868  64C 1.39        64   Grhl2     6.2150
## 8869  64C 1.40        64   Grhl2     8.1175
## 8870  64C 1.41        64   Grhl2     8.7600
## 8871  64C 1.42        64   Grhl2     5.8550
## 8872  64C 1.43        64   Grhl2     7.6800
## 8873  64C 1.44        64   Grhl2     4.4300
## 8874  64C 1.45        64   Grhl2     3.4850
## 8875  64C 1.46        64   Grhl2     3.8900
## 8876  64C 1.47        64   Grhl2     5.2650
## 8877  64C 1.48        64   Grhl2     4.9300
## 8878   64C 2.1        64   Grhl2     3.7425
## 8879   64C 2.2        64   Grhl2     4.8850
## 8880   64C 2.3        64   Grhl2     3.4150
## 8881   64C 2.4        64   Grhl2     3.9850
## 8882   64C 2.5        64   Grhl2     3.3250
## 8883   64C 2.6        64   Grhl2     4.2400
## 8884   64C 2.7        64   Grhl2     4.9150
## 8885   64C 2.8        64   Grhl2     5.5450
## 8886   64C 2.9        64   Grhl2     4.6950
## 8887  64C 2.10        64   Grhl2     4.4550
## 8888  64C 2.11        64   Grhl2     5.2250
## 8889  64C 2.12        64   Grhl2     2.4900
## 8890  64C 2.13        64   Grhl2     2.7150
## 8891  64C 2.14        64   Grhl2     1.9400
## 8892  64C 2.15        64   Grhl2     3.1550
## 8893  64C 2.16        64   Grhl2     4.4450
## 8894  64C 2.17        64   Grhl2     6.0300
## 8895  64C 2.18        64   Grhl2     4.7350
## 8896  64C 2.19        64   Grhl2     4.4550
## 8897  64C 2.20        64   Grhl2     5.3350
## 8898  64C 2.21        64   Grhl2     2.9350
## 8899  64C 2.22        64   Grhl2     4.2700
## 8900  64C 2.23        64   Grhl2     1.7450
## 8901  64C 2.24        64   Grhl2     2.1250
## 8902  64C 2.25        64   Grhl2     1.4250
## 8903   64C 3.1        64   Grhl2     4.3300
## 8904   64C 3.2        64   Grhl2     4.6850
## 8905   64C 3.3        64   Grhl2     4.7300
## 8906   64C 3.4        64   Grhl2     5.6300
## 8907   64C 3.5        64   Grhl2     6.3850
## 8908   64C 3.6        64   Grhl2     4.4250
## 8909   64C 3.7        64   Grhl2     2.4800
## 8910   64C 3.8        64   Grhl2     3.1700
## 8911   64C 4.1        64   Grhl2    10.9850
## 8912  64C 4.1b        64   Grhl2     9.2100
## 8913   64C 4.2        64   Grhl2     9.8350
## 8914   64C 4.3        64   Grhl2     7.7150
## 8915   64C 4.4        64   Grhl2    13.6850
## 8916   64C 4.5        64   Grhl2    10.9150
## 8917   64C 4.6        64   Grhl2    11.0150
## 8918   64C 4.7        64   Grhl2     3.6100
## 8919   64C 4.8        64   Grhl2     6.0000
## 8920   64C 4.9        64   Grhl2     4.6350
## 8921  64C 4.10        64   Grhl2     6.5150
## 8922  64C 4.11        64   Grhl2     9.7250
## 8923  64C 4.12        64   Grhl2     5.3750
## 8924  64C 4.13        64   Grhl2     4.3250
## 8925  64C 4.14        64   Grhl2     6.1700
## 8926  64C 4.15        64   Grhl2     4.6500
## 8927  64C 4.16        64   Grhl2     3.9750
## 8928  64C 4.17        64   Grhl2     5.1950
## 8929  64C 4.18        64   Grhl2     3.4400
## 8930  64C 4.19        64   Grhl2     6.3200
## 8931  64C 4.20        64   Grhl2     4.0650
## 8932  64C 4.21        64   Grhl2     4.8000
## 8933  64C 4.22        64   Grhl2     7.1200
## 8934  64C 4.23        64   Grhl2     4.6850
## 8935  64C 4.24        64   Grhl2     6.1600
## 8936  64C 4.25        64   Grhl2     3.1000
## 8937  64C 4.26        64   Grhl2     7.6750
## 8938  64C 4.27        64   Grhl2     4.8100
## 8939  64C 4.28        64   Grhl2     8.6900
## 8940  64C 4.29        64   Grhl2     6.5900
## 8941  64C 4.30        64   Grhl2     8.9500
## 8942  64C 4.31        64   Grhl2     4.5200
## 8943  64C 4.32        64   Grhl2    13.1200
## 8944  64C 4.33        64   Grhl2     4.7550
## 8945  64C 4.34        64   Grhl2     3.1650
## 8946  64C 4.35        64   Grhl2     6.3900
## 8947  64C 4.36        64   Grhl2     2.6900
## 8948  64C 4.37        64   Grhl2     5.5200
## 8949  64C 4.38        64   Grhl2     5.9650
## 8950  64C 4.39        64   Grhl2     6.5650
## 8951   64C 5.1        64   Grhl2     6.5450
## 8952   64C 5.2        64   Grhl2    14.1850
## 8953   64C 5.3        64   Grhl2    11.8100
## 8954   64C 5.4        64   Grhl2     3.1250
## 8955   64C 5.5        64   Grhl2     7.1850
## 8956   64C 5.6        64   Grhl2     6.0100
## 8957   64C 5.7        64   Grhl2    14.4500
## 8958   64C 5.8        64   Grhl2     8.6150
## 8959   64C 5.9        64   Grhl2    13.6050
## 8960  64C 5.10        64   Grhl2     8.1450
## 8961  64C 5.11        64   Grhl2     5.9850
## 8962  64C 5.12        64   Grhl2     2.7700
## 8963  64C 5.13        64   Grhl2     0.2750
## 8964  64C 5.14        64   Grhl2     3.7000
## 8965  64C 5.15        64   Grhl2     7.5150
## 8966  64C 5.16        64   Grhl2     7.0650
## 8967   64C 6.1        64   Grhl2    13.7700
## 8968   64C 6.2        64   Grhl2     8.5100
## 8969   64C 6.3        64   Grhl2     8.5400
## 8970   64C 6.4        64   Grhl2     7.9100
## 8971   64C 6.5        64   Grhl2     7.0350
## 8972   64C 6.6        64   Grhl2     5.8050
## 8973   64C 6.7        64   Grhl2     6.5000
## 8974   64C 6.8        64   Grhl2    10.3750
## 8975   64C 7.1        64   Grhl2     9.8250
## 8976   64C 7.2        64   Grhl2    15.2575
## 8977   64C 7.3        64   Grhl2     9.6400
## 8978   64C 7.4        64   Grhl2     8.8050
## 8979   64C 7.5        64   Grhl2     7.8100
## 8980   64C 7.6        64   Grhl2     6.1300
## 8981   64C 7.7        64   Grhl2     6.2050
## 8982   64C 7.8        64   Grhl2     7.6800
## 8983   64C 7.9        64   Grhl2    13.5850
## 8984  64C 7.10        64   Grhl2     5.4600
## 8985  64C 7.11        64   Grhl2     5.4525
## 8986  64C 7.12        64   Grhl2     6.7350
## 8987  64C 7.13        64   Grhl2     5.7050
## 8988  64C 7.14        64   Grhl2     5.0050
## 8989    2C 1.1         2   Hand1    10.6250
## 8990    2C 1.2         2   Hand1     8.8950
## 8991    2C 2.1         2   Hand1     5.2000
## 8992    2C 2.2         2   Hand1    13.2600
## 8993    2C 3.1         2   Hand1    14.1050
## 8994    2C 3.2         2   Hand1     7.8600
## 8995    2C 4.1         2   Hand1     6.0500
## 8996    2C 5.1         2   Hand1     3.8250
## 8997    2C 5.2         2   Hand1     9.2550
## 8998    2C 6.1         2   Hand1    -0.6450
## 8999    2C 6.2         2   Hand1     1.5650
## 9000    2C 7.1         2   Hand1     6.1000
## 9001    2C 7.2         2   Hand1    13.0100
## 9002    2C 8.1         2   Hand1    13.7200
## 9003    2C 8.2         2   Hand1     9.3600
## 9004    2C 9.1         2   Hand1     2.4500
## 9005    2C 9.2         2   Hand1     2.2850
## 9006   2C 10.1         2   Hand1     5.2700
## 9007   2C 10.2         2   Hand1     3.3550
## 9008    4C 1.1         4   Hand1     0.2450
## 9009    4C 1.2         4   Hand1    -1.5200
## 9010    4C 1.3         4   Hand1     4.5050
## 9011    4C 1.4         4   Hand1     3.5500
## 9012    4C 2.1         4   Hand1     1.9000
## 9013    4C 2.2         4   Hand1     6.7800
## 9014    4C 2.3         4   Hand1     3.1350
## 9015    4C 3.1         4   Hand1     1.9000
## 9016    4C 3.2         4   Hand1    -1.8300
## 9017    4C 3.3         4   Hand1     1.4350
## 9018    4C 3.4         4   Hand1     0.9450
## 9019    4C 4.1         4   Hand1     3.7400
## 9020    4C 4.2         4   Hand1     4.6350
## 9021    4C 4.3         4   Hand1     3.2400
## 9022    4C 4.4         4   Hand1     3.0850
## 9023    4C 5.1         4   Hand1     3.6800
## 9024    4C 5.2         4   Hand1     3.5050
## 9025    4C 5.3         4   Hand1     0.1150
## 9026    4C 5.4         4   Hand1    -0.4850
## 9027    4C 6.1         4   Hand1    -1.1150
## 9028    4C 6.2         4   Hand1     5.3150
## 9029    4C 6.3         4   Hand1     2.4950
## 9030    4C 6.4         4   Hand1     0.4650
## 9031    8C 1.1         8   Hand1     4.7300
## 9032    8C 1.2         8   Hand1     2.4550
## 9033    8C 1.3         8   Hand1     1.4350
## 9034    8C 1.4         8   Hand1     1.8050
## 9035    8C 1.5         8   Hand1     1.4300
## 9036    8C 2.1         8   Hand1     1.1950
## 9037    8C 2.2         8   Hand1     2.4300
## 9038    8C 2.3         8   Hand1     3.0200
## 9039    8C 2.4         8   Hand1     5.1300
## 9040    8C 2.5         8   Hand1     2.6100
## 9041    8C 2.6         8   Hand1     2.1700
## 9042    8C 2.7         8   Hand1     1.9350
## 9043    8C 2.8         8   Hand1     0.3950
## 9044    8C 3.1         8   Hand1     1.9650
## 9045    8C 3.2         8   Hand1     3.1550
## 9046    8C 3.3         8   Hand1     2.8400
## 9047    8C 3.4         8   Hand1     0.4750
## 9048    8C 3.5         8   Hand1     2.4450
## 9049    8C 3.6         8   Hand1    -1.1300
## 9050    8C 3.7         8   Hand1     2.9400
## 9051    8C 3.8         8   Hand1     0.6150
## 9052    8C 4.2         8   Hand1     4.2250
## 9053    8C 4.3         8   Hand1     1.1700
## 9054    8C 4.4         8   Hand1     1.7100
## 9055    8C 4.5         8   Hand1     4.1850
## 9056    8C 4.6         8   Hand1     3.2250
## 9057    8C 4.7         8   Hand1     1.9250
## 9058    8C 5.1         8   Hand1     2.5700
## 9059    8C 5.2         8   Hand1     2.3750
## 9060    8C 5.3         8   Hand1     0.0550
## 9061    8C 5.4         8   Hand1    -0.4100
## 9062    8C 5.5         8   Hand1     0.6200
## 9063    8C 5.6         8   Hand1     0.8150
## 9064    8C 5.7         8   Hand1     3.5450
## 9065    8C 5.8         8   Hand1     2.8200
## 9066    8C 6.1         8   Hand1     2.6800
## 9067    8C 6.2         8   Hand1     4.4900
## 9068    8C 6.3         8   Hand1     2.9600
## 9069    8C 6.4         8   Hand1     2.4250
## 9070    8C 6.5         8   Hand1     1.0250
## 9071    8C 6.6         8   Hand1     2.1350
## 9072    8C 6.7         8   Hand1     0.3950
## 9073    8C 6.8         8   Hand1     3.6350
## 9074   16C 1.1        16   Hand1     7.4850
## 9075   16C 1.2        16   Hand1     4.9300
## 9076   16C 1.3        16   Hand1     5.2450
## 9077   16C 1.4        16   Hand1     8.2500
## 9078   16C 1.5        16   Hand1     3.7600
## 9079   16C 1.6        16   Hand1     3.7450
## 9080   16C 1.7        16   Hand1     4.8100
## 9081   16C 1.8        16   Hand1     4.9700
## 9082   16C 1.9        16   Hand1     7.2300
## 9083  16C 1.10        16   Hand1     8.7850
## 9084  16C 1.11        16   Hand1    10.6500
## 9085  16C 1.12        16   Hand1     4.0200
## 9086  16C 1.13        16   Hand1     3.5300
## 9087  16C 1.14        16   Hand1     4.4350
## 9088  16C 1.15        16   Hand1    -1.2650
## 9089  16C 1.16        16   Hand1     5.6100
## 9090   16C 2.1        16   Hand1    12.3000
## 9091   16C 2.2        16   Hand1    13.1150
## 9092   16C 2.3        16   Hand1     5.4025
## 9093   16C 2.4        16   Hand1     5.9600
## 9094   16C 2.5        16   Hand1     3.5900
## 9095   16C 2.6        16   Hand1     3.4650
## 9096   16C 2.7        16   Hand1    -0.5350
## 9097   16C 2.8        16   Hand1     3.0050
## 9098   16C 2.9        16   Hand1     2.1000
## 9099  16C 2.10        16   Hand1     5.3100
## 9100  16C 2.11        16   Hand1     3.9450
## 9101  16C 2.12        16   Hand1     5.7500
## 9102  16C 2.13        16   Hand1     6.5800
## 9103  16C 2.14        16   Hand1     5.5450
## 9104  16C 2.15        16   Hand1    -1.6750
## 9105  16C 2.16        16   Hand1     0.5150
## 9106   16C 3.1        16   Hand1     6.4150
## 9107   16C 3.2        16   Hand1     4.9200
## 9108   16C 3.3        16   Hand1     6.3300
## 9109   16C 3.4        16   Hand1     8.0200
## 9110   16C 3.5        16   Hand1     5.8600
## 9111   16C 3.6        16   Hand1     6.4300
## 9112   16C 3.7        16   Hand1     3.7650
## 9113   16C 3.8        16   Hand1    11.8900
## 9114   16C 3.9        16   Hand1     9.5050
## 9115  16C 3.10        16   Hand1     3.9150
## 9116  16C 3.11        16   Hand1     5.6600
## 9117  16C 3.12        16   Hand1    11.8050
## 9118  16C 3.13        16   Hand1     8.0800
## 9119  16C 3.14        16   Hand1     3.8400
## 9120  16C 3.15        16   Hand1     8.0100
## 9121   16C 4.1        16   Hand1     3.9850
## 9122   16C 4.2        16   Hand1     2.7600
## 9123   16C 4.3        16   Hand1     1.0700
## 9124   16C 4.4        16   Hand1     5.4950
## 9125   16C 4.5        16   Hand1     2.3250
## 9126   16C 4.6        16   Hand1     4.5500
## 9127   16C 4.7        16   Hand1     7.4850
## 9128   16C 4.8        16   Hand1     7.1400
## 9129   16C 4.9        16   Hand1     5.5750
## 9130  16C 4.10        16   Hand1     6.0700
## 9131  16C 4.11        16   Hand1     6.7450
## 9132  16C 4.12        16   Hand1     3.5850
## 9133  16C 4.13        16   Hand1     3.2850
## 9134  16C 4.14        16   Hand1     6.1250
## 9135  16C 4.15        16   Hand1     8.0150
## 9136  16C 4.16        16   Hand1     5.2250
## 9137   16C 5.1        16   Hand1     6.5850
## 9138   16C 5.2        16   Hand1     7.4900
## 9139   16C 5.3        16   Hand1     5.5850
## 9140   16C 5.4        16   Hand1    11.9550
## 9141   16C 5.5        16   Hand1     2.0450
## 9142   16C 5.6        16   Hand1     3.8500
## 9143   16C 5.7        16   Hand1     3.2250
## 9144   16C 5.8        16   Hand1     7.6500
## 9145   16C 5.9        16   Hand1     5.6900
## 9146  16C 5.10        16   Hand1    11.5100
## 9147  16C 5.11        16   Hand1     4.6400
## 9148  16C 5.12        16   Hand1     3.9700
## 9149   32C 1.1        32   Hand1     7.5350
## 9150   32C 1.2        32   Hand1     7.0350
## 9151   32C 1.3        32   Hand1     6.0050
## 9152   32C 1.4        32   Hand1    11.3550
## 9153   32C 1.5        32   Hand1     8.9200
## 9154   32C 1.6        32   Hand1    12.6150
## 9155   32C 1.7        32   Hand1    13.4350
## 9156   32C 1.8        32   Hand1     9.9600
## 9157   32C 1.9        32   Hand1     6.6800
## 9158  32C 1.10        32   Hand1     4.9250
## 9159  32C 1.11        32   Hand1    11.6750
## 9160  32C 1.12        32   Hand1     7.4800
## 9161  32C 1.13        32   Hand1     7.6100
## 9162  32C 1.14        32   Hand1    13.2150
## 9163  32C 1.15        32   Hand1     9.0350
## 9164  32C 1.16        32   Hand1     6.8950
## 9165  32C 1.17        32   Hand1     7.3700
## 9166  32C 1.18        32   Hand1    13.7550
## 9167  32C 1.19        32   Hand1    11.6550
## 9168  32C 1.20        32   Hand1    11.2700
## 9169  32C 1.21        32   Hand1     5.0400
## 9170   32C 2.1        32   Hand1    11.2450
## 9171   32C 2.2        32   Hand1    14.8150
## 9172   32C 2.3        32   Hand1     7.5800
## 9173   32C 2.4        32   Hand1     4.8600
## 9174   32C 2.5        32   Hand1     8.7900
## 9175   32C 2.6        32   Hand1    10.1700
## 9176   32C 2.7        32   Hand1     6.0250
## 9177   32C 2.8        32   Hand1    10.4750
## 9178   32C 2.9        32   Hand1     5.6250
## 9179  32C 2.10        32   Hand1    10.5250
## 9180  32C 2.11        32   Hand1    13.5550
## 9181  32C 2.12        32   Hand1    14.2150
## 9182  32C 2.13        32   Hand1    14.1500
## 9183  32C 2.14        32   Hand1     6.5750
## 9184  32C 2.15        32   Hand1     4.7100
## 9185  32C 2.16        32   Hand1     4.8900
## 9186   32C 3.1        32   Hand1     5.8850
## 9187   32C 3.2        32   Hand1    10.4900
## 9188   32C 3.3        32   Hand1    11.8100
## 9189   32C 3.4        32   Hand1    14.4400
## 9190   32C 3.5        32   Hand1    13.7850
## 9191   32C 3.6        32   Hand1     7.9700
## 9192   32C 3.7        32   Hand1     7.1000
## 9193   32C 3.8        32   Hand1    11.9000
## 9194   32C 4.1        32   Hand1     4.8650
## 9195   32C 4.2        32   Hand1     9.6150
## 9196   32C 4.3        32   Hand1     8.4200
## 9197   32C 4.4        32   Hand1     6.6600
## 9198   32C 4.5        32   Hand1     7.7850
## 9199   32C 4.6        32   Hand1     7.1725
## 9200   32C 4.7        32   Hand1    13.8100
## 9201   32C 4.8        32   Hand1     6.4000
## 9202  32C 4.10        32   Hand1     9.3750
## 9203  32C 4.11        32   Hand1     3.2450
## 9204  32C 4.12        32   Hand1    12.3050
## 9205  32C 4.13        32   Hand1     4.1100
## 9206  32C 4.14        32   Hand1     6.8500
## 9207  32C 4.15        32   Hand1    14.1050
## 9208  32C 4.16        32   Hand1    12.3100
## 9209  32C 4.17        32   Hand1     8.7600
## 9210  32C 4.18        32   Hand1     8.1750
## 9211  32C 4.19        32   Hand1     9.2550
## 9212  32C 4.20        32   Hand1     3.7650
## 9213  32C 4.21        32   Hand1     8.0750
## 9214  32C 4.22        32   Hand1    10.8400
## 9215  32C 4.23        32   Hand1     8.2500
## 9216  32C 4.24        32   Hand1     7.3800
## 9217   32C 5.1        32   Hand1    12.7400
## 9218   32C 5.2        32   Hand1     9.0900
## 9219   32C 5.3        32   Hand1    11.9650
## 9220   32C 5.4        32   Hand1     6.4100
## 9221   32C 5.5        32   Hand1     1.2550
## 9222   32C 5.6        32   Hand1     5.8850
## 9223   32C 5.7        32   Hand1     9.3900
## 9224   32C 5.8        32   Hand1     8.4650
## 9225   32C 5.9        32   Hand1    10.8300
## 9226  32C 5.10        32   Hand1    12.9700
## 9227  32C 5.11        32   Hand1     9.8000
## 9228  32C 5.12        32   Hand1     7.6550
## 9229  32C 5.13        32   Hand1    11.5100
## 9230  32C 5.14        32   Hand1     4.0100
## 9231  32C 5.15        32   Hand1     5.0450
## 9232  32C 5.16        32   Hand1     3.5050
## 9233  32C 5.17        32   Hand1     8.1800
## 9234  32C 5.18        32   Hand1    14.2750
## 9235  32C 5.19        32   Hand1     3.7500
## 9236  32C 5.20        32   Hand1     7.6950
## 9237  32C 5.21        32   Hand1    14.4400
## 9238  32C 5.22        32   Hand1     7.7750
## 9239  32C 5.23        32   Hand1    11.0450
## 9240   32C 6.1        32   Hand1     0.8750
## 9241   32C 6.2        32   Hand1     6.6900
## 9242   32C 6.3        32   Hand1    15.2850
## 9243   32C 6.4        32   Hand1     8.5800
## 9244   32C 6.6        32   Hand1     5.6400
## 9245   32C 6.7        32   Hand1     7.6200
## 9246   32C 7.1        32   Hand1     8.6900
## 9247   32C 7.2        32   Hand1    11.9550
## 9248   32C 7.3        32   Hand1    12.0850
## 9249   32C 7.4        32   Hand1     6.4050
## 9250   32C 7.5        32   Hand1    12.4750
## 9251   32C 7.6        32   Hand1     9.9500
## 9252   32C 7.8        32   Hand1     9.9100
## 9253   32C 8.1        32   Hand1    11.5100
## 9254   32C 8.2        32   Hand1     8.3900
## 9255   32C 8.4        32   Hand1     7.2050
## 9256   32C 8.5        32   Hand1     7.5200
## 9257   32C 8.6        32   Hand1     5.1200
## 9258   64C 1.1        64   Hand1     8.1050
## 9259   64C 1.2        64   Hand1    11.3550
## 9260   64C 1.3        64   Hand1     8.4100
## 9261   64C 1.4        64   Hand1     6.0550
## 9262   64C 1.5        64   Hand1    13.4350
## 9263   64C 1.6        64   Hand1     3.3000
## 9264   64C 1.7        64   Hand1    13.8600
## 9265   64C 1.8        64   Hand1     4.3350
## 9266   64C 1.9        64   Hand1     5.7850
## 9267  64C 1.10        64   Hand1     9.2000
## 9268  64C 1.11        64   Hand1    11.7300
## 9269  64C 1.12        64   Hand1     8.8450
## 9270  64C 1.13        64   Hand1    13.8250
## 9271  64C 1.14        64   Hand1    12.7650
## 9272  64C 1.15        64   Hand1    13.1700
## 9273  64C 1.16        64   Hand1     6.9550
## 9274  64C 1.17        64   Hand1     8.5050
## 9275  64C 1.18        64   Hand1    11.2700
## 9276  64C 1.19        64   Hand1    11.3700
## 9277  64C 1.20        64   Hand1     5.3850
## 9278  64C 1.21        64   Hand1    10.7050
## 9279  64C 1.22        64   Hand1     7.4900
## 9280  64C 1.23        64   Hand1     7.2500
## 9281  64C 1.24        64   Hand1    11.2700
## 9282  64C 1.25        64   Hand1    13.1900
## 9283  64C 1.26        64   Hand1     5.4650
## 9284  64C 1.27        64   Hand1     4.8250
## 9285  64C 1.28        64   Hand1    12.1450
## 9286  64C 1.29        64   Hand1     4.3350
## 9287  64C 1.30        64   Hand1     7.9250
## 9288  64C 1.31        64   Hand1     7.6150
## 9289  64C 1.32        64   Hand1     9.2400
## 9290  64C 1.33        64   Hand1    13.2550
## 9291  64C 1.34        64   Hand1     7.3100
## 9292  64C 1.35        64   Hand1     6.6800
## 9293  64C 1.36        64   Hand1    10.7750
## 9294  64C 1.37        64   Hand1     5.0500
## 9295  64C 1.38        64   Hand1     6.8600
## 9296  64C 1.39        64   Hand1     9.1700
## 9297  64C 1.40        64   Hand1    13.7850
## 9298  64C 1.41        64   Hand1     9.3200
## 9299  64C 1.42        64   Hand1     6.5500
## 9300  64C 1.43        64   Hand1    11.9000
## 9301  64C 1.44        64   Hand1     5.5350
## 9302  64C 1.45        64   Hand1     4.3250
## 9303  64C 1.46        64   Hand1    12.5800
## 9304  64C 1.47        64   Hand1     7.0100
## 9305  64C 1.48        64   Hand1    13.1150
## 9306   64C 2.1        64   Hand1     7.5625
## 9307   64C 2.2        64   Hand1    13.8100
## 9308   64C 2.3        64   Hand1    11.9800
## 9309   64C 2.4        64   Hand1     5.8750
## 9310   64C 2.5        64   Hand1    10.6250
## 9311   64C 2.6        64   Hand1    12.3050
## 9312   64C 2.7        64   Hand1    10.4200
## 9313   64C 2.8        64   Hand1     7.9200
## 9314   64C 2.9        64   Hand1    14.1050
## 9315  64C 2.10        64   Hand1    12.3100
## 9316  64C 2.11        64   Hand1    12.9800
## 9317  64C 2.12        64   Hand1     8.8950
## 9318  64C 2.13        64   Hand1     5.4650
## 9319  64C 2.14        64   Hand1     4.1450
## 9320  64C 2.15        64   Hand1    12.6350
## 9321  64C 2.16        64   Hand1     4.9900
## 9322  64C 2.17        64   Hand1     6.6200
## 9323  64C 2.18        64   Hand1    13.7200
## 9324  64C 2.19        64   Hand1     6.7700
## 9325  64C 2.20        64   Hand1    13.5000
## 9326  64C 2.21        64   Hand1     7.5850
## 9327  64C 2.22        64   Hand1    11.8900
## 9328  64C 2.23        64   Hand1     5.0250
## 9329  64C 2.24        64   Hand1     7.6550
## 9330  64C 2.25        64   Hand1     9.3900
## 9331   64C 3.1        64   Hand1    10.2550
## 9332   64C 3.2        64   Hand1     8.7200
## 9333   64C 3.3        64   Hand1    12.9700
## 9334   64C 3.4        64   Hand1    10.8000
## 9335   64C 3.5        64   Hand1     7.0650
## 9336   64C 3.6        64   Hand1    11.5100
## 9337   64C 3.7        64   Hand1     7.6500
## 9338   64C 3.8        64   Hand1    11.3150
## 9339   64C 4.1        64   Hand1    11.0750
## 9340  64C 4.1b        64   Hand1     8.1200
## 9341   64C 4.2        64   Hand1    14.2750
## 9342   64C 4.3        64   Hand1     6.8300
## 9343   64C 4.4        64   Hand1     9.0250
## 9344   64C 4.5        64   Hand1    10.9400
## 9345   64C 4.6        64   Hand1    11.8250
## 9346   64C 4.7        64   Hand1    11.0450
## 9347   64C 4.8        64   Hand1     9.8950
## 9348   64C 4.9        64   Hand1    11.5850
## 9349  64C 4.10        64   Hand1    15.2850
## 9350  64C 4.11        64   Hand1     7.0650
## 9351  64C 4.12        64   Hand1    12.3750
## 9352  64C 4.13        64   Hand1    14.8800
## 9353  64C 4.14        64   Hand1    13.5150
## 9354  64C 4.15        64   Hand1     7.0250
## 9355  64C 4.16        64   Hand1    12.0850
## 9356  64C 4.17        64   Hand1    12.4100
## 9357  64C 4.18        64   Hand1    12.4750
## 9358  64C 4.19        64   Hand1    13.4600
## 9359  64C 4.20        64   Hand1    13.4100
## 9360  64C 4.21        64   Hand1    11.5100
## 9361  64C 4.22        64   Hand1    13.9100
## 9362  64C 4.23        64   Hand1    13.7500
## 9363  64C 4.24        64   Hand1     7.9450
## 9364  64C 4.25        64   Hand1    11.4450
## 9365  64C 4.26        64   Hand1     8.5250
## 9366  64C 4.27        64   Hand1    11.3550
## 9367  64C 4.28        64   Hand1    14.2400
## 9368  64C 4.29        64   Hand1     6.8150
## 9369  64C 4.30        64   Hand1    13.4350
## 9370  64C 4.31        64   Hand1     3.9200
## 9371  64C 4.32        64   Hand1    13.8600
## 9372  64C 4.33        64   Hand1     5.4050
## 9373  64C 4.34        64   Hand1    11.6750
## 9374  64C 4.35        64   Hand1     8.0900
## 9375  64C 4.36        64   Hand1    11.7300
## 9376  64C 4.37        64   Hand1     7.6750
## 9377  64C 4.38        64   Hand1     8.8550
## 9378  64C 4.39        64   Hand1    12.7650
## 9379   64C 5.1        64   Hand1    13.1700
## 9380   64C 5.2        64   Hand1    13.7550
## 9381   64C 5.3        64   Hand1    11.6550
## 9382   64C 5.4        64   Hand1    11.2700
## 9383   64C 5.5        64   Hand1     6.2300
## 9384   64C 5.6        64   Hand1    11.2450
## 9385   64C 5.7        64   Hand1    14.8150
## 9386   64C 5.8        64   Hand1    10.0900
## 9387   64C 5.9        64   Hand1    13.3900
## 9388  64C 5.10        64   Hand1    13.9800
## 9389  64C 5.11        64   Hand1     6.9800
## 9390  64C 5.12        64   Hand1     5.7350
## 9391  64C 5.13        64   Hand1    10.4750
## 9392  64C 5.14        64   Hand1     8.3150
## 9393  64C 5.15        64   Hand1     5.1250
## 9394  64C 5.16        64   Hand1     7.8150
## 9395   64C 6.1        64   Hand1    11.0850
## 9396   64C 6.2        64   Hand1     8.3100
## 9397   64C 6.3        64   Hand1    13.2550
## 9398   64C 6.4        64   Hand1     6.4500
## 9399   64C 6.5        64   Hand1    11.2700
## 9400   64C 6.6        64   Hand1     5.3050
## 9401   64C 6.7        64   Hand1     5.7000
## 9402   64C 6.8        64   Hand1     6.9100
## 9403   64C 7.1        64   Hand1     9.2600
## 9404   64C 7.2        64   Hand1    13.7850
## 9405   64C 7.3        64   Hand1    13.4000
## 9406   64C 7.4        64   Hand1     7.3700
## 9407   64C 7.5        64   Hand1    11.9000
## 9408   64C 7.6        64   Hand1    10.9850
## 9409   64C 7.7        64   Hand1     4.7350
## 9410   64C 7.8        64   Hand1    12.5800
## 9411   64C 7.9        64   Hand1    12.3000
## 9412  64C 7.10        64   Hand1    13.1150
## 9413  64C 7.11        64   Hand1    13.6125
## 9414  64C 7.12        64   Hand1    13.8100
## 9415  64C 7.13        64   Hand1    11.9800
## 9416  64C 7.14        64   Hand1    12.8450
## 9417    2C 1.1         2   Hnf4a     6.1350
## 9418    2C 1.2         2   Hnf4a     8.1800
## 9419    2C 2.1         2   Hnf4a     6.2450
## 9420    2C 2.2         2   Hnf4a     8.2250
## 9421    2C 3.1         2   Hnf4a     8.5800
## 9422    2C 3.2         2   Hnf4a    12.7325
## 9423    2C 4.1         2   Hnf4a     9.3750
## 9424    2C 5.1         2   Hnf4a     7.6550
## 9425    2C 5.2         2   Hnf4a     7.0900
## 9426    2C 6.1         2   Hnf4a    10.4750
## 9427    2C 6.2         2   Hnf4a    12.3650
## 9428    2C 7.1         2   Hnf4a     7.1650
## 9429    2C 7.2         2   Hnf4a     7.2450
## 9430    2C 8.1         2   Hnf4a     7.5450
## 9431    2C 8.2         2   Hnf4a     6.4400
## 9432    2C 9.1         2   Hnf4a    14.3950
## 9433    2C 9.2         2   Hnf4a    13.1550
## 9434   2C 10.1         2   Hnf4a     5.8900
## 9435   2C 10.2         2   Hnf4a     5.2450
## 9436    4C 1.1         4   Hnf4a     6.6800
## 9437    4C 1.2         4   Hnf4a    10.3450
## 9438    4C 1.3         4   Hnf4a     9.4750
## 9439    4C 1.4         4   Hnf4a    14.0950
## 9440    4C 2.1         4   Hnf4a    12.8700
## 9441    4C 2.2         4   Hnf4a    15.0900
## 9442    4C 2.3         4   Hnf4a    14.0750
## 9443    4C 3.1         4   Hnf4a     9.1850
## 9444    4C 3.2         4   Hnf4a    10.5950
## 9445    4C 3.3         4   Hnf4a    11.2950
## 9446    4C 3.4         4   Hnf4a    10.8700
## 9447    4C 4.1         4   Hnf4a    12.5350
## 9448    4C 4.2         4   Hnf4a    13.9250
## 9449    4C 4.3         4   Hnf4a    12.1200
## 9450    4C 4.4         4   Hnf4a    13.1350
## 9451    4C 5.1         4   Hnf4a    10.9200
## 9452    4C 5.2         4   Hnf4a    11.9200
## 9453    4C 5.3         4   Hnf4a    11.9500
## 9454    4C 5.4         4   Hnf4a    12.4350
## 9455    4C 6.1         4   Hnf4a    10.6400
## 9456    4C 6.2         4   Hnf4a    14.3400
## 9457    4C 6.3         4   Hnf4a    13.3150
## 9458    4C 6.4         4   Hnf4a    12.6950
## 9459    8C 1.1         8   Hnf4a    14.4300
## 9460    8C 1.2         8   Hnf4a    13.4450
## 9461    8C 1.3         8   Hnf4a    11.9400
## 9462    8C 1.4         8   Hnf4a    11.1700
## 9463    8C 1.5         8   Hnf4a    11.8150
## 9464    8C 2.1         8   Hnf4a    12.2600
## 9465    8C 2.2         8   Hnf4a    13.5550
## 9466    8C 2.3         8   Hnf4a    13.5000
## 9467    8C 2.4         8   Hnf4a    13.2900
## 9468    8C 2.5         8   Hnf4a    14.0200
## 9469    8C 2.6         8   Hnf4a    13.0200
## 9470    8C 2.7         8   Hnf4a    12.1900
## 9471    8C 2.8         8   Hnf4a    11.5150
## 9472    8C 3.1         8   Hnf4a    12.3600
## 9473    8C 3.2         8   Hnf4a    11.6750
## 9474    8C 3.3         8   Hnf4a    15.0050
## 9475    8C 3.4         8   Hnf4a    13.3050
## 9476    8C 3.5         8   Hnf4a    13.6650
## 9477    8C 3.6         8   Hnf4a    15.9200
## 9478    8C 3.7         8   Hnf4a    12.7750
## 9479    8C 3.8         8   Hnf4a    11.7950
## 9480    8C 4.2         8   Hnf4a     9.5250
## 9481    8C 4.3         8   Hnf4a    13.1700
## 9482    8C 4.4         8   Hnf4a    11.3100
## 9483    8C 4.5         8   Hnf4a    14.0950
## 9484    8C 4.6         8   Hnf4a    14.0350
## 9485    8C 4.7         8   Hnf4a    11.7500
## 9486    8C 5.1         8   Hnf4a    13.7500
## 9487    8C 5.2         8   Hnf4a    14.7950
## 9488    8C 5.3         8   Hnf4a    11.7000
## 9489    8C 5.4         8   Hnf4a    11.3000
## 9490    8C 5.5         8   Hnf4a    12.3250
## 9491    8C 5.6         8   Hnf4a    11.6700
## 9492    8C 5.7         8   Hnf4a    14.3350
## 9493    8C 5.8         8   Hnf4a    13.7550
## 9494    8C 6.1         8   Hnf4a    12.5350
## 9495    8C 6.2         8   Hnf4a    13.8350
## 9496    8C 6.3         8   Hnf4a    12.9500
## 9497    8C 6.4         8   Hnf4a    12.4350
## 9498    8C 6.5         8   Hnf4a    11.5450
## 9499    8C 6.6         8   Hnf4a    13.9600
## 9500    8C 6.7         8   Hnf4a    12.4050
## 9501    8C 6.8         8   Hnf4a    10.7450
## 9502   16C 1.1        16   Hnf4a    13.9300
## 9503   16C 1.2        16   Hnf4a    13.4500
## 9504   16C 1.3        16   Hnf4a    13.0850
## 9505   16C 1.4        16   Hnf4a    12.2750
## 9506   16C 1.5        16   Hnf4a     7.2300
## 9507   16C 1.6        16   Hnf4a    11.5800
## 9508   16C 1.7        16   Hnf4a    11.6000
## 9509   16C 1.8        16   Hnf4a    12.6300
## 9510   16C 1.9        16   Hnf4a    13.2800
## 9511  16C 1.10        16   Hnf4a    12.2975
## 9512  16C 1.11        16   Hnf4a    12.7250
## 9513  16C 1.12        16   Hnf4a    12.0700
## 9514  16C 1.13        16   Hnf4a    12.1200
## 9515  16C 1.14        16   Hnf4a    11.2750
## 9516  16C 1.15        16   Hnf4a     9.0650
## 9517  16C 1.16        16   Hnf4a    12.8250
## 9518   16C 2.1        16   Hnf4a    13.2950
## 9519   16C 2.2        16   Hnf4a    13.6250
## 9520   16C 2.3        16   Hnf4a    12.0575
## 9521   16C 2.4        16   Hnf4a    14.2550
## 9522   16C 2.5        16   Hnf4a    12.2000
## 9523   16C 2.6        16   Hnf4a     9.9500
## 9524   16C 2.7        16   Hnf4a    10.3550
## 9525   16C 2.8        16   Hnf4a    12.1400
## 9526   16C 2.9        16   Hnf4a    10.7950
## 9527  16C 2.10        16   Hnf4a    12.8150
## 9528  16C 2.11        16   Hnf4a    13.5600
## 9529  16C 2.12        16   Hnf4a    12.7325
## 9530  16C 2.13        16   Hnf4a    11.2850
## 9531  16C 2.14        16   Hnf4a    11.6150
## 9532  16C 2.15        16   Hnf4a    12.4200
## 9533  16C 2.16        16   Hnf4a    10.4750
## 9534   16C 3.1        16   Hnf4a     7.4750
## 9535   16C 3.2        16   Hnf4a    11.6550
## 9536   16C 3.3        16   Hnf4a    12.8950
## 9537   16C 3.4        16   Hnf4a    13.8650
## 9538   16C 3.5        16   Hnf4a    12.5000
## 9539   16C 3.6        16   Hnf4a    14.3950
## 9540   16C 3.7        16   Hnf4a    13.1550
## 9541   16C 3.8        16   Hnf4a    11.4100
## 9542   16C 3.9        16   Hnf4a     9.5850
## 9543  16C 3.10        16   Hnf4a    10.6800
## 9544  16C 3.11        16   Hnf4a    10.3450
## 9545  16C 3.12        16   Hnf4a    13.4050
## 9546  16C 3.13        16   Hnf4a    14.0950
## 9547  16C 3.14        16   Hnf4a    12.8700
## 9548  16C 3.15        16   Hnf4a    15.0900
## 9549   16C 4.1        16   Hnf4a    14.0750
## 9550   16C 4.2        16   Hnf4a     9.1850
## 9551   16C 4.3        16   Hnf4a    10.5950
## 9552   16C 4.4        16   Hnf4a    11.2950
## 9553   16C 4.5        16   Hnf4a    10.8700
## 9554   16C 4.6        16   Hnf4a    12.5350
## 9555   16C 4.7        16   Hnf4a    13.9250
## 9556   16C 4.8        16   Hnf4a    12.1200
## 9557   16C 4.9        16   Hnf4a    13.1350
## 9558  16C 4.10        16   Hnf4a    13.9900
## 9559  16C 4.11        16   Hnf4a    11.9200
## 9560  16C 4.12        16   Hnf4a    11.9500
## 9561  16C 4.13        16   Hnf4a     8.1350
## 9562  16C 4.14        16   Hnf4a    10.6400
## 9563  16C 4.15        16   Hnf4a    14.3400
## 9564  16C 4.16        16   Hnf4a    13.3150
## 9565   16C 5.1        16   Hnf4a    12.6950
## 9566   16C 5.2        16   Hnf4a    14.4300
## 9567   16C 5.3        16   Hnf4a    13.4450
## 9568   16C 5.4        16   Hnf4a    11.9400
## 9569   16C 5.5        16   Hnf4a    11.1700
## 9570   16C 5.6        16   Hnf4a     9.1850
## 9571   16C 5.7        16   Hnf4a    12.2600
## 9572   16C 5.8        16   Hnf4a    13.5550
## 9573   16C 5.9        16   Hnf4a    13.5000
## 9574  16C 5.10        16   Hnf4a    13.2900
## 9575  16C 5.11        16   Hnf4a    14.0200
## 9576  16C 5.12        16   Hnf4a     8.3200
## 9577   32C 1.1        32   Hnf4a    12.1900
## 9578   32C 1.2        32   Hnf4a     3.7550
## 9579   32C 1.3        32   Hnf4a    12.3600
## 9580   32C 1.4        32   Hnf4a     9.0150
## 9581   32C 1.5        32   Hnf4a    11.5450
## 9582   32C 1.6        32   Hnf4a     7.2450
## 9583   32C 1.7        32   Hnf4a    13.6650
## 9584   32C 1.8        32   Hnf4a    10.9600
## 9585   32C 1.9        32   Hnf4a     4.5450
## 9586  32C 1.10        32   Hnf4a     8.1050
## 9587  32C 1.11        32   Hnf4a     9.5250
## 9588  32C 1.12        32   Hnf4a    13.1700
## 9589  32C 1.13        32   Hnf4a    11.3100
## 9590  32C 1.14        32   Hnf4a    14.0950
## 9591  32C 1.15        32   Hnf4a     7.0750
## 9592  32C 1.16        32   Hnf4a     4.1100
## 9593  32C 1.17        32   Hnf4a    10.1300
## 9594  32C 1.18        32   Hnf4a     8.9850
## 9595  32C 1.19        32   Hnf4a     6.8300
## 9596  32C 1.20        32   Hnf4a     6.3200
## 9597  32C 1.21        32   Hnf4a     5.7850
## 9598   32C 2.1        32   Hnf4a     5.1900
## 9599   32C 2.2        32   Hnf4a    14.3350
## 9600   32C 2.3        32   Hnf4a    13.7550
## 9601   32C 2.4        32   Hnf4a     4.4250
## 9602   32C 2.5        32   Hnf4a     6.9050
## 9603   32C 2.6        32   Hnf4a    12.9500
## 9604   32C 2.7        32   Hnf4a     6.5950
## 9605   32C 2.8        32   Hnf4a     5.1350
## 9606   32C 2.9        32   Hnf4a    13.9600
## 9607  32C 2.10        32   Hnf4a    11.0750
## 9608  32C 2.11        32   Hnf4a    11.0650
## 9609  32C 2.12        32   Hnf4a    13.9300
## 9610  32C 2.13        32   Hnf4a     7.2800
## 9611  32C 2.14        32   Hnf4a     6.5750
## 9612  32C 2.15        32   Hnf4a     3.6650
## 9613  32C 2.16        32   Hnf4a     4.8100
## 9614   32C 3.1        32   Hnf4a    11.5800
## 9615   32C 3.2        32   Hnf4a     6.4500
## 9616   32C 3.3        32   Hnf4a     7.2800
## 9617   32C 3.4        32   Hnf4a     9.6400
## 9618   32C 3.5        32   Hnf4a    12.2975
## 9619   32C 3.6        32   Hnf4a     7.4350
## 9620   32C 3.7        32   Hnf4a     6.6200
## 9621   32C 3.8        32   Hnf4a     7.0800
## 9622   32C 4.1        32   Hnf4a     6.5050
## 9623   32C 4.2        32   Hnf4a     9.0650
## 9624   32C 4.3        32   Hnf4a     7.8650
## 9625   32C 4.4        32   Hnf4a    10.2150
## 9626   32C 4.5        32   Hnf4a    13.6250
## 9627   32C 4.6        32   Hnf4a     5.5475
## 9628   32C 4.7        32   Hnf4a    14.2550
## 9629   32C 4.8        32   Hnf4a     7.9200
## 9630  32C 4.10        32   Hnf4a     7.6800
## 9631  32C 4.11        32   Hnf4a     8.0750
## 9632  32C 4.12        32   Hnf4a    12.1400
## 9633  32C 4.13        32   Hnf4a    10.7950
## 9634  32C 4.14        32   Hnf4a     9.0050
## 9635  32C 4.15        32   Hnf4a     5.8300
## 9636  32C 4.16        32   Hnf4a    12.7325
## 9637  32C 4.17        32   Hnf4a    13.5650
## 9638  32C 4.18        32   Hnf4a    11.6150
## 9639  32C 4.19        32   Hnf4a     7.8700
## 9640  32C 4.20        32   Hnf4a    10.4750
## 9641  32C 4.21        32   Hnf4a     7.4550
## 9642  32C 4.22        32   Hnf4a     5.0250
## 9643  32C 4.23        32   Hnf4a    12.8950
## 9644  32C 4.24        32   Hnf4a    13.8650
## 9645   32C 5.1        32   Hnf4a    12.5000
## 9646   32C 5.2        32   Hnf4a    12.4150
## 9647   32C 5.3        32   Hnf4a     7.3250
## 9648   32C 5.4        32   Hnf4a     7.7100
## 9649   32C 5.5        32   Hnf4a     5.5050
## 9650   32C 5.6        32   Hnf4a    10.6800
## 9651   32C 5.7        32   Hnf4a    10.3450
## 9652   32C 5.8        32   Hnf4a     7.8250
## 9653   32C 5.9        32   Hnf4a    14.0950
## 9654  32C 5.10        32   Hnf4a     7.3800
## 9655  32C 5.11        32   Hnf4a    15.0900
## 9656  32C 5.12        32   Hnf4a    14.0750
## 9657  32C 5.13        32   Hnf4a     9.1850
## 9658  32C 5.14        32   Hnf4a    10.5950
## 9659  32C 5.15        32   Hnf4a     7.1850
## 9660  32C 5.16        32   Hnf4a    10.8700
## 9661  32C 5.17        32   Hnf4a    12.5350
## 9662  32C 5.18        32   Hnf4a    13.9250
## 9663  32C 5.19        32   Hnf4a     4.4600
## 9664  32C 5.20        32   Hnf4a    13.1350
## 9665  32C 5.21        32   Hnf4a    13.9900
## 9666  32C 5.22        32   Hnf4a    11.9200
## 9667  32C 5.23        32   Hnf4a    11.9500
## 9668   32C 6.1        32   Hnf4a     3.7000
## 9669   32C 6.2        32   Hnf4a     3.2200
## 9670   32C 6.3        32   Hnf4a    14.3400
## 9671   32C 6.4        32   Hnf4a     6.7500
## 9672   32C 6.6        32   Hnf4a    12.6950
## 9673   32C 6.7        32   Hnf4a    14.4300
## 9674   32C 7.1        32   Hnf4a     9.5750
## 9675   32C 7.2        32   Hnf4a     4.4750
## 9676   32C 7.3        32   Hnf4a    11.1700
## 9677   32C 7.4        32   Hnf4a    11.8150
## 9678   32C 7.5        32   Hnf4a    12.2600
## 9679   32C 7.6        32   Hnf4a     6.8600
## 9680   32C 7.8        32   Hnf4a    13.5000
## 9681   32C 8.1        32   Hnf4a    13.2900
## 9682   32C 8.2        32   Hnf4a    14.0200
## 9683   32C 8.4        32   Hnf4a     8.4650
## 9684   32C 8.5        32   Hnf4a     5.4800
## 9685   32C 8.6        32   Hnf4a    11.5150
## 9686   64C 1.1        64   Hnf4a     5.5800
## 9687   64C 1.2        64   Hnf4a    11.6750
## 9688   64C 1.3        64   Hnf4a    15.0050
## 9689   64C 1.4        64   Hnf4a     7.2550
## 9690   64C 1.5        64   Hnf4a     6.2950
## 9691   64C 1.6        64   Hnf4a    10.4600
## 9692   64C 1.7        64   Hnf4a     7.8150
## 9693   64C 1.8        64   Hnf4a    11.7950
## 9694   64C 1.9        64   Hnf4a     4.2250
## 9695  64C 1.10        64   Hnf4a    13.1700
## 9696  64C 1.11        64   Hnf4a     8.3300
## 9697  64C 1.12        64   Hnf4a    14.0950
## 9698  64C 1.13        64   Hnf4a    14.0350
## 9699  64C 1.14        64   Hnf4a    11.7500
## 9700  64C 1.15        64   Hnf4a    13.7500
## 9701  64C 1.16        64   Hnf4a    14.7950
## 9702  64C 1.17        64   Hnf4a    11.7000
## 9703  64C 1.18        64   Hnf4a    11.3000
## 9704  64C 1.19        64   Hnf4a    12.3250
## 9705  64C 1.20        64   Hnf4a    11.6700
## 9706  64C 1.21        64   Hnf4a     9.1350
## 9707  64C 1.22        64   Hnf4a    12.8450
## 9708  64C 1.23        64   Hnf4a    12.5350
## 9709  64C 1.24        64   Hnf4a    13.8350
## 9710  64C 1.25        64   Hnf4a    12.9500
## 9711  64C 1.26        64   Hnf4a     6.7050
## 9712  64C 1.27        64   Hnf4a    11.5450
## 9713  64C 1.28        64   Hnf4a    13.9600
## 9714  64C 1.29        64   Hnf4a    12.4050
## 9715  64C 1.30        64   Hnf4a    14.1050
## 9716  64C 1.31        64   Hnf4a    13.9300
## 9717  64C 1.32        64   Hnf4a    13.4500
## 9718  64C 1.33        64   Hnf4a    13.0850
## 9719  64C 1.34        64   Hnf4a    12.2750
## 9720  64C 1.35        64   Hnf4a    11.7900
## 9721  64C 1.36        64   Hnf4a    11.5800
## 9722  64C 1.37        64   Hnf4a    11.6000
## 9723  64C 1.38        64   Hnf4a    12.6300
## 9724  64C 1.39        64   Hnf4a    13.2800
## 9725  64C 1.40        64   Hnf4a    12.2975
## 9726  64C 1.41        64   Hnf4a     5.8650
## 9727  64C 1.42        64   Hnf4a     6.6200
## 9728  64C 1.43        64   Hnf4a    12.1200
## 9729  64C 1.44        64   Hnf4a    11.2750
## 9730  64C 1.45        64   Hnf4a     5.6550
## 9731  64C 1.46        64   Hnf4a    12.8250
## 9732  64C 1.47        64   Hnf4a    13.2950
## 9733  64C 1.48        64   Hnf4a    13.6250
## 9734   64C 2.1        64   Hnf4a    12.0575
## 9735   64C 2.2        64   Hnf4a    14.2550
## 9736   64C 2.3        64   Hnf4a    12.2000
## 9737   64C 2.4        64   Hnf4a    12.7000
## 9738   64C 2.5        64   Hnf4a    10.3550
## 9739   64C 2.6        64   Hnf4a    12.1400
## 9740   64C 2.7        64   Hnf4a     8.4650
## 9741   64C 2.8        64   Hnf4a    12.8150
## 9742   64C 2.9        64   Hnf4a    13.5600
## 9743  64C 2.10        64   Hnf4a    12.7325
## 9744  64C 2.11        64   Hnf4a    13.5650
## 9745  64C 2.12        64   Hnf4a    11.6150
## 9746  64C 2.13        64   Hnf4a    12.4200
## 9747  64C 2.14        64   Hnf4a    10.4750
## 9748  64C 2.15        64   Hnf4a    12.3650
## 9749  64C 2.16        64   Hnf4a     9.3750
## 9750  64C 2.17        64   Hnf4a     9.2850
## 9751  64C 2.18        64   Hnf4a    13.8650
## 9752  64C 2.19        64   Hnf4a    12.5000
## 9753  64C 2.20        64   Hnf4a    14.3950
## 9754  64C 2.21        64   Hnf4a    13.1550
## 9755  64C 2.22        64   Hnf4a    11.4100
## 9756  64C 2.23        64   Hnf4a     9.5850
## 9757  64C 2.24        64   Hnf4a    10.6800
## 9758  64C 2.25        64   Hnf4a    10.3450
## 9759   64C 3.1        64   Hnf4a    13.4050
## 9760   64C 3.2        64   Hnf4a    14.0950
## 9761   64C 3.3        64   Hnf4a    12.8700
## 9762   64C 3.4        64   Hnf4a    15.0900
## 9763   64C 3.5        64   Hnf4a     7.9850
## 9764   64C 3.6        64   Hnf4a     9.1850
## 9765   64C 3.7        64   Hnf4a    10.5950
## 9766   64C 3.8        64   Hnf4a    11.2950
## 9767   64C 4.1        64   Hnf4a    10.8700
## 9768  64C 4.1b        64   Hnf4a     5.6250
## 9769   64C 4.2        64   Hnf4a     9.7950
## 9770   64C 4.3        64   Hnf4a    12.1200
## 9771   64C 4.4        64   Hnf4a    13.1350
## 9772   64C 4.5        64   Hnf4a     8.2700
## 9773   64C 4.6        64   Hnf4a    11.9200
## 9774   64C 4.7        64   Hnf4a    11.9500
## 9775   64C 4.8        64   Hnf4a     8.0050
## 9776   64C 4.9        64   Hnf4a    10.6400
## 9777  64C 4.10        64   Hnf4a     7.5000
## 9778  64C 4.11        64   Hnf4a     7.0350
## 9779  64C 4.12        64   Hnf4a    12.6950
## 9780  64C 4.13        64   Hnf4a    14.4300
## 9781  64C 4.14        64   Hnf4a    13.4450
## 9782  64C 4.15        64   Hnf4a    11.9400
## 9783  64C 4.16        64   Hnf4a    11.1700
## 9784  64C 4.17        64   Hnf4a    11.8150
## 9785  64C 4.18        64   Hnf4a    12.2600
## 9786  64C 4.19        64   Hnf4a    13.5550
## 9787  64C 4.20        64   Hnf4a    13.5000
## 9788  64C 4.21        64   Hnf4a    13.2900
## 9789  64C 4.22        64   Hnf4a    14.0200
## 9790  64C 4.23        64   Hnf4a    13.0200
## 9791  64C 4.24        64   Hnf4a    12.1900
## 9792  64C 4.25        64   Hnf4a    11.5150
## 9793  64C 4.26        64   Hnf4a     5.0700
## 9794  64C 4.27        64   Hnf4a    11.6750
## 9795  64C 4.28        64   Hnf4a    15.0050
## 9796  64C 4.29        64   Hnf4a    13.3050
## 9797  64C 4.30        64   Hnf4a    13.6650
## 9798  64C 4.31        64   Hnf4a    15.9200
## 9799  64C 4.32        64   Hnf4a    12.7750
## 9800  64C 4.33        64   Hnf4a    11.7950
## 9801  64C 4.34        64   Hnf4a     9.5250
## 9802  64C 4.35        64   Hnf4a     4.9000
## 9803  64C 4.36        64   Hnf4a    11.3100
## 9804  64C 4.37        64   Hnf4a    14.0950
## 9805  64C 4.38        64   Hnf4a    14.0350
## 9806  64C 4.39        64   Hnf4a     9.0800
## 9807   64C 5.1        64   Hnf4a    13.7500
## 9808   64C 5.2        64   Hnf4a     7.0050
## 9809   64C 5.3        64   Hnf4a     2.8600
## 9810   64C 5.4        64   Hnf4a    11.3000
## 9811   64C 5.5        64   Hnf4a     4.0950
## 9812   64C 5.6        64   Hnf4a     6.3000
## 9813   64C 5.7        64   Hnf4a     5.9250
## 9814   64C 5.8        64   Hnf4a     8.5650
## 9815   64C 5.9        64   Hnf4a     6.5350
## 9816  64C 5.10        64   Hnf4a     5.5150
## 9817  64C 5.11        64   Hnf4a    12.9500
## 9818  64C 5.12        64   Hnf4a    12.4350
## 9819  64C 5.13        64   Hnf4a    11.5450
## 9820  64C 5.14        64   Hnf4a    13.9600
## 9821  64C 5.15        64   Hnf4a    12.4050
## 9822  64C 5.16        64   Hnf4a    14.1050
## 9823   64C 6.1        64   Hnf4a    13.9300
## 9824   64C 6.2        64   Hnf4a     9.4600
## 9825   64C 6.3        64   Hnf4a    13.0850
## 9826   64C 6.4        64   Hnf4a    12.2750
## 9827   64C 6.5        64   Hnf4a    11.7900
## 9828   64C 6.6        64   Hnf4a    11.5800
## 9829   64C 6.7        64   Hnf4a     2.1900
## 9830   64C 6.8        64   Hnf4a     7.5000
## 9831   64C 7.1        64   Hnf4a     6.9000
## 9832   64C 7.2        64   Hnf4a     5.9775
## 9833   64C 7.3        64   Hnf4a     6.5650
## 9834   64C 7.4        64   Hnf4a     7.8100
## 9835   64C 7.5        64   Hnf4a    12.1200
## 9836   64C 7.6        64   Hnf4a    11.2750
## 9837   64C 7.7        64   Hnf4a     9.0650
## 9838   64C 7.8        64   Hnf4a     6.8050
## 9839   64C 7.9        64   Hnf4a     6.0850
## 9840  64C 7.10        64   Hnf4a    13.6250
## 9841  64C 7.11        64   Hnf4a    12.0575
## 9842  64C 7.12        64   Hnf4a    14.2550
## 9843  64C 7.13        64   Hnf4a    12.2000
## 9844  64C 7.14        64   Hnf4a    12.7000
## 9845    2C 1.1         2     Id2     2.2050
## 9846    2C 1.2         2     Id2     6.4250
## 9847    2C 2.1         2     Id2     4.5950
## 9848    2C 2.2         2     Id2     7.9200
## 9849    2C 3.1         2     Id2     7.6250
## 9850    2C 3.2         2     Id2     7.3825
## 9851    2C 4.1         2     Id2    11.1100
## 9852    2C 5.1         2     Id2     8.0800
## 9853    2C 5.2         2     Id2     7.6600
## 9854    2C 6.1         2     Id2     4.8800
## 9855    2C 6.2         2     Id2     4.2750
## 9856    2C 7.1         2     Id2     5.8400
## 9857    2C 7.2         2     Id2     5.6500
## 9858    2C 8.1         2     Id2     6.8050
## 9859    2C 8.2         2     Id2     5.5925
## 9860    2C 9.1         2     Id2     8.2450
## 9861    2C 9.2         2     Id2     8.4250
## 9862   2C 10.1         2     Id2     5.3550
## 9863   2C 10.2         2     Id2     4.5350
## 9864    4C 1.1         4     Id2     7.7250
## 9865    4C 1.2         4     Id2     9.7950
## 9866    4C 1.3         4     Id2     9.3300
## 9867    4C 1.4         4     Id2    13.7500
## 9868    4C 2.1         4     Id2    11.4600
## 9869    4C 2.2         4     Id2    10.1150
## 9870    4C 2.3         4     Id2    13.1300
## 9871    4C 3.1         4     Id2     9.7750
## 9872    4C 3.2         4     Id2    11.2100
## 9873    4C 3.3         4     Id2    11.3750
## 9874    4C 3.4         4     Id2    10.9100
## 9875    4C 4.1         4     Id2    11.7300
## 9876    4C 4.2         4     Id2    12.9150
## 9877    4C 4.3         4     Id2     9.0700
## 9878    4C 4.4         4     Id2    10.5750
## 9879    4C 5.1         4     Id2    13.6100
## 9880    4C 5.2         4     Id2     7.8900
## 9881    4C 5.3         4     Id2     7.0900
## 9882    4C 5.4         4     Id2     6.5550
## 9883    4C 6.1         4     Id2     9.1300
## 9884    4C 6.2         4     Id2    11.3100
## 9885    4C 6.3         4     Id2    12.1900
## 9886    4C 6.4         4     Id2    12.2850
## 9887    8C 1.1         8     Id2    14.0100
## 9888    8C 1.2         8     Id2    13.3200
## 9889    8C 1.3         8     Id2    11.7050
## 9890    8C 1.4         8     Id2     9.1800
## 9891    8C 1.5         8     Id2    11.8950
## 9892    8C 2.1         8     Id2     6.5700
## 9893    8C 2.2         8     Id2    14.7350
## 9894    8C 2.3         8     Id2    11.5400
## 9895    8C 2.4         8     Id2    13.3850
## 9896    8C 2.5         8     Id2    14.8100
## 9897    8C 2.6         8     Id2    14.4450
## 9898    8C 2.7         8     Id2    12.3950
## 9899    8C 2.8         8     Id2    12.1750
## 9900    8C 3.1         8     Id2    12.4150
## 9901    8C 3.2         8     Id2    11.6200
## 9902    8C 3.3         8     Id2    13.4600
## 9903    8C 3.4         8     Id2     8.2750
## 9904    8C 3.5         8     Id2    10.7350
## 9905    8C 3.6         8     Id2    11.0400
## 9906    8C 3.7         8     Id2     8.5850
## 9907    8C 3.8         8     Id2     7.1650
## 9908    8C 4.2         8     Id2    11.5100
## 9909    8C 4.3         8     Id2     7.8200
## 9910    8C 4.4         8     Id2     8.9300
## 9911    8C 4.5         8     Id2    14.3100
## 9912    8C 4.6         8     Id2     9.5750
## 9913    8C 4.7         8     Id2     7.0800
## 9914    8C 5.1         8     Id2     9.7600
## 9915    8C 5.2         8     Id2    14.7300
## 9916    8C 5.3         8     Id2     9.3900
## 9917    8C 5.4         8     Id2     5.8650
## 9918    8C 5.5         8     Id2    11.7400
## 9919    8C 5.6         8     Id2     7.2700
## 9920    8C 5.7         8     Id2    11.9450
## 9921    8C 5.8         8     Id2    12.9600
## 9922    8C 6.1         8     Id2     8.6350
## 9923    8C 6.2         8     Id2    13.2600
## 9924    8C 6.3         8     Id2     8.6900
## 9925    8C 6.4         8     Id2    12.4350
## 9926    8C 6.5         8     Id2    11.5450
## 9927    8C 6.6         8     Id2    10.8650
## 9928    8C 6.7         8     Id2     8.8900
## 9929    8C 6.8         8     Id2    10.9000
## 9930   16C 1.1        16     Id2     9.5750
## 9931   16C 1.2        16     Id2    13.9450
## 9932   16C 1.3        16     Id2     9.6100
## 9933   16C 1.4        16     Id2     2.2700
## 9934   16C 1.5        16     Id2     4.1550
## 9935   16C 1.6        16     Id2     0.4250
## 9936   16C 1.7        16     Id2     3.8150
## 9937   16C 1.8        16     Id2     3.1250
## 9938   16C 1.9        16     Id2     5.4800
## 9939  16C 1.10        16     Id2     7.5650
## 9940  16C 1.11        16     Id2     5.8200
## 9941  16C 1.12        16     Id2     4.8300
## 9942  16C 1.13        16     Id2     4.1250
## 9943  16C 1.14        16     Id2     1.0250
## 9944  16C 1.15        16     Id2    11.5250
## 9945  16C 1.16        16     Id2     4.8050
## 9946   16C 2.1        16     Id2     3.0850
## 9947   16C 2.2        16     Id2     5.9100
## 9948   16C 2.3        16     Id2     4.9150
## 9949   16C 2.4        16     Id2     8.2300
## 9950   16C 2.5        16     Id2     5.8800
## 9951   16C 2.6        16     Id2    -1.7850
## 9952   16C 2.7        16     Id2    10.4450
## 9953   16C 2.8        16     Id2     8.2350
## 9954   16C 2.9        16     Id2     1.9650
## 9955  16C 2.10        16     Id2    13.1800
## 9956  16C 2.11        16     Id2    13.6550
## 9957  16C 2.12        16     Id2     6.7825
## 9958  16C 2.13        16     Id2    12.2800
## 9959  16C 2.14        16     Id2     5.4400
## 9960  16C 2.15        16     Id2    12.2600
## 9961  16C 2.16        16     Id2     6.7300
## 9962   16C 3.1        16     Id2     5.4850
## 9963   16C 3.2        16     Id2     5.4900
## 9964   16C 3.3        16     Id2     4.9700
## 9965   16C 3.4        16     Id2    13.4950
## 9966   16C 3.5        16     Id2    10.0725
## 9967   16C 3.6        16     Id2     8.7950
## 9968   16C 3.7        16     Id2    13.9850
## 9969   16C 3.8        16     Id2     5.7250
## 9970   16C 3.9        16     Id2     9.4650
## 9971  16C 3.10        16     Id2     7.0350
## 9972  16C 3.11        16     Id2     5.1150
## 9973  16C 3.12        16     Id2     7.7900
## 9974  16C 3.13        16     Id2     8.0500
## 9975  16C 3.14        16     Id2    11.4600
## 9976  16C 3.15        16     Id2     8.2850
## 9977   16C 4.1        16     Id2    13.1300
## 9978   16C 4.2        16     Id2     9.9950
## 9979   16C 4.3        16     Id2    11.2100
## 9980   16C 4.4        16     Id2    11.3750
## 9981   16C 4.5        16     Id2     9.7900
## 9982   16C 4.6        16     Id2     9.4600
## 9983   16C 4.7        16     Id2    12.3750
## 9984   16C 4.8        16     Id2     8.7100
## 9985   16C 4.9        16     Id2    13.3950
## 9986  16C 4.10        16     Id2    14.0200
## 9987  16C 4.11        16     Id2     9.9400
## 9988  16C 4.12        16     Id2    11.6300
## 9989  16C 4.13        16     Id2    12.1650
## 9990  16C 4.14        16     Id2     7.2000
## 9991  16C 4.15        16     Id2    14.7500
## 9992  16C 4.16        16     Id2    11.9000
## 9993   16C 5.1        16     Id2     9.4550
## 9994   16C 5.2        16     Id2    12.1100
## 9995   16C 5.3        16     Id2     9.4700
## 9996   16C 5.4        16     Id2     4.7250
## 9997   16C 5.5        16     Id2     6.6300
## 9998   16C 5.6        16     Id2    11.8950
## 9999   16C 5.7        16     Id2     9.8300
## 10000  16C 5.8        16     Id2     8.3250
## 10001  16C 5.9        16     Id2     7.2900
## 10002 16C 5.10        16     Id2    11.0750
## 10003 16C 5.11        16     Id2     7.0300
## 10004 16C 5.12        16     Id2    14.4450
## 10005  32C 1.1        32     Id2     0.9350
## 10006  32C 1.2        32     Id2     8.6050
## 10007  32C 1.3        32     Id2     1.5850
## 10008  32C 1.4        32     Id2     0.1200
## 10009  32C 1.5        32     Id2    13.4600
## 10010  32C 1.6        32     Id2    12.9150
## 10011  32C 1.7        32     Id2     2.4450
## 10012  32C 1.8        32     Id2    14.6800
## 10013  32C 1.9        32     Id2    13.8750
## 10014 32C 1.10        32     Id2    11.1850
## 10015 32C 1.11        32     Id2     0.8400
## 10016 32C 1.12        32     Id2     2.1900
## 10017 32C 1.13        32     Id2    11.7000
## 10018 32C 1.14        32     Id2     3.6800
## 10019 32C 1.15        32     Id2    13.5650
## 10020 32C 1.16        32     Id2     8.4600
## 10021 32C 1.17        32     Id2    11.3300
## 10022 32C 1.18        32     Id2    14.7300
## 10023 32C 1.19        32     Id2     6.7500
## 10024 32C 1.20        32     Id2     9.6850
## 10025 32C 1.21        32     Id2    11.7400
## 10026  32C 2.1        32     Id2     0.6100
## 10027  32C 2.2        32     Id2     3.9050
## 10028  32C 2.3        32     Id2     1.9200
## 10029  32C 2.4        32     Id2     9.9450
## 10030  32C 2.5        32     Id2    10.9100
## 10031  32C 2.6        32     Id2     4.7100
## 10032  32C 2.7        32     Id2     2.3650
## 10033  32C 2.8        32     Id2    11.5450
## 10034  32C 2.9        32     Id2    -0.3350
## 10035 32C 2.10        32     Id2    -0.6200
## 10036 32C 2.11        32     Id2    11.4700
## 10037 32C 2.12        32     Id2     2.3850
## 10038 32C 2.13        32     Id2    13.9450
## 10039 32C 2.14        32     Id2     9.7700
## 10040 32C 2.15        32     Id2    12.1000
## 10041 32C 2.16        32     Id2     6.7750
## 10042  32C 3.1        32     Id2    -3.5950
## 10043  32C 3.2        32     Id2     2.0250
## 10044  32C 3.3        32     Id2     0.7850
## 10045  32C 3.4        32     Id2     1.8700
## 10046  32C 3.5        32     Id2     3.2850
## 10047  32C 3.6        32     Id2     9.8800
## 10048  32C 3.7        32     Id2     7.6900
## 10049  32C 3.8        32     Id2     7.5250
## 10050  32C 4.1        32     Id2    -1.1650
## 10051  32C 4.2        32     Id2     1.3450
## 10052  32C 4.3        32     Id2    12.4650
## 10053  32C 4.4        32     Id2    12.3750
## 10054  32C 4.5        32     Id2    13.0900
## 10055  32C 4.6        32     Id2    13.1050
## 10056  32C 4.7        32     Id2     2.6100
## 10057  32C 4.8        32     Id2    -0.2900
## 10058 32C 4.10        32     Id2     2.0050
## 10059 32C 4.11        32     Id2    10.4450
## 10060 32C 4.12        32     Id2     2.4050
## 10061 32C 4.13        32     Id2     1.7250
## 10062 32C 4.14        32     Id2    13.1800
## 10063 32C 4.15        32     Id2    13.6550
## 10064 32C 4.16        32     Id2    13.4025
## 10065 32C 4.17        32     Id2     2.6700
## 10066 32C 4.18        32     Id2     2.2400
## 10067 32C 4.19        32     Id2     0.6400
## 10068 32C 4.20        32     Id2    10.3100
## 10069 32C 4.21        32     Id2     8.9550
## 10070 32C 4.22        32     Id2     7.7800
## 10071 32C 4.23        32     Id2     1.2300
## 10072 32C 4.24        32     Id2    13.4950
## 10073  32C 5.1        32     Id2     0.3525
## 10074  32C 5.2        32     Id2     3.5750
## 10075  32C 5.3        32     Id2    11.0450
## 10076  32C 5.4        32     Id2     0.2650
## 10077  32C 5.5        32     Id2     9.4650
## 10078  32C 5.6        32     Id2    -0.1450
## 10079  32C 5.7        32     Id2    -0.7750
## 10080  32C 5.8        32     Id2    12.9200
## 10081  32C 5.9        32     Id2     2.6300
## 10082 32C 5.10        32     Id2     9.5500
## 10083 32C 5.11        32     Id2     4.2150
## 10084 32C 5.12        32     Id2    13.1300
## 10085 32C 5.13        32     Id2     0.3750
## 10086 32C 5.14        32     Id2     0.9300
## 10087 32C 5.15        32     Id2     1.3550
## 10088 32C 5.16        32     Id2     1.7700
## 10089 32C 5.17        32     Id2     2.3600
## 10090 32C 5.18        32     Id2     2.5250
## 10091 32C 5.19        32     Id2    12.1600
## 10092 32C 5.20        32     Id2     5.2350
## 10093 32C 5.21        32     Id2     4.1100
## 10094 32C 5.22        32     Id2     0.7500
## 10095 32C 5.23        32     Id2    -0.0400
## 10096  32C 6.1        32     Id2    12.1650
## 10097  32C 6.2        32     Id2    -0.7800
## 10098  32C 6.3        32     Id2     3.5900
## 10099  32C 6.4        32     Id2    14.1500
## 10100  32C 6.6        32     Id2     2.6600
## 10101  32C 6.7        32     Id2     4.9800
## 10102  32C 7.1        32     Id2     2.9900
## 10103  32C 7.2        32     Id2    10.8050
## 10104  32C 7.3        32     Id2     3.4650
## 10105  32C 7.4        32     Id2     3.2550
## 10106  32C 7.5        32     Id2    11.2000
## 10107  32C 7.6        32     Id2    14.7350
## 10108  32C 7.8        32     Id2     3.0800
## 10109  32C 8.1        32     Id2     3.5200
## 10110  32C 8.2        32     Id2     4.5050
## 10111  32C 8.4        32     Id2     5.3600
## 10112  32C 8.5        32     Id2     9.8950
## 10113  32C 8.6        32     Id2     2.2500
## 10114  64C 1.1        64     Id2    12.4150
## 10115  64C 1.2        64     Id2     1.2500
## 10116  64C 1.3        64     Id2    13.4600
## 10117  64C 1.4        64     Id2     9.3650
## 10118  64C 1.5        64     Id2     7.2650
## 10119  64C 1.6        64     Id2    14.6800
## 10120  64C 1.7        64     Id2    13.8750
## 10121  64C 1.8        64     Id2    -1.1550
## 10122  64C 1.9        64     Id2    10.2200
## 10123 64C 1.10        64     Id2     2.4500
## 10124 64C 1.11        64     Id2    11.7000
## 10125 64C 1.12        64     Id2     3.9900
## 10126 64C 1.13        64     Id2    13.5650
## 10127 64C 1.14        64     Id2     1.0100
## 10128 64C 1.15        64     Id2     2.4500
## 10129 64C 1.16        64     Id2     3.3000
## 10130 64C 1.17        64     Id2     0.8600
## 10131 64C 1.18        64     Id2    -0.7050
## 10132 64C 1.19        64     Id2     0.6300
## 10133 64C 1.20        64     Id2     3.0100
## 10134 64C 1.21        64     Id2    14.2350
## 10135 64C 1.22        64     Id2     9.7100
## 10136 64C 1.23        64     Id2    14.3950
## 10137 64C 1.24        64     Id2     2.1000
## 10138 64C 1.25        64     Id2     2.7300
## 10139 64C 1.26        64     Id2     7.8150
## 10140 64C 1.27        64     Id2     0.2050
## 10141 64C 1.28        64     Id2    -0.5750
## 10142 64C 1.29        64     Id2    -1.7000
## 10143 64C 1.30        64     Id2     2.5800
## 10144 64C 1.31        64     Id2     2.6950
## 10145 64C 1.32        64     Id2     3.1750
## 10146 64C 1.33        64     Id2     2.2500
## 10147 64C 1.34        64     Id2     2.2400
## 10148 64C 1.35        64     Id2    -0.4450
## 10149 64C 1.36        64     Id2    -3.1950
## 10150 64C 1.37        64     Id2     0.0550
## 10151 64C 1.38        64     Id2    -0.4850
## 10152 64C 1.39        64     Id2     1.7500
## 10153 64C 1.40        64     Id2    14.3150
## 10154 64C 1.41        64     Id2    10.7300
## 10155 64C 1.42        64     Id2     2.5100
## 10156 64C 1.43        64     Id2    12.2750
## 10157 64C 1.44        64     Id2     0.9750
## 10158 64C 1.45        64     Id2     2.2250
## 10159 64C 1.46        64     Id2     1.4950
## 10160 64C 1.47        64     Id2     2.6050
## 10161 64C 1.48        64     Id2     1.6900
## 10162  64C 2.1        64     Id2     1.1250
## 10163  64C 2.2        64     Id2     2.0400
## 10164  64C 2.3        64     Id2    -0.2500
## 10165  64C 2.4        64     Id2     0.5450
## 10166  64C 2.5        64     Id2    10.4450
## 10167  64C 2.6        64     Id2     1.3850
## 10168  64C 2.7        64     Id2    10.7850
## 10169  64C 2.8        64     Id2     8.8400
## 10170  64C 2.9        64     Id2     1.8650
## 10171 64C 2.10        64     Id2     1.0325
## 10172 64C 2.11        64     Id2     1.2200
## 10173 64C 2.12        64     Id2     1.2500
## 10174 64C 2.13        64     Id2     0.6300
## 10175 64C 2.14        64     Id2     2.3700
## 10176 64C 2.15        64     Id2     1.1750
## 10177 64C 2.16        64     Id2     8.1600
## 10178 64C 2.17        64     Id2    10.4300
## 10179 64C 2.18        64     Id2     0.8750
## 10180 64C 2.19        64     Id2     0.2225
## 10181 64C 2.20        64     Id2     4.6350
## 10182 64C 2.21        64     Id2     3.6350
## 10183 64C 2.22        64     Id2     1.7050
## 10184 64C 2.23        64     Id2    -1.7250
## 10185 64C 2.24        64     Id2    -0.9050
## 10186 64C 2.25        64     Id2    -1.1650
## 10187  64C 3.1        64     Id2     1.6000
## 10188  64C 3.2        64     Id2     3.2400
## 10189  64C 3.3        64     Id2     0.1400
## 10190  64C 3.4        64     Id2     3.0450
## 10191  64C 3.5        64     Id2    13.1300
## 10192  64C 3.6        64     Id2     2.0750
## 10193  64C 3.7        64     Id2     0.7800
## 10194  64C 3.8        64     Id2    -0.7950
## 10195  64C 4.1        64     Id2    10.9100
## 10196 64C 4.1b        64     Id2    12.5900
## 10197  64C 4.2        64     Id2    13.5550
## 10198  64C 4.3        64     Id2    12.1600
## 10199  64C 4.4        64     Id2    13.3950
## 10200  64C 4.5        64     Id2    14.0200
## 10201  64C 4.6        64     Id2    11.8600
## 10202  64C 4.7        64     Id2     1.1800
## 10203  64C 4.8        64     Id2    12.1650
## 10204  64C 4.9        64     Id2     1.6100
## 10205 64C 4.10        64     Id2    14.7500
## 10206 64C 4.11        64     Id2    14.1500
## 10207 64C 4.12        64     Id2     2.8950
## 10208 64C 4.13        64     Id2     3.6500
## 10209 64C 4.14        64     Id2     3.6400
## 10210 64C 4.15        64     Id2     3.9750
## 10211 64C 4.16        64     Id2     3.1000
## 10212 64C 4.17        64     Id2     3.6950
## 10213 64C 4.18        64     Id2     0.3300
## 10214 64C 4.19        64     Id2     4.3250
## 10215 64C 4.20        64     Id2     4.0800
## 10216 64C 4.21        64     Id2     3.5850
## 10217 64C 4.22        64     Id2     4.9300
## 10218 64C 4.23        64     Id2     4.8650
## 10219 64C 4.24        64     Id2     4.3150
## 10220 64C 4.25        64     Id2     3.2550
## 10221 64C 4.26        64     Id2    12.4150
## 10222 64C 4.27        64     Id2     1.9600
## 10223 64C 4.28        64     Id2    13.4600
## 10224 64C 4.29        64     Id2     3.0050
## 10225 64C 4.30        64     Id2    13.2550
## 10226 64C 4.31        64     Id2     5.1500
## 10227 64C 4.32        64     Id2    13.8750
## 10228 64C 4.33        64     Id2     2.0950
## 10229 64C 4.34        64     Id2     1.2500
## 10230 64C 4.35        64     Id2    12.4300
## 10231 64C 4.36        64     Id2     1.1900
## 10232 64C 4.37        64     Id2     4.0200
## 10233 64C 4.38        64     Id2     2.9550
## 10234 64C 4.39        64     Id2     3.5200
## 10235  64C 5.1        64     Id2     5.2000
## 10236  64C 5.2        64     Id2    11.1800
## 10237  64C 5.3        64     Id2     6.0400
## 10238  64C 5.4        64     Id2    -0.1250
## 10239  64C 5.5        64     Id2    11.7400
## 10240  64C 5.6        64     Id2     7.8300
## 10241  64C 5.7        64     Id2     9.8850
## 10242  64C 5.8        64     Id2    11.8900
## 10243  64C 5.9        64     Id2    13.3450
## 10244 64C 5.10        64     Id2    13.2600
## 10245 64C 5.11        64     Id2     4.3700
## 10246 64C 5.12        64     Id2     2.9150
## 10247 64C 5.13        64     Id2     4.4850
## 10248 64C 5.14        64     Id2     4.4950
## 10249 64C 5.15        64     Id2     5.4400
## 10250 64C 5.16        64     Id2    10.6500
## 10251  64C 6.1        64     Id2     9.2850
## 10252  64C 6.2        64     Id2    13.9450
## 10253  64C 6.3        64     Id2    13.1700
## 10254  64C 6.4        64     Id2    12.1000
## 10255  64C 6.5        64     Id2    11.5150
## 10256  64C 6.6        64     Id2     8.3950
## 10257  64C 6.7        64     Id2     8.1250
## 10258  64C 6.8        64     Id2    11.3750
## 10259  64C 7.1        64     Id2    13.6700
## 10260  64C 7.2        64     Id2    14.3150
## 10261  64C 7.3        64     Id2    15.2400
## 10262  64C 7.4        64     Id2    11.7400
## 10263  64C 7.5        64     Id2    10.6350
## 10264  64C 7.6        64     Id2     6.5950
## 10265  64C 7.7        64     Id2    11.5250
## 10266  64C 7.8        64     Id2    12.4650
## 10267  64C 7.9        64     Id2    10.0150
## 10268 64C 7.10        64     Id2     5.7100
## 10269 64C 7.11        64     Id2     4.0650
## 10270 64C 7.12        64     Id2     4.9700
## 10271 64C 7.13        64     Id2     4.1900
## 10272 64C 7.14        64     Id2     4.4150
## 10273   2C 1.1         2    Klf2     1.8400
## 10274   2C 1.2         2    Klf2     3.4150
## 10275   2C 2.1         2    Klf2     0.9150
## 10276   2C 2.2         2    Klf2     3.7100
## 10277   2C 3.1         2    Klf2     5.3250
## 10278   2C 3.2         2    Klf2     3.9950
## 10279   2C 4.1         2    Klf2     4.0750
## 10280   2C 5.1         2    Klf2     4.0350
## 10281   2C 5.2         2    Klf2     4.5100
## 10282   2C 6.1         2    Klf2     0.7650
## 10283   2C 6.2         2    Klf2     0.4750
## 10284   2C 7.1         2    Klf2     0.4450
## 10285   2C 7.2         2    Klf2     6.1100
## 10286   2C 8.1         2    Klf2     4.7650
## 10287   2C 8.2         2    Klf2     3.5700
## 10288   2C 9.1         2    Klf2     3.7900
## 10289   2C 9.2         2    Klf2     3.9350
## 10290  2C 10.1         2    Klf2     3.5350
## 10291  2C 10.2         2    Klf2     0.5100
## 10292   4C 1.1         4    Klf2     1.9100
## 10293   4C 1.2         4    Klf2     0.0050
## 10294   4C 1.3         4    Klf2     2.7000
## 10295   4C 1.4         4    Klf2     2.1250
## 10296   4C 2.1         4    Klf2     1.4050
## 10297   4C 2.2         4    Klf2     3.7750
## 10298   4C 2.3         4    Klf2     3.1350
## 10299   4C 3.1         4    Klf2    -0.1550
## 10300   4C 3.2         4    Klf2     0.3100
## 10301   4C 3.3         4    Klf2     0.5700
## 10302   4C 3.4         4    Klf2     1.7350
## 10303   4C 4.1         4    Klf2     3.0350
## 10304   4C 4.2         4    Klf2     4.3850
## 10305   4C 4.3         4    Klf2     1.7050
## 10306   4C 4.4         4    Klf2     2.2150
## 10307   4C 5.1         4    Klf2     5.6600
## 10308   4C 5.2         4    Klf2     2.2200
## 10309   4C 5.3         4    Klf2     2.4950
## 10310   4C 5.4         4    Klf2     1.9850
## 10311   4C 6.1         4    Klf2    -1.0600
## 10312   4C 6.2         4    Klf2     2.3400
## 10313   4C 6.3         4    Klf2     1.4250
## 10314   4C 6.4         4    Klf2     0.9300
## 10315   8C 1.1         8    Klf2     5.9700
## 10316   8C 1.2         8    Klf2     3.4250
## 10317   8C 1.3         8    Klf2     2.7300
## 10318   8C 1.4         8    Klf2     1.3400
## 10319   8C 1.5         8    Klf2     2.5350
## 10320   8C 2.1         8    Klf2     0.9300
## 10321   8C 2.2         8    Klf2     3.6300
## 10322   8C 2.3         8    Klf2     3.4300
## 10323   8C 2.4         8    Klf2     4.7900
## 10324   8C 2.5         8    Klf2     2.6900
## 10325   8C 2.6         8    Klf2     2.7000
## 10326   8C 2.7         8    Klf2     0.2950
## 10327   8C 2.8         8    Klf2     0.1050
## 10328   8C 3.1         8    Klf2     3.5200
## 10329   8C 3.2         8    Klf2     4.2600
## 10330   8C 3.3         8    Klf2     6.2900
## 10331   8C 3.4         8    Klf2     5.4050
## 10332   8C 3.5         8    Klf2     5.0150
## 10333   8C 3.6         8    Klf2     3.6950
## 10334   8C 3.7         8    Klf2     4.4550
## 10335   8C 3.8         8    Klf2     4.1000
## 10336   8C 4.2         8    Klf2     4.4850
## 10337   8C 4.3         8    Klf2     2.5150
## 10338   8C 4.4         8    Klf2     3.7100
## 10339   8C 4.5         8    Klf2     7.5700
## 10340   8C 4.6         8    Klf2     5.2050
## 10341   8C 4.7         8    Klf2     4.6550
## 10342   8C 5.1         8    Klf2     4.0650
## 10343   8C 5.2         8    Klf2     5.2950
## 10344   8C 5.3         8    Klf2     2.0100
## 10345   8C 5.4         8    Klf2    -0.4450
## 10346   8C 5.5         8    Klf2     2.4300
## 10347   8C 5.6         8    Klf2     2.1150
## 10348   8C 5.7         8    Klf2     5.7250
## 10349   8C 5.8         8    Klf2     5.4500
## 10350   8C 6.1         8    Klf2     4.1100
## 10351   8C 6.2         8    Klf2     4.0700
## 10352   8C 6.3         8    Klf2     2.1200
## 10353   8C 6.4         8    Klf2     1.5750
## 10354   8C 6.5         8    Klf2     1.9450
## 10355   8C 6.6         8    Klf2     0.8000
## 10356   8C 6.7         8    Klf2     2.3150
## 10357   8C 6.8         8    Klf2     4.3550
## 10358  16C 1.1        16    Klf2     9.1975
## 10359  16C 1.2        16    Klf2     5.8800
## 10360  16C 1.3        16    Klf2     5.3750
## 10361  16C 1.4        16    Klf2     4.2400
## 10362  16C 1.5        16    Klf2     3.0800
## 10363  16C 1.6        16    Klf2     2.9050
## 10364  16C 1.7        16    Klf2     3.4600
## 10365  16C 1.8        16    Klf2     5.4650
## 10366  16C 1.9        16    Klf2     5.0800
## 10367 16C 1.10        16    Klf2     5.2825
## 10368 16C 1.11        16    Klf2     5.6050
## 10369 16C 1.12        16    Klf2     3.8950
## 10370 16C 1.13        16    Klf2     3.2250
## 10371 16C 1.14        16    Klf2     1.1750
## 10372 16C 1.15        16    Klf2     4.6600
## 10373 16C 1.16        16    Klf2     3.8850
## 10374  16C 2.1        16    Klf2     7.9750
## 10375  16C 2.2        16    Klf2     4.9550
## 10376  16C 2.3        16    Klf2     4.7450
## 10377  16C 2.4        16    Klf2     5.0850
## 10378  16C 2.5        16    Klf2     1.1200
## 10379  16C 2.6        16    Klf2     0.5750
## 10380  16C 2.7        16    Klf2     2.3300
## 10381  16C 2.8        16    Klf2     2.1950
## 10382  16C 2.9        16    Klf2     1.0250
## 10383 16C 2.10        16    Klf2     2.6200
## 10384 16C 2.11        16    Klf2     2.6850
## 10385 16C 2.12        16    Klf2     2.8350
## 10386 16C 2.13        16    Klf2     4.1450
## 10387 16C 2.14        16    Klf2     2.4850
## 10388 16C 2.15        16    Klf2     2.2300
## 10389 16C 2.16        16    Klf2     1.0650
## 10390  16C 3.1        16    Klf2     2.7850
## 10391  16C 3.2        16    Klf2     1.4550
## 10392  16C 3.3        16    Klf2     3.9700
## 10393  16C 3.4        16    Klf2     5.4550
## 10394  16C 3.5        16    Klf2     4.7000
## 10395  16C 3.6        16    Klf2     4.6000
## 10396  16C 3.7        16    Klf2     6.0650
## 10397  16C 3.8        16    Klf2     5.2350
## 10398  16C 3.9        16    Klf2     2.1100
## 10399 16C 3.10        16    Klf2     1.6600
## 10400 16C 3.11        16    Klf2     4.4250
## 10401 16C 3.12        16    Klf2     5.6600
## 10402 16C 3.13        16    Klf2     4.1150
## 10403 16C 3.14        16    Klf2     3.3350
## 10404 16C 3.15        16    Klf2     4.5750
## 10405  16C 4.1        16    Klf2     5.5650
## 10406  16C 4.2        16    Klf2     0.6350
## 10407  16C 4.3        16    Klf2     2.0600
## 10408  16C 4.4        16    Klf2     2.8800
## 10409  16C 4.5        16    Klf2     2.7850
## 10410  16C 4.6        16    Klf2     3.2650
## 10411  16C 4.7        16    Klf2     5.6950
## 10412  16C 4.8        16    Klf2     2.9050
## 10413  16C 4.9        16    Klf2     3.7950
## 10414 16C 4.10        16    Klf2     5.4000
## 10415 16C 4.11        16    Klf2     4.0300
## 10416 16C 4.12        16    Klf2     3.0550
## 10417 16C 4.13        16    Klf2     3.2850
## 10418 16C 4.14        16    Klf2     1.0400
## 10419 16C 4.15        16    Klf2     5.2300
## 10420 16C 4.16        16    Klf2     3.8550
## 10421  16C 5.1        16    Klf2     2.9200
## 10422  16C 5.2        16    Klf2     5.2500
## 10423  16C 5.3        16    Klf2     4.3550
## 10424  16C 5.4        16    Klf2     5.3300
## 10425  16C 5.5        16    Klf2     2.2200
## 10426  16C 5.6        16    Klf2     4.3250
## 10427  16C 5.7        16    Klf2     2.8400
## 10428  16C 5.8        16    Klf2     5.5500
## 10429  16C 5.9        16    Klf2     5.3300
## 10430 16C 5.10        16    Klf2     5.5400
## 10431 16C 5.11        16    Klf2     2.8600
## 10432 16C 5.12        16    Klf2     3.6700
## 10433  32C 1.1        32    Klf2     8.8950
## 10434  32C 1.2        32    Klf2     2.9850
## 10435  32C 1.3        32    Klf2     8.2400
## 10436  32C 1.4        32    Klf2    11.5700
## 10437  32C 1.5        32    Klf2     4.8500
## 10438  32C 1.6        32    Klf2     6.9350
## 10439  32C 1.7        32    Klf2     9.4450
## 10440  32C 1.8        32    Klf2     4.9450
## 10441  32C 1.9        32    Klf2     4.8350
## 10442 32C 1.10        32    Klf2    11.8100
## 10443 32C 1.11        32    Klf2     6.5950
## 10444 32C 1.12        32    Klf2     6.6650
## 10445 32C 1.13        32    Klf2    11.5300
## 10446 32C 1.14        32    Klf2    12.0700
## 10447 32C 1.15        32    Klf2     4.2650
## 10448 32C 1.16        32    Klf2     6.6650
## 10449 32C 1.17        32    Klf2     8.7650
## 10450 32C 1.18        32    Klf2     5.3050
## 10451 32C 1.19        32    Klf2     6.0100
## 10452 32C 1.20        32    Klf2     2.5750
## 10453 32C 1.21        32    Klf2     4.0700
## 10454  32C 2.1        32    Klf2     5.3950
## 10455  32C 2.2        32    Klf2    10.3850
## 10456  32C 2.3        32    Klf2    11.2700
## 10457  32C 2.4        32    Klf2     7.5300
## 10458  32C 2.5        32    Klf2     8.2900
## 10459  32C 2.6        32    Klf2     8.9500
## 10460  32C 2.7        32    Klf2     5.8850
## 10461  32C 2.8        32    Klf2     3.3150
## 10462  32C 2.9        32    Klf2     6.0900
## 10463 32C 2.10        32    Klf2    11.7950
## 10464 32C 2.11        32    Klf2     8.8450
## 10465 32C 2.12        32    Klf2    15.2575
## 10466 32C 2.13        32    Klf2     6.3300
## 10467 32C 2.14        32    Klf2     3.3150
## 10468 32C 2.15        32    Klf2     2.8400
## 10469 32C 2.16        32    Klf2     3.5000
## 10470  32C 3.1        32    Klf2     8.2450
## 10471  32C 3.2        32    Klf2     9.1600
## 10472  32C 3.3        32    Klf2    13.5850
## 10473  32C 3.4        32    Klf2     8.2400
## 10474  32C 3.5        32    Klf2    12.5725
## 10475  32C 3.6        32    Klf2     5.6050
## 10476  32C 3.7        32    Klf2     3.6750
## 10477  32C 3.8        32    Klf2     5.1150
## 10478  32C 4.1        32    Klf2     6.2450
## 10479  32C 4.2        32    Klf2    11.9300
## 10480  32C 4.3        32    Klf2     1.6150
## 10481  32C 4.4        32    Klf2    12.3050
## 10482  32C 4.5        32    Klf2    12.8350
## 10483  32C 4.6        32    Klf2     4.2250
## 10484  32C 4.7        32    Klf2     7.8250
## 10485  32C 4.8        32    Klf2     8.2500
## 10486 32C 4.10        32    Klf2     7.2250
## 10487 32C 4.11        32    Klf2     1.0100
## 10488 32C 4.12        32    Klf2    11.3850
## 10489 32C 4.13        32    Klf2    10.1350
## 10490 32C 4.14        32    Klf2     4.2700
## 10491 32C 4.15        32    Klf2     4.6150
## 10492 32C 4.16        32    Klf2     9.3350
## 10493 32C 4.17        32    Klf2     8.1350
## 10494 32C 4.18        32    Klf2     7.5250
## 10495 32C 4.19        32    Klf2     9.5600
## 10496 32C 4.20        32    Klf2     0.2550
## 10497 32C 4.21        32    Klf2     2.7550
## 10498 32C 4.22        32    Klf2     0.1350
## 10499 32C 4.23        32    Klf2    12.4600
## 10500 32C 4.24        32    Klf2     4.6050
## 10501  32C 5.1        32    Klf2     8.0200
## 10502  32C 5.2        32    Klf2     7.8800
## 10503  32C 5.3        32    Klf2     5.4050
## 10504  32C 5.4        32    Klf2    10.8050
## 10505  32C 5.5        32    Klf2     1.5300
## 10506  32C 5.6        32    Klf2     9.3300
## 10507  32C 5.7        32    Klf2    10.9850
## 10508  32C 5.8        32    Klf2     8.1500
## 10509  32C 5.9        32    Klf2    10.2250
## 10510 32C 5.10        32    Klf2    12.5450
## 10511 32C 5.11        32    Klf2    13.6850
## 10512 32C 5.12        32    Klf2     5.4050
## 10513 32C 5.13        32    Klf2     5.6550
## 10514 32C 5.14        32    Klf2     4.5100
## 10515 32C 5.15        32    Klf2     7.2400
## 10516 32C 5.16        32    Klf2     6.0650
## 10517 32C 5.17        32    Klf2     7.5750
## 10518 32C 5.18        32    Klf2    10.4250
## 10519 32C 5.19        32    Klf2     4.1150
## 10520 32C 5.20        32    Klf2     7.0550
## 10521 32C 5.21        32    Klf2    14.1900
## 10522 32C 5.22        32    Klf2    11.8800
## 10523 32C 5.23        32    Klf2    11.4450
## 10524  32C 6.1        32    Klf2     4.4850
## 10525  32C 6.2        32    Klf2     6.7100
## 10526  32C 6.3        32    Klf2    14.4500
## 10527  32C 6.4        32    Klf2     7.5100
## 10528  32C 6.6        32    Klf2     7.8350
## 10529  32C 6.7        32    Klf2    10.8750
## 10530  32C 7.1        32    Klf2    13.0350
## 10531  32C 7.2        32    Klf2     4.9500
## 10532  32C 7.3        32    Klf2    11.7000
## 10533  32C 7.4        32    Klf2    12.4950
## 10534  32C 7.5        32    Klf2     4.7500
## 10535  32C 7.6        32    Klf2     7.1800
## 10536  32C 7.8        32    Klf2    14.2300
## 10537  32C 8.1        32    Klf2    13.9500
## 10538  32C 8.2        32    Klf2    12.5700
## 10539  32C 8.4        32    Klf2     8.0200
## 10540  32C 8.5        32    Klf2     6.1850
## 10541  32C 8.6        32    Klf2    11.4850
## 10542  64C 1.1        64    Klf2    12.6200
## 10543  64C 1.2        64    Klf2    11.5700
## 10544  64C 1.3        64    Klf2     6.2000
## 10545  64C 1.4        64    Klf2    14.3550
## 10546  64C 1.5        64    Klf2     8.2850
## 10547  64C 1.6        64    Klf2     6.4650
## 10548  64C 1.7        64    Klf2    11.5650
## 10549  64C 1.8        64    Klf2    11.8100
## 10550  64C 1.9        64    Klf2     7.6750
## 10551 64C 1.10        64    Klf2    11.8350
## 10552 64C 1.11        64    Klf2     7.3300
## 10553 64C 1.12        64    Klf2     8.4900
## 10554 64C 1.13        64    Klf2     9.3450
## 10555 64C 1.14        64    Klf2     9.1250
## 10556 64C 1.15        64    Klf2    13.5150
## 10557 64C 1.16        64    Klf2    14.5650
## 10558 64C 1.17        64    Klf2    11.6400
## 10559 64C 1.18        64    Klf2     5.5650
## 10560 64C 1.19        64    Klf2     8.5900
## 10561 64C 1.20        64    Klf2    12.0050
## 10562 64C 1.21        64    Klf2    14.8450
## 10563 64C 1.22        64    Klf2     5.8400
## 10564 64C 1.23        64    Klf2     6.4300
## 10565 64C 1.24        64    Klf2    13.4700
## 10566 64C 1.25        64    Klf2     8.1300
## 10567 64C 1.26        64    Klf2     9.1550
## 10568 64C 1.27        64    Klf2     6.5550
## 10569 64C 1.28        64    Klf2    11.2100
## 10570 64C 1.29        64    Klf2     8.4450
## 10571 64C 1.30        64    Klf2    14.3350
## 10572 64C 1.31        64    Klf2    15.2575
## 10573 64C 1.32        64    Klf2    13.8800
## 10574 64C 1.33        64    Klf2    13.1450
## 10575 64C 1.34        64    Klf2    12.6400
## 10576 64C 1.35        64    Klf2    11.8000
## 10577 64C 1.36        64    Klf2    11.4350
## 10578 64C 1.37        64    Klf2    11.1700
## 10579 64C 1.38        64    Klf2    13.5850
## 10580 64C 1.39        64    Klf2     8.1400
## 10581 64C 1.40        64    Klf2     5.4025
## 10582 64C 1.41        64    Klf2     9.4650
## 10583 64C 1.42        64    Klf2     4.7650
## 10584 64C 1.43        64    Klf2    12.4550
## 10585 64C 1.44        64    Klf2     4.5250
## 10586 64C 1.45        64    Klf2    11.9300
## 10587 64C 1.46        64    Klf2    11.3350
## 10588 64C 1.47        64    Klf2    12.5650
## 10589 64C 1.48        64    Klf2    12.0250
## 10590  64C 2.1        64    Klf2    13.4050
## 10591  64C 2.2        64    Klf2    13.3050
## 10592  64C 2.3        64    Klf2     7.5700
## 10593  64C 2.4        64    Klf2     7.1550
## 10594  64C 2.5        64    Klf2    10.5100
## 10595  64C 2.6        64    Klf2     7.2350
## 10596  64C 2.7        64    Klf2     7.2350
## 10597  64C 2.8        64    Klf2    12.9000
## 10598  64C 2.9        64    Klf2    13.7550
## 10599 64C 2.10        64    Klf2     8.9050
## 10600 64C 2.11        64    Klf2    13.4150
## 10601 64C 2.12        64    Klf2    11.8150
## 10602 64C 2.13        64    Klf2    12.0500
## 10603 64C 2.14        64    Klf2     7.2150
## 10604 64C 2.15        64    Klf2     8.6550
## 10605 64C 2.16        64    Klf2     9.9050
## 10606 64C 2.17        64    Klf2    12.4600
## 10607 64C 2.18        64    Klf2    10.7850
## 10608 64C 2.19        64    Klf2    12.9000
## 10609 64C 2.20        64    Klf2    14.5200
## 10610 64C 2.21        64    Klf2    13.5050
## 10611 64C 2.22        64    Klf2    12.7050
## 10612 64C 2.23        64    Klf2     9.5100
## 10613 64C 2.24        64    Klf2    11.1900
## 10614 64C 2.25        64    Klf2     5.1850
## 10615  64C 3.1        64    Klf2    13.7700
## 10616  64C 3.2        64    Klf2    13.2950
## 10617  64C 3.3        64    Klf2     7.8750
## 10618  64C 3.4        64    Klf2     9.4650
## 10619  64C 3.5        64    Klf2    14.1950
## 10620  64C 3.6        64    Klf2    11.0150
## 10621  64C 3.7        64    Klf2    10.9900
## 10622  64C 3.8        64    Klf2    11.5100
## 10623  64C 4.1        64    Klf2    11.7950
## 10624 64C 4.1b        64    Klf2     6.6050
## 10625  64C 4.2        64    Klf2     7.2650
## 10626  64C 4.3        64    Klf2     7.1650
## 10627  64C 4.4        64    Klf2    12.4750
## 10628  64C 4.5        64    Klf2    14.1900
## 10629  64C 4.6        64    Klf2    11.8800
## 10630  64C 4.7        64    Klf2    11.4450
## 10631  64C 4.8        64    Klf2    12.2150
## 10632  64C 4.9        64    Klf2    11.0900
## 10633 64C 4.10        64    Klf2     8.9100
## 10634 64C 4.11        64    Klf2     6.0050
## 10635 64C 4.12        64    Klf2    12.5900
## 10636 64C 4.13        64    Klf2    14.3600
## 10637 64C 4.14        64    Klf2    13.0350
## 10638 64C 4.15        64    Klf2    13.0500
## 10639 64C 4.16        64    Klf2     8.3700
## 10640 64C 4.17        64    Klf2    12.4950
## 10641 64C 4.18        64    Klf2    11.4500
## 10642 64C 4.19        64    Klf2    13.7800
## 10643 64C 4.20        64    Klf2     9.9300
## 10644 64C 4.21        64    Klf2    13.9500
## 10645 64C 4.22        64    Klf2     7.6400
## 10646 64C 4.23        64    Klf2    13.1200
## 10647 64C 4.24        64    Klf2    11.7850
## 10648 64C 4.25        64    Klf2    11.4850
## 10649 64C 4.26        64    Klf2    12.6200
## 10650 64C 4.27        64    Klf2    11.5700
## 10651 64C 4.28        64    Klf2    14.0300
## 10652 64C 4.29        64    Klf2    14.3550
## 10653 64C 4.30        64    Klf2    13.4350
## 10654 64C 4.31        64    Klf2    13.9050
## 10655 64C 4.32        64    Klf2     5.3750
## 10656 64C 4.33        64    Klf2    11.8100
## 10657 64C 4.34        64    Klf2    11.6050
## 10658 64C 4.35        64    Klf2     8.5450
## 10659 64C 4.36        64    Klf2    11.5300
## 10660 64C 4.37        64    Klf2    14.4500
## 10661 64C 4.38        64    Klf2     6.5150
## 10662 64C 4.39        64    Klf2    13.6050
## 10663  64C 5.1        64    Klf2    13.5150
## 10664  64C 5.2        64    Klf2    14.5650
## 10665  64C 5.3        64    Klf2     8.5600
## 10666  64C 5.4        64    Klf2     6.6750
## 10667  64C 5.5        64    Klf2    12.5600
## 10668  64C 5.6        64    Klf2    12.0050
## 10669  64C 5.7        64    Klf2    14.8450
## 10670  64C 5.8        64    Klf2     7.2100
## 10671  64C 5.9        64    Klf2    14.3000
## 10672 64C 5.10        64    Klf2    13.4700
## 10673 64C 5.11        64    Klf2    13.1300
## 10674 64C 5.12        64    Klf2    12.3250
## 10675 64C 5.13        64    Klf2    10.9550
## 10676 64C 5.14        64    Klf2    11.2100
## 10677 64C 5.15        64    Klf2    11.7950
## 10678 64C 5.16        64    Klf2    14.3350
## 10679  64C 6.1        64    Klf2    15.2575
## 10680  64C 6.2        64    Klf2     5.2200
## 10681  64C 6.3        64    Klf2     5.4150
## 10682  64C 6.4        64    Klf2     5.5700
## 10683  64C 6.5        64    Klf2     4.0500
## 10684  64C 6.6        64    Klf2     2.0450
## 10685  64C 6.7        64    Klf2    12.4900
## 10686  64C 6.8        64    Klf2     5.9050
## 10687  64C 7.1        64    Klf2    13.3300
## 10688  64C 7.2        64    Klf2    12.5725
## 10689  64C 7.3        64    Klf2     6.4150
## 10690  64C 7.4        64    Klf2    11.9350
## 10691  64C 7.5        64    Klf2    12.4550
## 10692  64C 7.6        64    Klf2    10.0050
## 10693  64C 7.7        64    Klf2     7.3500
## 10694  64C 7.8        64    Klf2     4.3350
## 10695  64C 7.9        64    Klf2     6.6550
## 10696 64C 7.10        64    Klf2    14.3750
## 10697 64C 7.11        64    Klf2     8.6350
## 10698 64C 7.12        64    Klf2     8.5750
## 10699 64C 7.13        64    Klf2    11.1000
## 10700 64C 7.14        64    Klf2    10.8150
## 10701   2C 1.1         2    Klf4    -0.3950
## 10702   2C 1.2         2    Klf4     1.7750
## 10703   2C 2.1         2    Klf4    -0.2800
## 10704   2C 2.2         2    Klf4     2.6900
## 10705   2C 3.1         2    Klf4     2.9900
## 10706   2C 3.2         2    Klf4     1.6800
## 10707   2C 4.1         2    Klf4     1.8600
## 10708   2C 5.1         2    Klf4     0.8950
## 10709   2C 5.2         2    Klf4     0.7300
## 10710   2C 6.1         2    Klf4    -1.8750
## 10711   2C 6.2         2    Klf4    -0.2350
## 10712   2C 7.1         2    Klf4    -1.7800
## 10713   2C 7.2         2    Klf4     3.5850
## 10714   2C 8.1         2    Klf4     3.1700
## 10715   2C 8.2         2    Klf4     2.5000
## 10716   2C 9.1         2    Klf4     3.9400
## 10717   2C 9.2         2    Klf4     1.8950
## 10718  2C 10.1         2    Klf4     0.7000
## 10719  2C 10.2         2    Klf4    -1.5400
## 10720   4C 1.1         4    Klf4     1.8250
## 10721   4C 1.2         4    Klf4     0.8150
## 10722   4C 1.3         4    Klf4     3.5700
## 10723   4C 1.4         4    Klf4     4.1250
## 10724   4C 2.1         4    Klf4     2.9900
## 10725   4C 2.2         4    Klf4     3.0450
## 10726   4C 2.3         4    Klf4     5.3300
## 10727   4C 3.1         4    Klf4     2.1050
## 10728   4C 3.2         4    Klf4     0.8150
## 10729   4C 3.3         4    Klf4     0.5450
## 10730   4C 3.4         4    Klf4     1.3850
## 10731   4C 4.1         4    Klf4     5.4250
## 10732   4C 4.2         4    Klf4     4.2950
## 10733   4C 4.3         4    Klf4     3.2750
## 10734   4C 4.4         4    Klf4     5.5900
## 10735   4C 5.1         4    Klf4     3.8150
## 10736   4C 5.2         4    Klf4     2.9050
## 10737   4C 5.3         4    Klf4     1.8750
## 10738   4C 5.4         4    Klf4     2.8400
## 10739   4C 6.1         4    Klf4     2.3050
## 10740   4C 6.2         4    Klf4     3.0200
## 10741   4C 6.3         4    Klf4     4.0500
## 10742   4C 6.4         4    Klf4     0.8800
## 10743   8C 1.1         8    Klf4     9.4900
## 10744   8C 1.2         8    Klf4     6.5500
## 10745   8C 1.3         8    Klf4     5.4750
## 10746   8C 1.4         8    Klf4     3.0650
## 10747   8C 1.5         8    Klf4     4.6050
## 10748   8C 2.1         8    Klf4     1.6950
## 10749   8C 2.2         8    Klf4     5.3600
## 10750   8C 2.3         8    Klf4     1.4950
## 10751   8C 2.4         8    Klf4     8.1650
## 10752   8C 2.5         8    Klf4     0.8700
## 10753   8C 2.6         8    Klf4     4.2700
## 10754   8C 2.7         8    Klf4     0.6950
## 10755   8C 2.8         8    Klf4     2.7250
## 10756   8C 3.1         8    Klf4     3.4700
## 10757   8C 3.2         8    Klf4     4.4800
## 10758   8C 3.3         8    Klf4     4.0550
## 10759   8C 3.4         8    Klf4     4.5850
## 10760   8C 3.5         8    Klf4     3.5250
## 10761   8C 3.6         8    Klf4     3.5200
## 10762   8C 3.7         8    Klf4     4.6250
## 10763   8C 3.8         8    Klf4     1.5550
## 10764   8C 4.2         8    Klf4     6.0700
## 10765   8C 4.3         8    Klf4     1.6500
## 10766   8C 4.4         8    Klf4     4.0550
## 10767   8C 4.5         8    Klf4     7.9750
## 10768   8C 4.6         8    Klf4     4.2100
## 10769   8C 4.7         8    Klf4     2.7500
## 10770   8C 5.1         8    Klf4     5.0400
## 10771   8C 5.2         8    Klf4     3.2900
## 10772   8C 5.3         8    Klf4     1.4550
## 10773   8C 5.4         8    Klf4    -0.6450
## 10774   8C 5.5         8    Klf4     2.7050
## 10775   8C 5.6         8    Klf4     0.5950
## 10776   8C 5.7         8    Klf4     3.6050
## 10777   8C 5.8         8    Klf4     3.9550
## 10778   8C 6.1         8    Klf4     4.4300
## 10779   8C 6.2         8    Klf4     5.3750
## 10780   8C 6.3         8    Klf4     2.8200
## 10781   8C 6.4         8    Klf4     1.7100
## 10782   8C 6.5         8    Klf4     2.2550
## 10783   8C 6.6         8    Klf4     3.4000
## 10784   8C 6.7         8    Klf4     2.7500
## 10785   8C 6.8         8    Klf4     5.5500
## 10786  16C 1.1        16    Klf4     7.3950
## 10787  16C 1.2        16    Klf4     3.8600
## 10788  16C 1.3        16    Klf4     3.5200
## 10789  16C 1.4        16    Klf4     2.1700
## 10790  16C 1.5        16    Klf4     0.9350
## 10791  16C 1.6        16    Klf4     1.6350
## 10792  16C 1.7        16    Klf4     6.5400
## 10793  16C 1.8        16    Klf4     2.8200
## 10794  16C 1.9        16    Klf4     3.3250
## 10795 16C 1.10        16    Klf4     3.0725
## 10796 16C 1.11        16    Klf4     3.6100
## 10797 16C 1.12        16    Klf4     1.5800
## 10798 16C 1.13        16    Klf4     3.6950
## 10799 16C 1.14        16    Klf4     1.7950
## 10800 16C 1.15        16    Klf4     3.1450
## 10801 16C 1.16        16    Klf4     1.6800
## 10802  16C 2.1        16    Klf4     6.7600
## 10803  16C 2.2        16    Klf4     6.7450
## 10804  16C 2.3        16    Klf4     3.6200
## 10805  16C 2.4        16    Klf4     4.2600
## 10806  16C 2.5        16    Klf4     3.9050
## 10807  16C 2.6        16    Klf4    -0.4150
## 10808  16C 2.7        16    Klf4     0.5350
## 10809  16C 2.8        16    Klf4     3.2950
## 10810  16C 2.9        16    Klf4     2.5900
## 10811 16C 2.10        16    Klf4     3.0700
## 10812 16C 2.11        16    Klf4     3.7000
## 10813 16C 2.12        16    Klf4     3.4200
## 10814 16C 2.13        16    Klf4     4.8000
## 10815 16C 2.14        16    Klf4     2.8750
## 10816 16C 2.15        16    Klf4     1.7700
## 10817 16C 2.16        16    Klf4    -0.0950
## 10818  16C 3.1        16    Klf4     2.5750
## 10819  16C 3.2        16    Klf4     0.2700
## 10820  16C 3.3        16    Klf4     5.9350
## 10821  16C 3.4        16    Klf4     4.1500
## 10822  16C 3.5        16    Klf4     2.8900
## 10823  16C 3.6        16    Klf4     5.2300
## 10824  16C 3.7        16    Klf4     3.5250
## 10825  16C 3.8        16    Klf4     3.8600
## 10826  16C 3.9        16    Klf4     1.7900
## 10827 16C 3.10        16    Klf4     2.3450
## 10828 16C 3.11        16    Klf4     2.4550
## 10829 16C 3.12        16    Klf4     6.1400
## 10830 16C 3.13        16    Klf4     5.7050
## 10831 16C 3.14        16    Klf4     3.9700
## 10832 16C 3.15        16    Klf4     2.8050
## 10833  16C 4.1        16    Klf4     3.9600
## 10834  16C 4.2        16    Klf4     1.3050
## 10835  16C 4.3        16    Klf4    -0.6150
## 10836  16C 4.4        16    Klf4    -1.6350
## 10837  16C 4.5        16    Klf4     0.6550
## 10838  16C 4.6        16    Klf4     4.7750
## 10839  16C 4.7        16    Klf4     3.5350
## 10840  16C 4.8        16    Klf4     2.2050
## 10841  16C 4.9        16    Klf4     6.0900
## 10842 16C 4.10        16    Klf4     3.4850
## 10843 16C 4.11        16    Klf4     1.1850
## 10844 16C 4.12        16    Klf4     1.4950
## 10845 16C 4.13        16    Klf4     2.0500
## 10846 16C 4.14        16    Klf4     1.6550
## 10847 16C 4.15        16    Klf4     2.4700
## 10848 16C 4.16        16    Klf4     2.9000
## 10849  16C 5.1        16    Klf4     0.7400
## 10850  16C 5.2        16    Klf4     3.0300
## 10851  16C 5.3        16    Klf4     3.5700
## 10852  16C 5.4        16    Klf4     2.7450
## 10853  16C 5.5        16    Klf4     0.3650
## 10854  16C 5.6        16    Klf4     3.0150
## 10855  16C 5.7        16    Klf4     1.3250
## 10856  16C 5.8        16    Klf4     4.9600
## 10857  16C 5.9        16    Klf4     2.7450
## 10858 16C 5.10        16    Klf4     2.4650
## 10859 16C 5.11        16    Klf4     0.0500
## 10860 16C 5.12        16    Klf4     3.2900
## 10861  32C 1.1        32    Klf4     6.5750
## 10862  32C 1.2        32    Klf4     1.6350
## 10863  32C 1.3        32    Klf4    12.6600
## 10864  32C 1.4        32    Klf4    11.7300
## 10865  32C 1.5        32    Klf4     4.0150
## 10866  32C 1.6        32    Klf4     3.2950
## 10867  32C 1.7        32    Klf4     6.4350
## 10868  32C 1.8        32    Klf4     2.5900
## 10869  32C 1.9        32    Klf4     3.6250
## 10870 32C 1.10        32    Klf4     7.1550
## 10871 32C 1.11        32    Klf4     4.8400
## 10872 32C 1.12        32    Klf4     2.9400
## 10873 32C 1.13        32    Klf4     5.7650
## 10874 32C 1.14        32    Klf4     7.8850
## 10875 32C 1.15        32    Klf4     4.9200
## 10876 32C 1.16        32    Klf4     3.9900
## 10877 32C 1.17        32    Klf4     5.2000
## 10878 32C 1.18        32    Klf4     2.9300
## 10879 32C 1.19        32    Klf4     2.3150
## 10880 32C 1.20        32    Klf4     3.0850
## 10881 32C 1.21        32    Klf4     5.4450
## 10882  32C 2.1        32    Klf4     4.4250
## 10883  32C 2.2        32    Klf4     5.5050
## 10884  32C 2.3        32    Klf4     6.8650
## 10885  32C 2.4        32    Klf4     5.3200
## 10886  32C 2.5        32    Klf4     6.3950
## 10887  32C 2.6        32    Klf4     7.6300
## 10888  32C 2.7        32    Klf4     2.5400
## 10889  32C 2.8        32    Klf4     2.2650
## 10890  32C 2.9        32    Klf4     3.9100
## 10891 32C 2.10        32    Klf4     4.1900
## 10892 32C 2.11        32    Klf4     6.8200
## 10893 32C 2.12        32    Klf4     9.9250
## 10894 32C 2.13        32    Klf4     4.7600
## 10895 32C 2.14        32    Klf4     4.3500
## 10896 32C 2.15        32    Klf4     2.6300
## 10897 32C 2.16        32    Klf4     2.8650
## 10898  32C 3.1        32    Klf4     2.8950
## 10899  32C 3.2        32    Klf4     4.7600
## 10900  32C 3.3        32    Klf4     4.8000
## 10901  32C 3.4        32    Klf4     4.5350
## 10902  32C 3.5        32    Klf4     5.9225
## 10903  32C 3.6        32    Klf4     3.6700
## 10904  32C 3.7        32    Klf4     2.7300
## 10905  32C 3.8        32    Klf4     3.6050
## 10906  32C 4.1        32    Klf4     3.3250
## 10907  32C 4.2        32    Klf4     5.9750
## 10908  32C 4.3        32    Klf4     0.7000
## 10909  32C 4.4        32    Klf4     4.1900
## 10910  32C 4.5        32    Klf4    11.0750
## 10911  32C 4.6        32    Klf4     2.1300
## 10912  32C 4.7        32    Klf4     3.7200
## 10913  32C 4.8        32    Klf4     6.5650
## 10914 32C 4.10        32    Klf4     1.6450
## 10915 32C 4.11        32    Klf4    -1.1050
## 10916 32C 4.12        32    Klf4     8.2250
## 10917 32C 4.13        32    Klf4     3.3000
## 10918 32C 4.14        32    Klf4     3.2800
## 10919 32C 4.15        32    Klf4     3.1400
## 10920 32C 4.16        32    Klf4     7.0100
## 10921 32C 4.17        32    Klf4     6.5200
## 10922 32C 4.18        32    Klf4     5.1450
## 10923 32C 4.19        32    Klf4     3.4800
## 10924 32C 4.20        32    Klf4     1.1150
## 10925 32C 4.21        32    Klf4     1.3350
## 10926 32C 4.22        32    Klf4    -1.1000
## 10927 32C 4.23        32    Klf4     8.1250
## 10928 32C 4.24        32    Klf4     3.2200
## 10929  32C 5.1        32    Klf4     3.1900
## 10930  32C 5.2        32    Klf4     5.6900
## 10931  32C 5.3        32    Klf4     5.2850
## 10932  32C 5.4        32    Klf4     3.9600
## 10933  32C 5.5        32    Klf4     5.2900
## 10934  32C 5.6        32    Klf4     4.8150
## 10935  32C 5.7        32    Klf4     4.0650
## 10936  32C 5.8        32    Klf4     5.4200
## 10937  32C 5.9        32    Klf4     5.2050
## 10938 32C 5.10        32    Klf4     6.3100
## 10939 32C 5.11        32    Klf4     8.5550
## 10940 32C 5.12        32    Klf4     4.2800
## 10941 32C 5.13        32    Klf4     5.3550
## 10942 32C 5.14        32    Klf4     1.7150
## 10943 32C 5.15        32    Klf4     3.6850
## 10944 32C 5.16        32    Klf4     6.9550
## 10945 32C 5.17        32    Klf4     8.9950
## 10946 32C 5.18        32    Klf4     5.5050
## 10947 32C 5.19        32    Klf4     3.0750
## 10948 32C 5.20        32    Klf4     7.7000
## 10949 32C 5.21        32    Klf4     6.4750
## 10950 32C 5.22        32    Klf4     6.7150
## 10951 32C 5.23        32    Klf4     4.2750
## 10952  32C 6.1        32    Klf4     2.7800
## 10953  32C 6.2        32    Klf4     2.5900
## 10954  32C 6.3        32    Klf4     5.1750
## 10955  32C 6.4        32    Klf4     4.4000
## 10956  32C 6.6        32    Klf4     4.0000
## 10957  32C 6.7        32    Klf4     4.7500
## 10958  32C 7.1        32    Klf4     6.5200
## 10959  32C 7.2        32    Klf4     4.6100
## 10960  32C 7.3        32    Klf4    11.4450
## 10961  32C 7.4        32    Klf4    12.3950
## 10962  32C 7.5        32    Klf4     3.0700
## 10963  32C 7.6        32    Klf4     5.7950
## 10964  32C 7.8        32    Klf4     7.5550
## 10965  32C 8.1        32    Klf4     9.4350
## 10966  32C 8.2        32    Klf4     9.9600
## 10967  32C 8.4        32    Klf4     5.5150
## 10968  32C 8.5        32    Klf4     4.1650
## 10969  32C 8.6        32    Klf4     6.1000
## 10970  64C 1.1        64    Klf4     3.1900
## 10971  64C 1.2        64    Klf4    11.7300
## 10972  64C 1.3        64    Klf4     5.1350
## 10973  64C 1.4        64    Klf4     5.7250
## 10974  64C 1.5        64    Klf4     4.9650
## 10975  64C 1.6        64    Klf4     3.9500
## 10976  64C 1.7        64    Klf4     5.1150
## 10977  64C 1.8        64    Klf4    11.6550
## 10978  64C 1.9        64    Klf4     3.3000
## 10979 64C 1.10        64    Klf4     7.0800
## 10980 64C 1.11        64    Klf4     1.8350
## 10981 64C 1.12        64    Klf4    14.8150
## 10982 64C 1.13        64    Klf4     6.4300
## 10983 64C 1.14        64    Klf4    13.3900
## 10984 64C 1.15        64    Klf4     9.7600
## 10985 64C 1.16        64    Klf4     8.3200
## 10986 64C 1.17        64    Klf4     6.0450
## 10987 64C 1.18        64    Klf4     6.9250
## 10988 64C 1.19        64    Klf4    12.1450
## 10989 64C 1.20        64    Klf4    10.5250
## 10990 64C 1.21        64    Klf4     7.1250
## 10991 64C 1.22        64    Klf4     4.6550
## 10992 64C 1.23        64    Klf4     4.4600
## 10993 64C 1.24        64    Klf4    10.3850
## 10994 64C 1.25        64    Klf4     5.4200
## 10995 64C 1.26        64    Klf4     3.3600
## 10996 64C 1.27        64    Klf4     5.8350
## 10997 64C 1.28        64    Klf4    11.6800
## 10998 64C 1.29        64    Klf4    11.8100
## 10999 64C 1.30        64    Klf4     9.3400
## 11000 64C 1.31        64    Klf4    13.7850
## 11001 64C 1.32        64    Klf4     9.7400
## 11002 64C 1.33        64    Klf4     6.4700
## 11003 64C 1.34        64    Klf4    11.9000
## 11004 64C 1.35        64    Klf4     4.3750
## 11005 64C 1.36        64    Klf4     5.9950
## 11006 64C 1.37        64    Klf4     9.7000
## 11007 64C 1.38        64    Klf4     6.9700
## 11008 64C 1.39        64    Klf4     6.5650
## 11009 64C 1.40        64    Klf4     2.2825
## 11010 64C 1.41        64    Klf4     5.4000
## 11011 64C 1.42        64    Klf4     2.3700
## 11012 64C 1.43        64    Klf4     7.0950
## 11013 64C 1.44        64    Klf4     6.8950
## 11014 64C 1.45        64    Klf4     9.1150
## 11015 64C 1.46        64    Klf4     6.7100
## 11016 64C 1.47        64    Klf4    13.2600
## 11017 64C 1.48        64    Klf4     9.2150
## 11018  64C 2.1        64    Klf4    12.3100
## 11019  64C 2.2        64    Klf4     5.8800
## 11020  64C 2.3        64    Klf4     6.9450
## 11021  64C 2.4        64    Klf4     4.2550
## 11022  64C 2.5        64    Klf4     1.3550
## 11023  64C 2.6        64    Klf4     5.3550
## 11024  64C 2.7        64    Klf4     2.1900
## 11025  64C 2.8        64    Klf4     5.2900
## 11026  64C 2.9        64    Klf4     7.0400
## 11027 64C 2.10        64    Klf4     5.5900
## 11028 64C 2.11        64    Klf4     7.1600
## 11029 64C 2.12        64    Klf4     8.7350
## 11030 64C 2.13        64    Klf4     6.3000
## 11031 64C 2.14        64    Klf4     3.4650
## 11032 64C 2.15        64    Klf4     5.1050
## 11033 64C 2.16        64    Klf4     2.5000
## 11034 64C 2.17        64    Klf4     9.9950
## 11035 64C 2.18        64    Klf4     7.6000
## 11036 64C 2.19        64    Klf4    12.9700
## 11037 64C 2.20        64    Klf4    14.8300
## 11038 64C 2.21        64    Klf4     8.0650
## 11039 64C 2.22        64    Klf4     6.0700
## 11040 64C 2.23        64    Klf4     5.3200
## 11041 64C 2.24        64    Klf4     6.2150
## 11042 64C 2.25        64    Klf4     3.4350
## 11043  64C 3.1        64    Klf4    13.3600
## 11044  64C 3.2        64    Klf4     8.3450
## 11045  64C 3.3        64    Klf4    12.7800
## 11046  64C 3.4        64    Klf4     8.4250
## 11047  64C 3.5        64    Klf4     5.2600
## 11048  64C 3.6        64    Klf4     6.7150
## 11049  64C 3.7        64    Klf4     7.1450
## 11050  64C 3.8        64    Klf4     9.8950
## 11051  64C 4.1        64    Klf4     8.2050
## 11052 64C 4.1b        64    Klf4     7.1750
## 11053  64C 4.2        64    Klf4     4.2150
## 11054  64C 4.3        64    Klf4     6.3350
## 11055  64C 4.4        64    Klf4     7.7500
## 11056  64C 4.5        64    Klf4     7.0050
## 11057  64C 4.6        64    Klf4     7.3250
## 11058  64C 4.7        64    Klf4     8.5750
## 11059  64C 4.8        64    Klf4     2.9800
## 11060  64C 4.9        64    Klf4    12.4750
## 11061 64C 4.10        64    Klf4     5.8500
## 11062 64C 4.11        64    Klf4     5.2600
## 11063 64C 4.12        64    Klf4    11.5100
## 11064 64C 4.13        64    Klf4    13.9100
## 11065 64C 4.14        64    Klf4    13.7500
## 11066 64C 4.15        64    Klf4     9.3850
## 11067 64C 4.16        64    Klf4    11.4450
## 11068 64C 4.17        64    Klf4     7.6750
## 11069 64C 4.18        64    Klf4     7.0250
## 11070 64C 4.19        64    Klf4    14.2400
## 11071 64C 4.20        64    Klf4    12.6150
## 11072 64C 4.21        64    Klf4    13.4350
## 11073 64C 4.22        64    Klf4     9.9600
## 11074 64C 4.23        64    Klf4     9.4900
## 11075 64C 4.24        64    Klf4    11.5150
## 11076 64C 4.25        64    Klf4    11.6750
## 11077 64C 4.26        64    Klf4     3.9300
## 11078 64C 4.27        64    Klf4    11.7300
## 11079 64C 4.28        64    Klf4     6.5450
## 11080 64C 4.29        64    Klf4    13.8250
## 11081 64C 4.30        64    Klf4     5.0550
## 11082 64C 4.31        64    Klf4    13.1700
## 11083 64C 4.32        64    Klf4     3.7350
## 11084 64C 4.33        64    Klf4     6.5850
## 11085 64C 4.34        64    Klf4     7.0400
## 11086 64C 4.35        64    Klf4     1.8800
## 11087 64C 4.36        64    Klf4    10.2150
## 11088 64C 4.37        64    Klf4    14.8150
## 11089 64C 4.38        64    Klf4     7.5100
## 11090 64C 4.39        64    Klf4     9.6400
## 11091  64C 5.1        64    Klf4    10.6800
## 11092  64C 5.2        64    Klf4     6.1700
## 11093  64C 5.3        64    Klf4     4.2750
## 11094  64C 5.4        64    Klf4    10.4750
## 11095  64C 5.5        64    Klf4     3.4950
## 11096  64C 5.6        64    Klf4     3.6750
## 11097  64C 5.7        64    Klf4     6.2450
## 11098  64C 5.8        64    Klf4     4.7550
## 11099  64C 5.9        64    Klf4     5.6500
## 11100 64C 5.10        64    Klf4     5.7650
## 11101 64C 5.11        64    Klf4     7.2400
## 11102 64C 5.12        64    Klf4    11.2700
## 11103 64C 5.13        64    Klf4    10.7750
## 11104 64C 5.14        64    Klf4     8.0700
## 11105 64C 5.15        64    Klf4    11.8100
## 11106 64C 5.16        64    Klf4    14.4400
## 11107  64C 6.1        64    Klf4     6.5050
## 11108  64C 6.2        64    Klf4     2.0300
## 11109  64C 6.3        64    Klf4     2.9000
## 11110  64C 6.4        64    Klf4     1.4200
## 11111  64C 6.5        64    Klf4     1.7050
## 11112  64C 6.6        64    Klf4    -1.4350
## 11113  64C 6.7        64    Klf4     5.5800
## 11114  64C 6.8        64    Klf4     1.6700
## 11115  64C 7.1        64    Klf4    10.6350
## 11116  64C 7.2        64    Klf4     5.7325
## 11117  64C 7.3        64    Klf4     4.3600
## 11118  64C 7.4        64    Klf4     4.0300
## 11119  64C 7.5        64    Klf4     4.7650
## 11120  64C 7.6        64    Klf4     4.2550
## 11121  64C 7.7        64    Klf4     3.8650
## 11122  64C 7.8        64    Klf4     2.5800
## 11123  64C 7.9        64    Klf4     4.9000
## 11124 64C 7.10        64    Klf4    14.1050
## 11125 64C 7.11        64    Klf4     8.4100
## 11126 64C 7.12        64    Klf4     8.3600
## 11127 64C 7.13        64    Klf4    13.5250
## 11128 64C 7.14        64    Klf4     9.2550
## 11129   2C 1.1         2    Klf5     5.6050
## 11130   2C 1.2         2    Klf5     8.5150
## 11131   2C 2.1         2    Klf5     8.1050
## 11132   2C 2.2         2    Klf5     8.7950
## 11133   2C 3.1         2    Klf5     9.2550
## 11134   2C 3.2         2    Klf5     8.0100
## 11135   2C 4.1         2    Klf5    13.1350
## 11136   2C 5.1         2    Klf5     8.3650
## 11137   2C 5.2         2    Klf5     7.5600
## 11138   2C 6.1         2    Klf5     5.0450
## 11139   2C 6.2         2    Klf5     7.4100
## 11140   2C 7.1         2    Klf5     7.9850
## 11141   2C 7.2         2    Klf5     8.8850
## 11142   2C 8.1         2    Klf5    10.6550
## 11143   2C 8.2         2    Klf5     9.0400
## 11144   2C 9.1         2    Klf5    12.5800
## 11145   2C 9.2         2    Klf5     9.9150
## 11146  2C 10.1         2    Klf5     6.6850
## 11147  2C 10.2         2    Klf5     9.9650
## 11148   4C 1.1         4    Klf5     7.1450
## 11149   4C 1.2         4    Klf5     9.6000
## 11150   4C 1.3         4    Klf5    10.4050
## 11151   4C 1.4         4    Klf5    10.6850
## 11152   4C 2.1         4    Klf5     9.7000
## 11153   4C 2.2         4    Klf5    10.4150
## 11154   4C 2.3         4    Klf5    10.3700
## 11155   4C 3.1         4    Klf5     9.7000
## 11156   4C 3.2         4    Klf5     9.0200
## 11157   4C 3.3         4    Klf5    10.5250
## 11158   4C 3.4         4    Klf5     8.5000
## 11159   4C 4.1         4    Klf5    11.8400
## 11160   4C 4.2         4    Klf5    10.5750
## 11161   4C 4.3         4    Klf5    12.6950
## 11162   4C 4.4         4    Klf5    13.0900
## 11163   4C 5.1         4    Klf5     9.8550
## 11164   4C 5.2         4    Klf5     8.8700
## 11165   4C 5.3         4    Klf5     5.4200
## 11166   4C 5.4         4    Klf5     6.6550
## 11167   4C 6.1         4    Klf5     7.1500
## 11168   4C 6.2         4    Klf5     7.7550
## 11169   4C 6.3         4    Klf5     8.4700
## 11170   4C 6.4         4    Klf5     8.4900
## 11171   8C 1.1         8    Klf5     9.6000
## 11172   8C 1.2         8    Klf5     5.8600
## 11173   8C 1.3         8    Klf5     5.1900
## 11174   8C 1.4         8    Klf5     7.1650
## 11175   8C 1.5         8    Klf5     6.1400
## 11176   8C 2.1         8    Klf5     3.8250
## 11177   8C 2.2         8    Klf5     8.5750
## 11178   8C 2.3         8    Klf5     5.1750
## 11179   8C 2.4         8    Klf5     8.0950
## 11180   8C 2.5         8    Klf5     8.8800
## 11181   8C 2.6         8    Klf5     4.6250
## 11182   8C 2.7         8    Klf5     3.5050
## 11183   8C 2.8         8    Klf5     1.3150
## 11184   8C 3.1         8    Klf5     6.6600
## 11185   8C 3.2         8    Klf5     6.9800
## 11186   8C 3.3         8    Klf5     7.8950
## 11187   8C 3.4         8    Klf5     7.0050
## 11188   8C 3.5         8    Klf5     5.2000
## 11189   8C 3.6         8    Klf5     5.7700
## 11190   8C 3.7         8    Klf5     6.9450
## 11191   8C 3.8         8    Klf5     4.1400
## 11192   8C 4.2         8    Klf5     8.9100
## 11193   8C 4.3         8    Klf5     3.9150
## 11194   8C 4.4         8    Klf5     5.5400
## 11195   8C 4.5         8    Klf5     9.8950
## 11196   8C 4.6         8    Klf5     6.0150
## 11197   8C 4.7         8    Klf5     4.2850
## 11198   8C 5.1         8    Klf5     5.9050
## 11199   8C 5.2         8    Klf5     4.3300
## 11200   8C 5.3         8    Klf5     3.9550
## 11201   8C 5.4         8    Klf5     4.1450
## 11202   8C 5.5         8    Klf5     7.1900
## 11203   8C 5.6         8    Klf5     4.7750
## 11204   8C 5.7         8    Klf5     6.3450
## 11205   8C 5.8         8    Klf5     6.0400
## 11206   8C 6.1         8    Klf5     5.3600
## 11207   8C 6.2         8    Klf5     6.0350
## 11208   8C 6.3         8    Klf5     4.5250
## 11209   8C 6.4         8    Klf5     5.4400
## 11210   8C 6.5         8    Klf5     5.0400
## 11211   8C 6.6         8    Klf5     4.6900
## 11212   8C 6.7         8    Klf5     5.7900
## 11213   8C 6.8         8    Klf5     7.0100
## 11214  16C 1.1        16    Klf5     6.0675
## 11215  16C 1.2        16    Klf5     5.1350
## 11216  16C 1.3        16    Klf5     4.8200
## 11217  16C 1.4        16    Klf5     3.6900
## 11218  16C 1.5        16    Klf5     3.1750
## 11219  16C 1.6        16    Klf5     0.8150
## 11220  16C 1.7        16    Klf5     4.5550
## 11221  16C 1.8        16    Klf5     5.2850
## 11222  16C 1.9        16    Klf5     6.0450
## 11223 16C 1.10        16    Klf5     3.7075
## 11224 16C 1.11        16    Klf5     5.5850
## 11225 16C 1.12        16    Klf5     3.9000
## 11226 16C 1.13        16    Klf5     3.6500
## 11227 16C 1.14        16    Klf5     1.3450
## 11228 16C 1.15        16    Klf5     3.5000
## 11229 16C 1.16        16    Klf5     3.3450
## 11230  16C 2.1        16    Klf5     6.6450
## 11231  16C 2.2        16    Klf5     6.0800
## 11232  16C 2.3        16    Klf5     4.2725
## 11233  16C 2.4        16    Klf5     5.0150
## 11234  16C 2.5        16    Klf5     3.1150
## 11235  16C 2.6        16    Klf5     3.2300
## 11236  16C 2.7        16    Klf5     3.7550
## 11237  16C 2.8        16    Klf5     4.2350
## 11238  16C 2.9        16    Klf5     4.2450
## 11239 16C 2.10        16    Klf5     5.2850
## 11240 16C 2.11        16    Klf5     7.2350
## 11241 16C 2.12        16    Klf5     4.7600
## 11242 16C 2.13        16    Klf5     6.8350
## 11243 16C 2.14        16    Klf5     5.7850
## 11244 16C 2.15        16    Klf5     4.8800
## 11245 16C 2.16        16    Klf5     2.4650
## 11246  16C 3.1        16    Klf5     3.5900
## 11247  16C 3.2        16    Klf5     3.2350
## 11248  16C 3.3        16    Klf5     5.9850
## 11249  16C 3.4        16    Klf5     6.4750
## 11250  16C 3.5        16    Klf5     5.2400
## 11251  16C 3.6        16    Klf5     7.3500
## 11252  16C 3.7        16    Klf5     6.1550
## 11253  16C 3.8        16    Klf5     2.6850
## 11254  16C 3.9        16    Klf5     3.7050
## 11255 16C 3.10        16    Klf5     3.9050
## 11256 16C 3.11        16    Klf5     3.6500
## 11257 16C 3.12        16    Klf5     4.8950
## 11258 16C 3.13        16    Klf5     7.1450
## 11259 16C 3.14        16    Klf5     4.6200
## 11260 16C 3.15        16    Klf5     4.8950
## 11261  16C 4.1        16    Klf5     5.8400
## 11262  16C 4.2        16    Klf5     3.9200
## 11263  16C 4.3        16    Klf5     3.8400
## 11264  16C 4.4        16    Klf5     3.6850
## 11265  16C 4.5        16    Klf5     2.0800
## 11266  16C 4.6        16    Klf5     5.7400
## 11267  16C 4.7        16    Klf5     5.1450
## 11268  16C 4.8        16    Klf5     4.4350
## 11269  16C 4.9        16    Klf5     7.1300
## 11270 16C 4.10        16    Klf5     5.7950
## 11271 16C 4.11        16    Klf5     3.4400
## 11272 16C 4.12        16    Klf5     3.1800
## 11273 16C 4.13        16    Klf5     3.7950
## 11274 16C 4.14        16    Klf5     3.8300
## 11275 16C 4.15        16    Klf5     6.0450
## 11276 16C 4.16        16    Klf5     5.3700
## 11277  16C 5.1        16    Klf5     5.4400
## 11278  16C 5.2        16    Klf5     6.0000
## 11279  16C 5.3        16    Klf5     5.2100
## 11280  16C 5.4        16    Klf5     4.2200
## 11281  16C 5.5        16    Klf5     4.7050
## 11282  16C 5.6        16    Klf5     4.8700
## 11283  16C 5.7        16    Klf5     4.9750
## 11284  16C 5.8        16    Klf5     7.9950
## 11285  16C 5.9        16    Klf5     6.7350
## 11286 16C 5.10        16    Klf5     6.1050
## 11287 16C 5.11        16    Klf5     9.3100
## 11288 16C 5.12        16    Klf5     4.3550
## 11289  32C 1.1        32    Klf5     4.9450
## 11290  32C 1.2        32    Klf5     3.8150
## 11291  32C 1.3        32    Klf5     5.6400
## 11292  32C 1.4        32    Klf5     3.5800
## 11293  32C 1.5        32    Klf5     8.6550
## 11294  32C 1.6        32    Klf5     8.1050
## 11295  32C 1.7        32    Klf5     6.6500
## 11296  32C 1.8        32    Klf5     8.2900
## 11297  32C 1.9        32    Klf5     8.7850
## 11298 32C 1.10        32    Klf5     5.4600
## 11299 32C 1.11        32    Klf5     4.4500
## 11300 32C 1.12        32    Klf5     4.5750
## 11301 32C 1.13        32    Klf5     5.1000
## 11302 32C 1.14        32    Klf5     6.8050
## 11303 32C 1.15        32    Klf5     8.3550
## 11304 32C 1.16        32    Klf5     6.8150
## 11305 32C 1.17        32    Klf5     7.5950
## 11306 32C 1.18        32    Klf5     7.7000
## 11307 32C 1.19        32    Klf5     6.1850
## 11308 32C 1.20        32    Klf5     5.3250
## 11309 32C 1.21        32    Klf5     8.3500
## 11310  32C 2.1        32    Klf5     4.5750
## 11311  32C 2.2        32    Klf5     6.1550
## 11312  32C 2.3        32    Klf5     5.6900
## 11313  32C 2.4        32    Klf5     7.3100
## 11314  32C 2.5        32    Klf5     6.2550
## 11315  32C 2.6        32    Klf5     6.1850
## 11316  32C 2.7        32    Klf5     4.4800
## 11317  32C 2.8        32    Klf5     5.6600
## 11318  32C 2.9        32    Klf5     3.3400
## 11319 32C 2.10        32    Klf5     4.2500
## 11320 32C 2.11        32    Klf5     7.4400
## 11321 32C 2.12        32    Klf5     6.3775
## 11322 32C 2.13        32    Klf5     6.8150
## 11323 32C 2.14        32    Klf5     5.6500
## 11324 32C 2.15        32    Klf5     4.8600
## 11325 32C 2.16        32    Klf5     3.8250
## 11326  32C 3.1        32    Klf5     1.5350
## 11327  32C 3.2        32    Klf5     5.9650
## 11328  32C 3.3        32    Klf5     5.9950
## 11329  32C 3.4        32    Klf5     6.4650
## 11330  32C 3.5        32    Klf5     5.4375
## 11331  32C 3.6        32    Klf5     8.3850
## 11332  32C 3.7        32    Klf5     6.2900
## 11333  32C 3.8        32    Klf5     4.7100
## 11334  32C 4.1        32    Klf5     2.0950
## 11335  32C 4.2        32    Klf5     6.4000
## 11336  32C 4.3        32    Klf5     5.5750
## 11337  32C 4.4        32    Klf5     6.9950
## 11338  32C 4.5        32    Klf5     8.1300
## 11339  32C 4.6        32    Klf5     7.6525
## 11340  32C 4.7        32    Klf5     7.8150
## 11341  32C 4.8        32    Klf5     3.4750
## 11342 32C 4.10        32    Klf5     4.9900
## 11343 32C 4.11        32    Klf5     5.0350
## 11344 32C 4.12        32    Klf5     4.9950
## 11345 32C 4.13        32    Klf5     3.7550
## 11346 32C 4.14        32    Klf5     7.4050
## 11347 32C 4.15        32    Klf5     7.1750
## 11348 32C 4.16        32    Klf5     6.5400
## 11349 32C 4.17        32    Klf5     7.8050
## 11350 32C 4.18        32    Klf5     5.6650
## 11351 32C 4.19        32    Klf5     3.2700
## 11352 32C 4.20        32    Klf5     4.9150
## 11353 32C 4.21        32    Klf5     5.0500
## 11354 32C 4.22        32    Klf5     3.5050
## 11355 32C 4.23        32    Klf5     4.9850
## 11356 32C 4.24        32    Klf5     7.2850
## 11357  32C 5.1        32    Klf5     4.2700
## 11358  32C 5.2        32    Klf5     7.0300
## 11359  32C 5.3        32    Klf5     7.8450
## 11360  32C 5.4        32    Klf5     2.3150
## 11361  32C 5.5        32    Klf5     6.5250
## 11362  32C 5.6        32    Klf5     5.3550
## 11363  32C 5.7        32    Klf5     3.2400
## 11364  32C 5.8        32    Klf5     9.1950
## 11365  32C 5.9        32    Klf5     5.6650
## 11366 32C 5.10        32    Klf5     6.6900
## 11367 32C 5.11        32    Klf5     5.9650
## 11368 32C 5.12        32    Klf5     8.6700
## 11369 32C 5.13        32    Klf5     5.2100
## 11370 32C 5.14        32    Klf5     5.4600
## 11371 32C 5.15        32    Klf5     6.6950
## 11372 32C 5.16        32    Klf5     3.2700
## 11373 32C 5.17        32    Klf5     8.0500
## 11374 32C 5.18        32    Klf5     6.0050
## 11375 32C 5.19        32    Klf5     9.8850
## 11376 32C 5.20        32    Klf5    10.0100
## 11377 32C 5.21        32    Klf5     5.5250
## 11378 32C 5.22        32    Klf5     4.4600
## 11379 32C 5.23        32    Klf5     2.5200
## 11380  32C 6.1        32    Klf5     5.8100
## 11381  32C 6.2        32    Klf5     2.4950
## 11382  32C 6.3        32    Klf5     5.5850
## 11383  32C 6.4        32    Klf5     6.4100
## 11384  32C 6.6        32    Klf5     4.8450
## 11385  32C 6.7        32    Klf5     7.7100
## 11386  32C 7.1        32    Klf5     5.6450
## 11387  32C 7.2        32    Klf5     7.0050
## 11388  32C 7.3        32    Klf5     5.0050
## 11389  32C 7.4        32    Klf5     5.0900
## 11390  32C 7.5        32    Klf5     6.0050
## 11391  32C 7.6        32    Klf5    10.3750
## 11392  32C 7.8        32    Klf5     7.2800
## 11393  32C 8.1        32    Klf5     6.1200
## 11394  32C 8.2        32    Klf5     9.5200
## 11395  32C 8.4        32    Klf5     6.1100
## 11396  32C 8.5        32    Klf5     6.5950
## 11397  32C 8.6        32    Klf5     1.7200
## 11398  64C 1.1        64    Klf5     9.1400
## 11399  64C 1.2        64    Klf5     7.5200
## 11400  64C 1.3        64    Klf5    10.0250
## 11401  64C 1.4        64    Klf5     9.7850
## 11402  64C 1.5        64    Klf5     6.3500
## 11403  64C 1.6        64    Klf5     9.7800
## 11404  64C 1.7        64    Klf5     9.7650
## 11405  64C 1.8        64    Klf5     7.8600
## 11406  64C 1.9        64    Klf5     6.7800
## 11407 64C 1.10        64    Klf5     8.7750
## 11408 64C 1.11        64    Klf5     6.2400
## 11409 64C 1.12        64    Klf5     9.0050
## 11410 64C 1.13        64    Klf5     8.5650
## 11411 64C 1.14        64    Klf5     7.6150
## 11412 64C 1.15        64    Klf5     9.1050
## 11413 64C 1.16        64    Klf5     8.3400
## 11414 64C 1.17        64    Klf5     7.7350
## 11415 64C 1.18        64    Klf5     7.5750
## 11416 64C 1.19        64    Klf5     8.3000
## 11417 64C 1.20        64    Klf5     7.3650
## 11418 64C 1.21        64    Klf5    11.3150
## 11419 64C 1.22        64    Klf5     9.6100
## 11420 64C 1.23        64    Klf5     9.1900
## 11421 64C 1.24        64    Klf5     9.0050
## 11422 64C 1.25        64    Klf5     7.4550
## 11423 64C 1.26        64    Klf5     6.9300
## 11424 64C 1.27        64    Klf5     6.7600
## 11425 64C 1.28        64    Klf5     5.8300
## 11426 64C 1.29        64    Klf5     7.2700
## 11427 64C 1.30        64    Klf5     8.3900
## 11428 64C 1.31        64    Klf5     6.9475
## 11429 64C 1.32        64    Klf5     7.5250
## 11430 64C 1.33        64    Klf5     7.7000
## 11431 64C 1.34        64    Klf5    10.3400
## 11432 64C 1.35        64    Klf5     4.7950
## 11433 64C 1.36        64    Klf5     3.7550
## 11434 64C 1.37        64    Klf5     7.5850
## 11435 64C 1.38        64    Klf5     7.9050
## 11436 64C 1.39        64    Klf5     7.3550
## 11437 64C 1.40        64    Klf5     8.3075
## 11438 64C 1.41        64    Klf5     8.8750
## 11439 64C 1.42        64    Klf5     6.8800
## 11440 64C 1.43        64    Klf5     7.2100
## 11441 64C 1.44        64    Klf5     5.1550
## 11442 64C 1.45        64    Klf5     7.7200
## 11443 64C 1.46        64    Klf5     5.0050
## 11444 64C 1.47        64    Klf5     7.5350
## 11445 64C 1.48        64    Klf5     7.5100
## 11446  64C 2.1        64    Klf5     6.2225
## 11447  64C 2.2        64    Klf5     4.1950
## 11448  64C 2.3        64    Klf5     5.4950
## 11449  64C 2.4        64    Klf5     5.7400
## 11450  64C 2.5        64    Klf5     4.0850
## 11451  64C 2.6        64    Klf5     6.5250
## 11452  64C 2.7        64    Klf5     5.7050
## 11453  64C 2.8        64    Klf5     7.3150
## 11454  64C 2.9        64    Klf5     7.0950
## 11455 64C 2.10        64    Klf5     5.3100
## 11456 64C 2.11        64    Klf5     8.7150
## 11457 64C 2.12        64    Klf5     7.8450
## 11458 64C 2.13        64    Klf5     5.9500
## 11459 64C 2.14        64    Klf5     3.7950
## 11460 64C 2.15        64    Klf5     4.5500
## 11461 64C 2.16        64    Klf5     4.4750
## 11462 64C 2.17        64    Klf5     9.3150
## 11463 64C 2.18        64    Klf5     7.6450
## 11464 64C 2.19        64    Klf5     6.8800
## 11465 64C 2.20        64    Klf5     9.3600
## 11466 64C 2.21        64    Klf5     8.4950
## 11467 64C 2.22        64    Klf5     4.3950
## 11468 64C 2.23        64    Klf5     5.0850
## 11469 64C 2.24        64    Klf5     5.8650
## 11470 64C 2.25        64    Klf5     4.6500
## 11471  64C 3.1        64    Klf5     7.4350
## 11472  64C 3.2        64    Klf5     8.8050
## 11473  64C 3.3        64    Klf5     7.0100
## 11474  64C 3.4        64    Klf5     7.7950
## 11475  64C 3.5        64    Klf5     8.8400
## 11476  64C 3.6        64    Klf5     7.4900
## 11477  64C 3.7        64    Klf5     7.7200
## 11478  64C 3.8        64    Klf5     6.8850
## 11479  64C 4.1        64    Klf5     6.7400
## 11480 64C 4.1b        64    Klf5    12.0000
## 11481  64C 4.2        64    Klf5    10.6150
## 11482  64C 4.3        64    Klf5     9.2550
## 11483  64C 4.4        64    Klf5    14.1700
## 11484  64C 4.5        64    Klf5     9.7850
## 11485  64C 4.6        64    Klf5     9.5300
## 11486  64C 4.7        64    Klf5     6.0500
## 11487  64C 4.8        64    Klf5     7.4250
## 11488  64C 4.9        64    Klf5     8.0900
## 11489 64C 4.10        64    Klf5     9.3150
## 11490 64C 4.11        64    Klf5    11.7100
## 11491 64C 4.12        64    Klf5     8.7300
## 11492 64C 4.13        64    Klf5     8.3000
## 11493 64C 4.14        64    Klf5     7.7900
## 11494 64C 4.15        64    Klf5     7.0800
## 11495 64C 4.16        64    Klf5     9.4950
## 11496 64C 4.17        64    Klf5     9.8900
## 11497 64C 4.18        64    Klf5     5.8050
## 11498 64C 4.19        64    Klf5     9.9550
## 11499 64C 4.20        64    Klf5     8.4050
## 11500 64C 4.21        64    Klf5     9.2150
## 11501 64C 4.22        64    Klf5    11.6000
## 11502 64C 4.23        64    Klf5     8.1350
## 11503 64C 4.24        64    Klf5    10.5350
## 11504 64C 4.25        64    Klf5     5.0750
## 11505 64C 4.26        64    Klf5     8.7600
## 11506 64C 4.27        64    Klf5     7.1300
## 11507 64C 4.28        64    Klf5     8.0050
## 11508 64C 4.29        64    Klf5     9.8350
## 11509 64C 4.30        64    Klf5     6.4200
## 11510 64C 4.31        64    Klf5    10.7800
## 11511 64C 4.32        64    Klf5    12.9250
## 11512 64C 4.33        64    Klf5     6.7400
## 11513 64C 4.34        64    Klf5     7.1000
## 11514 64C 4.35        64    Klf5     6.7450
## 11515 64C 4.36        64    Klf5     5.9100
## 11516 64C 4.37        64    Klf5     9.1150
## 11517 64C 4.38        64    Klf5     8.9850
## 11518 64C 4.39        64    Klf5    12.5350
## 11519  64C 5.1        64    Klf5     8.9250
## 11520  64C 5.2        64    Klf5     7.7300
## 11521  64C 5.3        64    Klf5     7.3450
## 11522  64C 5.4        64    Klf5     7.7750
## 11523  64C 5.5        64    Klf5     9.8000
## 11524  64C 5.6        64    Klf5     8.2150
## 11525  64C 5.7        64    Klf5     9.0250
## 11526  64C 5.8        64    Klf5    13.9300
## 11527  64C 5.9        64    Klf5     8.4900
## 11528 64C 5.10        64    Klf5     9.0550
## 11529 64C 5.11        64    Klf5     7.5850
## 11530 64C 5.12        64    Klf5     7.5400
## 11531 64C 5.13        64    Klf5     7.5900
## 11532 64C 5.14        64    Klf5     6.6500
## 11533 64C 5.15        64    Klf5    12.6300
## 11534 64C 5.16        64    Klf5    11.1400
## 11535  64C 6.1        64    Klf5     6.2175
## 11536  64C 6.2        64    Klf5     7.8150
## 11537  64C 6.3        64    Klf5     7.9100
## 11538  64C 6.4        64    Klf5     7.4300
## 11539  64C 6.5        64    Klf5    10.7950
## 11540  64C 6.6        64    Klf5     5.9150
## 11541  64C 6.7        64    Klf5     7.8850
## 11542  64C 6.8        64    Klf5     9.3750
## 11543  64C 7.1        64    Klf5    13.3650
## 11544  64C 7.2        64    Klf5     7.1375
## 11545  64C 7.3        64    Klf5    12.4550
## 11546  64C 7.4        64    Klf5     7.5500
## 11547  64C 7.5        64    Klf5     9.7000
## 11548  64C 7.6        64    Klf5     5.6850
## 11549  64C 7.7        64    Klf5     8.3400
## 11550  64C 7.8        64    Klf5     6.7850
## 11551  64C 7.9        64    Klf5    10.5550
## 11552 64C 7.10        64    Klf5    11.2100
## 11553 64C 7.11        64    Klf5     8.3325
## 11554 64C 7.12        64    Klf5     9.8750
## 11555 64C 7.13        64    Klf5     7.4950
## 11556 64C 7.14        64    Klf5     6.6600
## 11557   2C 1.1         2    Krt8    10.3100
## 11558   2C 1.2         2    Krt8    11.8050
## 11559   2C 2.1         2    Krt8    11.2000
## 11560   2C 2.2         2    Krt8    13.3600
## 11561   2C 3.1         2    Krt8    13.4950
## 11562   2C 3.2         2    Krt8    11.7925
## 11563   2C 4.1         2    Krt8    14.2450
## 11564   2C 5.1         2    Krt8    13.9850
## 11565   2C 5.2         2    Krt8     7.6950
## 11566   2C 6.1         2    Krt8     2.9050
## 11567   2C 6.2         2    Krt8     5.4550
## 11568   2C 7.1         2    Krt8     4.2550
## 11569   2C 7.2         2    Krt8     8.4500
## 11570   2C 8.1         2    Krt8    13.7500
## 11571   2C 8.2         2    Krt8    11.4600
## 11572   2C 9.1         2    Krt8     7.8150
## 11573   2C 9.2         2    Krt8    13.1300
## 11574  2C 10.1         2    Krt8    11.7650
## 11575  2C 10.2         2    Krt8    11.2100
## 11576   4C 1.1         4    Krt8    11.3750
## 11577   4C 1.2         4    Krt8    10.9100
## 11578   4C 1.3         4    Krt8    12.5900
## 11579   4C 1.4         4    Krt8    13.5550
## 11580   4C 2.1         4    Krt8    11.6700
## 11581   4C 2.2         4    Krt8    13.3950
## 11582   4C 2.3         4    Krt8    14.0200
## 11583   4C 3.1         4    Krt8     6.9100
## 11584   4C 3.2         4    Krt8     6.5700
## 11585   4C 3.3         4    Krt8    12.1650
## 11586   4C 3.4         4    Krt8     6.9300
## 11587   4C 4.1         4    Krt8    14.7500
## 11588   4C 4.2         4    Krt8    14.1500
## 11589   4C 4.3         4    Krt8    12.2850
## 11590   4C 4.4         4    Krt8    14.0100
## 11591   4C 5.1         4    Krt8    13.3200
## 11592   4C 5.2         4    Krt8     8.4750
## 11593   4C 5.3         4    Krt8     4.9700
## 11594   4C 5.4         4    Krt8    11.8950
## 11595   4C 6.1         4    Krt8    11.2000
## 11596   4C 6.2         4    Krt8    11.0550
## 11597   4C 6.3         4    Krt8    12.2600
## 11598   4C 6.4         4    Krt8     9.2650
## 11599   8C 1.1         8    Krt8    14.8100
## 11600   8C 1.2         8    Krt8    14.4450
## 11601   8C 1.3         8    Krt8     7.9750
## 11602   8C 1.4         8    Krt8    12.1750
## 11603   8C 1.5         8    Krt8    12.4150
## 11604   8C 2.1         8    Krt8     4.9100
## 11605   8C 2.2         8    Krt8     7.7700
## 11606   8C 2.3         8    Krt8     7.3750
## 11607   8C 2.4         8    Krt8    13.2550
## 11608   8C 2.5         8    Krt8     7.7100
## 11609   8C 2.6         8    Krt8     6.6150
## 11610   8C 2.7         8    Krt8    11.1850
## 11611   8C 2.8         8    Krt8    11.5100
## 11612   8C 3.1         8    Krt8    12.4300
## 11613   8C 3.2         8    Krt8    11.7000
## 11614   8C 3.3         8    Krt8    14.3100
## 11615   8C 3.4         8    Krt8     6.0350
## 11616   8C 3.5         8    Krt8     6.6600
## 11617   8C 3.6         8    Krt8     9.4300
## 11618   8C 3.7         8    Krt8     9.8100
## 11619   8C 3.8         8    Krt8     4.6700
## 11620   8C 4.2         8    Krt8     9.6850
## 11621   8C 4.3         8    Krt8     4.7600
## 11622   8C 4.4         8    Krt8    12.6600
## 11623   8C 4.5         8    Krt8    14.2350
## 11624   8C 4.6         8    Krt8    12.9600
## 11625   8C 4.7         8    Krt8     8.0450
## 11626   8C 5.1         8    Krt8     6.1100
## 11627   8C 5.2         8    Krt8     4.7500
## 11628   8C 5.3         8    Krt8     5.6850
## 11629   8C 5.4         8    Krt8     3.2150
## 11630   8C 5.5         8    Krt8     6.4950
## 11631   8C 5.6         8    Krt8     3.4500
## 11632   8C 5.7         8    Krt8    14.1900
## 11633   8C 5.8         8    Krt8     6.8650
## 11634   8C 6.1         8    Krt8     6.7350
## 11635   8C 6.2         8    Krt8     6.6400
## 11636   8C 6.3         8    Krt8     5.7800
## 11637   8C 6.4         8    Krt8    11.5150
## 11638   8C 6.5         8    Krt8     4.6950
## 11639   8C 6.6         8    Krt8     6.3550
## 11640   8C 6.7         8    Krt8     6.8950
## 11641   8C 6.8         8    Krt8    11.9900
## 11642  16C 1.1        16    Krt8     9.7450
## 11643  16C 1.2        16    Krt8     7.4300
## 11644  16C 1.3        16    Krt8     5.4500
## 11645  16C 1.4        16    Krt8     3.0850
## 11646  16C 1.5        16    Krt8     2.6850
## 11647  16C 1.6        16    Krt8     3.3850
## 11648  16C 1.7        16    Krt8     4.7950
## 11649  16C 1.8        16    Krt8     4.8350
## 11650  16C 1.9        16    Krt8    13.6300
## 11651 16C 1.10        16    Krt8     6.1650
## 11652 16C 1.11        16    Krt8     5.7300
## 11653 16C 1.12        16    Krt8     2.9700
## 11654 16C 1.13        16    Krt8     4.8950
## 11655 16C 1.14        16    Krt8     1.9050
## 11656 16C 1.15        16    Krt8     5.8850
## 11657 16C 1.16        16    Krt8     2.6350
## 11658  16C 2.1        16    Krt8     7.0400
## 11659  16C 2.2        16    Krt8     4.6450
## 11660  16C 2.3        16    Krt8     5.2825
## 11661  16C 2.4        16    Krt8     3.3200
## 11662  16C 2.5        16    Krt8     3.5900
## 11663  16C 2.6        16    Krt8    -0.5700
## 11664  16C 2.7        16    Krt8     3.0400
## 11665  16C 2.8        16    Krt8     3.0450
## 11666  16C 2.9        16    Krt8     2.7200
## 11667 16C 2.10        16    Krt8     6.1000
## 11668 16C 2.11        16    Krt8     6.2350
## 11669 16C 2.12        16    Krt8     2.1225
## 11670 16C 2.13        16    Krt8     6.0650
## 11671 16C 2.14        16    Krt8     3.7350
## 11672 16C 2.15        16    Krt8     4.5350
## 11673 16C 2.16        16    Krt8     0.4250
## 11674  16C 3.1        16    Krt8     4.3550
## 11675  16C 3.2        16    Krt8     3.6650
## 11676  16C 3.3        16    Krt8     6.1200
## 11677  16C 3.4        16    Krt8     8.0700
## 11678  16C 3.5        16    Krt8     5.9000
## 11679  16C 3.6        16    Krt8     8.6750
## 11680  16C 3.7        16    Krt8     6.8400
## 11681  16C 3.8        16    Krt8     4.8350
## 11682  16C 3.9        16    Krt8    11.2100
## 11683 16C 3.10        16    Krt8     4.5550
## 11684 16C 3.11        16    Krt8    10.9100
## 11685 16C 3.12        16    Krt8     7.2300
## 11686 16C 3.13        16    Krt8     9.7450
## 11687 16C 3.14        16    Krt8     4.2600
## 11688 16C 3.15        16    Krt8     8.8050
## 11689  16C 4.1        16    Krt8     7.4700
## 11690  16C 4.2        16    Krt8     6.7100
## 11691  16C 4.3        16    Krt8     7.3700
## 11692  16C 4.4        16    Krt8     5.6950
## 11693  16C 4.5        16    Krt8    11.1400
## 11694  16C 4.6        16    Krt8     6.6100
## 11695  16C 4.7        16    Krt8     7.9500
## 11696  16C 4.8        16    Krt8     5.2850
## 11697  16C 4.9        16    Krt8    14.0100
## 11698 16C 4.10        16    Krt8     7.7700
## 11699 16C 4.11        16    Krt8     7.1950
## 11700 16C 4.12        16    Krt8     4.7300
## 11701 16C 4.13        16    Krt8     6.2150
## 11702 16C 4.14        16    Krt8     7.2600
## 11703 16C 4.15        16    Krt8    12.7850
## 11704 16C 4.16        16    Krt8    13.0900
## 11705  16C 5.1        16    Krt8     9.0950
## 11706  16C 5.2        16    Krt8    10.5200
## 11707  16C 5.3        16    Krt8    14.4450
## 11708  16C 5.4        16    Krt8     4.5450
## 11709  16C 5.5        16    Krt8     4.0350
## 11710  16C 5.6        16    Krt8     9.0650
## 11711  16C 5.7        16    Krt8     3.0900
## 11712  16C 5.8        16    Krt8    13.4600
## 11713  16C 5.9        16    Krt8     6.6950
## 11714 16C 5.10        16    Krt8     8.4150
## 11715 16C 5.11        16    Krt8     6.5300
## 11716 16C 5.12        16    Krt8    13.8750
## 11717  32C 1.1        32    Krt8    -0.4550
## 11718  32C 1.2        32    Krt8     4.5400
## 11719  32C 1.3        32    Krt8     0.5000
## 11720  32C 1.4        32    Krt8     0.0500
## 11721  32C 1.5        32    Krt8     8.8800
## 11722  32C 1.6        32    Krt8     5.3250
## 11723  32C 1.7        32    Krt8     0.5600
## 11724  32C 1.8        32    Krt8     6.0500
## 11725  32C 1.9        32    Krt8     6.5100
## 11726 32C 1.10        32    Krt8     3.9900
## 11727 32C 1.11        32    Krt8    -1.8650
## 11728 32C 1.12        32    Krt8     0.2000
## 11729 32C 1.13        32    Krt8     7.5500
## 11730 32C 1.14        32    Krt8     1.7750
## 11731 32C 1.15        32    Krt8     5.3000
## 11732 32C 1.16        32    Krt8     7.1350
## 11733 32C 1.17        32    Krt8     4.4500
## 11734 32C 1.18        32    Krt8     3.8600
## 11735 32C 1.19        32    Krt8     3.7350
## 11736 32C 1.20        32    Krt8     3.8650
## 11737 32C 1.21        32    Krt8     2.8550
## 11738  32C 2.1        32    Krt8    -3.7400
## 11739  32C 2.2        32    Krt8     1.7400
## 11740  32C 2.3        32    Krt8     0.5450
## 11741  32C 2.4        32    Krt8     4.7850
## 11742  32C 2.5        32    Krt8     3.7400
## 11743  32C 2.6        32    Krt8     0.5800
## 11744  32C 2.7        32    Krt8    -0.9950
## 11745  32C 2.8        32    Krt8     0.3150
## 11746  32C 2.9        32    Krt8    -1.6350
## 11747 32C 2.10        32    Krt8    -1.5850
## 11748 32C 2.11        32    Krt8     3.9000
## 11749 32C 2.12        32    Krt8     1.8250
## 11750 32C 2.13        32    Krt8     6.4000
## 11751 32C 2.14        32    Krt8     2.2700
## 11752 32C 2.15        32    Krt8     3.8550
## 11753 32C 2.16        32    Krt8     0.4550
## 11754  32C 3.1        32    Krt8    -2.7350
## 11755  32C 3.2        32    Krt8    -0.4150
## 11756  32C 3.3        32    Krt8     1.4550
## 11757  32C 3.4        32    Krt8    -0.2100
## 11758  32C 3.5        32    Krt8     0.3950
## 11759  32C 3.6        32    Krt8     4.7400
## 11760  32C 3.7        32    Krt8     0.3600
## 11761  32C 3.8        32    Krt8     2.7450
## 11762  32C 4.1        32    Krt8    -1.0350
## 11763  32C 4.2        32    Krt8     1.6650
## 11764  32C 4.3        32    Krt8     2.2450
## 11765  32C 4.4        32    Krt8    10.0000
## 11766  32C 4.5        32    Krt8     7.1750
## 11767  32C 4.6        32    Krt8     5.0325
## 11768  32C 4.7        32    Krt8     1.9000
## 11769  32C 4.8        32    Krt8     1.0400
## 11770 32C 4.10        32    Krt8     0.3100
## 11771 32C 4.11        32    Krt8     2.9900
## 11772 32C 4.12        32    Krt8     0.5750
## 11773 32C 4.13        32    Krt8     0.6600
## 11774 32C 4.14        32    Krt8     5.4200
## 11775 32C 4.15        32    Krt8     7.2850
## 11776 32C 4.16        32    Krt8     4.0325
## 11777 32C 4.17        32    Krt8     3.3050
## 11778 32C 4.18        32    Krt8     1.4650
## 11779 32C 4.19        32    Krt8     0.0550
## 11780 32C 4.20        32    Krt8     3.2250
## 11781 32C 4.21        32    Krt8     4.3950
## 11782 32C 4.22        32    Krt8     0.1450
## 11783 32C 4.23        32    Krt8     1.0300
## 11784 32C 4.24        32    Krt8     6.0800
## 11785  32C 5.1        32    Krt8    -1.4300
## 11786  32C 5.2        32    Krt8     4.7350
## 11787  32C 5.3        32    Krt8     7.0300
## 11788  32C 5.4        32    Krt8     0.0450
## 11789  32C 5.5        32    Krt8     3.0500
## 11790  32C 5.6        32    Krt8     0.8250
## 11791  32C 5.7        32    Krt8     0.3900
## 11792  32C 5.8        32    Krt8     4.7000
## 11793  32C 5.9        32    Krt8     2.0050
## 11794 32C 5.10        32    Krt8     3.3200
## 11795 32C 5.11        32    Krt8     2.7450
## 11796 32C 5.12        32    Krt8     6.6400
## 11797 32C 5.13        32    Krt8     0.9000
## 11798 32C 5.14        32    Krt8     0.3000
## 11799 32C 5.15        32    Krt8     1.5650
## 11800 32C 5.16        32    Krt8    -0.9000
## 11801 32C 5.17        32    Krt8     4.6200
## 11802 32C 5.18        32    Krt8     2.6400
## 11803 32C 5.19        32    Krt8     4.8250
## 11804 32C 5.20        32    Krt8     4.8500
## 11805 32C 5.21        32    Krt8     1.3200
## 11806 32C 5.22        32    Krt8     1.0650
## 11807 32C 5.23        32    Krt8    -0.6900
## 11808  32C 6.1        32    Krt8     3.9650
## 11809  32C 6.2        32    Krt8    -3.1600
## 11810  32C 6.3        32    Krt8     1.9650
## 11811  32C 6.4        32    Krt8     4.3850
## 11812  32C 6.6        32    Krt8     0.6550
## 11813  32C 6.7        32    Krt8     5.9450
## 11814  32C 7.1        32    Krt8     3.4200
## 11815  32C 7.2        32    Krt8     5.3350
## 11816  32C 7.3        32    Krt8     1.2500
## 11817  32C 7.4        32    Krt8     1.6750
## 11818  32C 7.5        32    Krt8    11.6200
## 11819  32C 7.6        32    Krt8     7.4750
## 11820  32C 7.8        32    Krt8     1.6450
## 11821  32C 8.1        32    Krt8     1.9850
## 11822  32C 8.2        32    Krt8     2.7350
## 11823  32C 8.4        32    Krt8     4.4000
## 11824  32C 8.5        32    Krt8     2.9450
## 11825  32C 8.6        32    Krt8     1.2650
## 11826  64C 1.1        64    Krt8     5.1200
## 11827  64C 1.2        64    Krt8     2.4700
## 11828  64C 1.3        64    Krt8    14.3100
## 11829  64C 1.4        64    Krt8     8.8950
## 11830  64C 1.5        64    Krt8     4.1500
## 11831  64C 1.6        64    Krt8    13.9200
## 11832  64C 1.7        64    Krt8    12.8700
## 11833  64C 1.8        64    Krt8     1.7300
## 11834  64C 1.9        64    Krt8     4.8150
## 11835 64C 1.10        64    Krt8     1.4700
## 11836 64C 1.11        64    Krt8     6.1000
## 11837 64C 1.12        64    Krt8     3.2850
## 11838 64C 1.13        64    Krt8    12.9600
## 11839 64C 1.14        64    Krt8     2.9950
## 11840 64C 1.15        64    Krt8     1.6600
## 11841 64C 1.16        64    Krt8     1.0100
## 11842 64C 1.17        64    Krt8     1.0150
## 11843 64C 1.18        64    Krt8     0.0750
## 11844 64C 1.19        64    Krt8     0.7550
## 11845 64C 1.20        64    Krt8     1.8600
## 11846 64C 1.21        64    Krt8     7.5800
## 11847 64C 1.22        64    Krt8     8.7450
## 11848 64C 1.23        64    Krt8    13.9450
## 11849 64C 1.24        64    Krt8     1.0200
## 11850 64C 1.25        64    Krt8    -0.0600
## 11851 64C 1.26        64    Krt8     5.3050
## 11852 64C 1.27        64    Krt8    -3.8450
## 11853 64C 1.28        64    Krt8    -0.6450
## 11854 64C 1.29        64    Krt8    -1.2250
## 11855 64C 1.30        64    Krt8     2.6000
## 11856 64C 1.31        64    Krt8     2.3650
## 11857 64C 1.32        64    Krt8     3.7800
## 11858 64C 1.33        64    Krt8    -0.4500
## 11859 64C 1.34        64    Krt8     2.5250
## 11860 64C 1.35        64    Krt8    -2.7350
## 11861 64C 1.36        64    Krt8    -1.3050
## 11862 64C 1.37        64    Krt8    -0.2450
## 11863 64C 1.38        64    Krt8     1.5550
## 11864 64C 1.39        64    Krt8     0.7500
## 11865 64C 1.40        64    Krt8     9.4950
## 11866 64C 1.41        64    Krt8     9.0700
## 11867 64C 1.42        64    Krt8     4.5500
## 11868 64C 1.43        64    Krt8     8.7350
## 11869 64C 1.44        64    Krt8    -1.7350
## 11870 64C 1.45        64    Krt8     2.4550
## 11871 64C 1.46        64    Krt8    -1.5450
## 11872 64C 1.47        64    Krt8     1.8600
## 11873 64C 1.48        64    Krt8     1.4250
## 11874  64C 2.1        64    Krt8     0.2525
## 11875  64C 2.2        64    Krt8    -0.6700
## 11876  64C 2.3        64    Krt8     0.9600
## 11877  64C 2.4        64    Krt8     0.7400
## 11878  64C 2.5        64    Krt8     4.1900
## 11879  64C 2.6        64    Krt8     0.3850
## 11880  64C 2.7        64    Krt8     4.9900
## 11881  64C 2.8        64    Krt8     8.8800
## 11882  64C 2.9        64    Krt8     1.0150
## 11883 64C 2.10        64    Krt8    -0.9875
## 11884 64C 2.11        64    Krt8     2.1650
## 11885 64C 2.12        64    Krt8     2.6950
## 11886 64C 2.13        64    Krt8    -0.7250
## 11887 64C 2.14        64    Krt8    -1.3450
## 11888 64C 2.15        64    Krt8     1.2050
## 11889 64C 2.16        64    Krt8     2.8250
## 11890 64C 2.17        64    Krt8    12.9200
## 11891 64C 2.18        64    Krt8     0.1500
## 11892 64C 2.19        64    Krt8    -0.7700
## 11893 64C 2.20        64    Krt8     2.0550
## 11894 64C 2.21        64    Krt8     1.7100
## 11895 64C 2.22        64    Krt8    -0.5150
## 11896 64C 2.23        64    Krt8    -0.8300
## 11897 64C 2.24        64    Krt8    -1.4650
## 11898 64C 2.25        64    Krt8    -0.1000
## 11899  64C 3.1        64    Krt8     3.0000
## 11900  64C 3.2        64    Krt8     5.4950
## 11901  64C 3.3        64    Krt8     2.1400
## 11902  64C 3.4        64    Krt8     4.9950
## 11903  64C 3.5        64    Krt8    10.8500
## 11904  64C 3.6        64    Krt8     2.3900
## 11905  64C 3.7        64    Krt8     2.5200
## 11906  64C 3.8        64    Krt8     2.5650
## 11907  64C 4.1        64    Krt8    11.0500
## 11908 64C 4.1b        64    Krt8    14.7500
## 11909  64C 4.2        64    Krt8    14.1500
## 11910  64C 4.3        64    Krt8    12.2850
## 11911  64C 4.4        64    Krt8    12.0100
## 11912  64C 4.5        64    Krt8    13.3200
## 11913  64C 4.6        64    Krt8    12.5450
## 11914  64C 4.7        64    Krt8     3.7500
## 11915  64C 4.8        64    Krt8    11.8950
## 11916  64C 4.9        64    Krt8     3.8500
## 11917 64C 4.10        64    Krt8    13.4150
## 11918 64C 4.11        64    Krt8    12.7600
## 11919 64C 4.12        64    Krt8     6.9850
## 11920 64C 4.13        64    Krt8     6.9600
## 11921 64C 4.14        64    Krt8     8.4650
## 11922 64C 4.15        64    Krt8     6.1450
## 11923 64C 4.16        64    Krt8     8.7750
## 11924 64C 4.17        64    Krt8     4.8650
## 11925 64C 4.18        64    Krt8     3.2900
## 11926 64C 4.19        64    Krt8     4.7600
## 11927 64C 4.20        64    Krt8     4.8250
## 11928 64C 4.21        64    Krt8     5.2750
## 11929 64C 4.22        64    Krt8     5.3200
## 11930 64C 4.23        64    Krt8     7.4150
## 11931 64C 4.24        64    Krt8     5.5050
## 11932 64C 4.25        64    Krt8     2.3700
## 11933 64C 4.26        64    Krt8    11.0800
## 11934 64C 4.27        64    Krt8     3.0300
## 11935 64C 4.28        64    Krt8    14.3100
## 11936 64C 4.29        64    Krt8     4.8650
## 11937 64C 4.30        64    Krt8     9.3700
## 11938 64C 4.31        64    Krt8     7.0900
## 11939 64C 4.32        64    Krt8    14.7300
## 11940 64C 4.33        64    Krt8     5.9900
## 11941 64C 4.34        64    Krt8     0.9550
## 11942 64C 4.35        64    Krt8     7.5100
## 11943 64C 4.36        64    Krt8     2.0200
## 11944 64C 4.37        64    Krt8     4.7150
## 11945 64C 4.38        64    Krt8     3.5300
## 11946 64C 4.39        64    Krt8     5.7750
## 11947  64C 5.1        64    Krt8     7.9900
## 11948  64C 5.2        64    Krt8    12.7300
## 11949  64C 5.3        64    Krt8    11.1050
## 11950  64C 5.4        64    Krt8     3.6750
## 11951  64C 5.5        64    Krt8    10.8650
## 11952  64C 5.6        64    Krt8     9.7400
## 11953  64C 5.7        64    Krt8    14.1900
## 11954  64C 5.8        64    Krt8    10.3150
## 11955  64C 5.9        64    Krt8    13.9450
## 11956 64C 5.10        64    Krt8    13.1700
## 11957 64C 5.11        64    Krt8    11.3900
## 11958 64C 5.12        64    Krt8     4.4750
## 11959 64C 5.13        64    Krt8     2.4050
## 11960 64C 5.14        64    Krt8     5.9850
## 11961 64C 5.15        64    Krt8     9.5050
## 11962 64C 5.16        64    Krt8    13.6700
## 11963  64C 6.1        64    Krt8    14.3150
## 11964  64C 6.2        64    Krt8    15.2400
## 11965  64C 6.3        64    Krt8    11.7400
## 11966  64C 6.4        64    Krt8    12.2750
## 11967  64C 6.5        64    Krt8    10.6750
## 11968  64C 6.6        64    Krt8    11.5250
## 11969  64C 6.7        64    Krt8    12.4650
## 11970  64C 6.8        64    Krt8    13.3750
## 11971  64C 7.1        64    Krt8    13.6300
## 11972  64C 7.2        64    Krt8    13.1050
## 11973  64C 7.3        64    Krt8    13.8700
## 11974  64C 7.4        64    Krt8     9.8000
## 11975  64C 7.5        64    Krt8    12.5750
## 11976  64C 7.6        64    Krt8    10.4450
## 11977  64C 7.7        64    Krt8    10.9850
## 11978  64C 7.8        64    Krt8    10.7850
## 11979  64C 7.9        64    Krt8    11.0300
## 11980 64C 7.10        64    Krt8     6.7650
## 11981 64C 7.11        64    Krt8     4.7425
## 11982 64C 7.12        64    Krt8     4.6100
## 11983 64C 7.13        64    Krt8     5.7600
## 11984 64C 7.14        64    Krt8     4.5000
## 11985   2C 1.1         2    Lcp1     6.6050
## 11986   2C 1.2         2    Lcp1     7.0550
## 11987   2C 2.1         2    Lcp1     5.8650
## 11988   2C 2.2         2    Lcp1     8.8500
## 11989   2C 3.1         2    Lcp1    11.0250
## 11990   2C 3.2         2    Lcp1    12.8800
## 11991   2C 4.1         2    Lcp1    11.6400
## 11992   2C 5.1         2    Lcp1    11.8150
## 11993   2C 5.2         2    Lcp1    12.7050
## 11994   2C 6.1         2    Lcp1     6.7300
## 11995   2C 6.2         2    Lcp1     5.9900
## 11996   2C 7.1         2    Lcp1     5.7050
## 11997   2C 7.2         2    Lcp1    13.7700
## 11998   2C 8.1         2    Lcp1    11.1750
## 11999   2C 8.2         2    Lcp1    11.2550
## 12000   2C 9.1         2    Lcp1     9.7250
## 12001   2C 9.2         2    Lcp1    11.5950
## 12002  2C 10.1         2    Lcp1    10.6250
## 12003  2C 10.2         2    Lcp1    10.9900
## 12004   4C 1.1         4    Lcp1     8.8300
## 12005   4C 1.2         4    Lcp1    11.7950
## 12006   4C 1.3         4    Lcp1    13.2550
## 12007   4C 1.4         4    Lcp1    14.2350
## 12008   4C 2.1         4    Lcp1    12.3950
## 12009   4C 2.2         4    Lcp1     9.9750
## 12010   4C 2.3         4    Lcp1    12.4100
## 12011   4C 3.1         4    Lcp1    10.0400
## 12012   4C 3.2         4    Lcp1    11.0850
## 12013   4C 3.3         4    Lcp1    12.2150
## 12014   4C 3.4         4    Lcp1     8.6200
## 12015   4C 4.1         4    Lcp1    14.4500
## 12016   4C 4.2         4    Lcp1    10.9850
## 12017   4C 4.3         4    Lcp1    10.1700
## 12018   4C 4.4         4    Lcp1    13.0600
## 12019   4C 5.1         4    Lcp1    13.0350
## 12020   4C 5.2         4    Lcp1     9.8000
## 12021   4C 5.3         4    Lcp1    11.7000
## 12022   4C 5.4         4    Lcp1    11.4050
## 12023   4C 6.1         4    Lcp1     8.8400
## 12024   4C 6.2         4    Lcp1     9.4700
## 12025   4C 6.3         4    Lcp1    10.6300
## 12026   4C 6.4         4    Lcp1    13.3500
## 12027   8C 1.1         8    Lcp1    11.1000
## 12028   8C 1.2         8    Lcp1    12.2300
## 12029   8C 1.3         8    Lcp1     8.1750
## 12030   8C 1.4         8    Lcp1    11.4850
## 12031   8C 1.5         8    Lcp1     9.3900
## 12032   8C 2.1         8    Lcp1     8.2500
## 12033   8C 2.2         8    Lcp1    11.4600
## 12034   8C 2.3         8    Lcp1    13.1150
## 12035   8C 2.4         8    Lcp1    13.4350
## 12036   8C 2.5         8    Lcp1    13.9050
## 12037   8C 2.6         8    Lcp1    11.1750
## 12038   8C 2.7         8    Lcp1     9.1600
## 12039   8C 2.8         8    Lcp1    11.5350
## 12040   8C 3.1         8    Lcp1    11.8350
## 12041   8C 3.2         8    Lcp1    11.5300
## 12042   8C 3.3         8    Lcp1     9.6700
## 12043   8C 3.4         8    Lcp1    13.2950
## 12044   8C 3.5         8    Lcp1     9.6150
## 12045   8C 3.6         8    Lcp1    10.6350
## 12046   8C 3.7         8    Lcp1    14.5650
## 12047   8C 3.8         8    Lcp1    10.4900
## 12048   8C 4.2         8    Lcp1     8.0150
## 12049   8C 4.3         8    Lcp1     9.1200
## 12050   8C 4.4         8    Lcp1    12.0050
## 12051   8C 4.5         8    Lcp1    11.6450
## 12052   8C 4.6         8    Lcp1    12.1000
## 12053   8C 4.7         8    Lcp1    14.3000
## 12054   8C 5.1         8    Lcp1    10.7200
## 12055   8C 5.2         8    Lcp1    13.1300
## 12056   8C 5.3         8    Lcp1    12.3250
## 12057   8C 5.4         8    Lcp1    10.9550
## 12058   8C 5.5         8    Lcp1     7.8500
## 12059   8C 5.6         8    Lcp1    11.7950
## 12060   8C 5.7         8    Lcp1    14.3350
## 12061   8C 5.8         8    Lcp1    15.2575
## 12062   8C 6.1         8    Lcp1    13.8800
## 12063   8C 6.2         8    Lcp1    13.1450
## 12064   8C 6.3         8    Lcp1    12.6400
## 12065   8C 6.4         8    Lcp1     8.2500
## 12066   8C 6.5         8    Lcp1    11.4350
## 12067   8C 6.6         8    Lcp1    12.4900
## 12068   8C 6.7         8    Lcp1    13.5850
## 12069   8C 6.8         8    Lcp1    10.9800
## 12070  16C 1.1        16    Lcp1    12.3325
## 12071  16C 1.2        16    Lcp1     9.8050
## 12072  16C 1.3        16    Lcp1     6.2250
## 12073  16C 1.4        16    Lcp1     8.1650
## 12074  16C 1.5        16    Lcp1     6.0850
## 12075  16C 1.6        16    Lcp1     6.6300
## 12076  16C 1.7        16    Lcp1     5.6150
## 12077  16C 1.8        16    Lcp1     5.8850
## 12078  16C 1.9        16    Lcp1     9.3750
## 12079 16C 1.10        16    Lcp1    10.9350
## 12080 16C 1.11        16    Lcp1     7.8250
## 12081 16C 1.12        16    Lcp1     4.5400
## 12082 16C 1.13        16    Lcp1     7.4150
## 12083 16C 1.14        16    Lcp1     7.3400
## 12084 16C 1.15        16    Lcp1     7.8450
## 12085 16C 1.16        16    Lcp1     3.8750
## 12086  16C 2.1        16    Lcp1    12.9000
## 12087  16C 2.2        16    Lcp1     8.7250
## 12088  16C 2.3        16    Lcp1     9.6550
## 12089  16C 2.4        16    Lcp1     8.6850
## 12090  16C 2.5        16    Lcp1     7.5150
## 12091  16C 2.6        16    Lcp1     5.9500
## 12092  16C 2.7        16    Lcp1     6.9750
## 12093  16C 2.8        16    Lcp1     5.9650
## 12094  16C 2.9        16    Lcp1     4.8450
## 12095 16C 2.10        16    Lcp1     7.6800
## 12096 16C 2.11        16    Lcp1     9.7950
## 12097 16C 2.12        16    Lcp1     7.7500
## 12098 16C 2.13        16    Lcp1     9.8600
## 12099 16C 2.14        16    Lcp1     7.9450
## 12100 16C 2.15        16    Lcp1     8.5150
## 12101 16C 2.16        16    Lcp1     5.6300
## 12102  16C 3.1        16    Lcp1    11.1900
## 12103  16C 3.2        16    Lcp1     6.9050
## 12104  16C 3.3        16    Lcp1    10.5400
## 12105  16C 3.4        16    Lcp1    10.9850
## 12106  16C 3.5        16    Lcp1    10.4650
## 12107  16C 3.6        16    Lcp1     9.5850
## 12108  16C 3.7        16    Lcp1     9.9850
## 12109  16C 3.8        16    Lcp1    11.0150
## 12110  16C 3.9        16    Lcp1     8.2200
## 12111 16C 3.10        16    Lcp1     8.3900
## 12112 16C 3.11        16    Lcp1    11.7750
## 12113 16C 3.12        16    Lcp1     9.1050
## 12114 16C 3.13        16    Lcp1    11.2450
## 12115 16C 3.14        16    Lcp1     6.5750
## 12116 16C 3.15        16    Lcp1     8.9950
## 12117  16C 4.1        16    Lcp1     9.4600
## 12118  16C 4.2        16    Lcp1     9.3700
## 12119  16C 4.3        16    Lcp1     8.7950
## 12120  16C 4.4        16    Lcp1     6.2150
## 12121  16C 4.5        16    Lcp1     8.2700
## 12122  16C 4.6        16    Lcp1    10.3000
## 12123  16C 4.7        16    Lcp1     9.9050
## 12124  16C 4.8        16    Lcp1     9.6600
## 12125  16C 4.9        16    Lcp1    11.0700
## 12126 16C 4.10        16    Lcp1    10.5350
## 12127 16C 4.11        16    Lcp1    13.0500
## 12128 16C 4.12        16    Lcp1     7.6200
## 12129 16C 4.13        16    Lcp1     8.9950
## 12130 16C 4.14        16    Lcp1     8.6100
## 12131 16C 4.15        16    Lcp1     7.9700
## 12132 16C 4.16        16    Lcp1     8.7400
## 12133  16C 5.1        16    Lcp1    13.9500
## 12134  16C 5.2        16    Lcp1     8.8300
## 12135  16C 5.3        16    Lcp1    10.4700
## 12136  16C 5.4        16    Lcp1     6.4350
## 12137  16C 5.5        16    Lcp1     6.6850
## 12138  16C 5.6        16    Lcp1    12.4300
## 12139  16C 5.7        16    Lcp1     9.8300
## 12140  16C 5.8        16    Lcp1     9.2900
## 12141  16C 5.9        16    Lcp1     9.1150
## 12142 16C 5.10        16    Lcp1    13.4350
## 12143 16C 5.11        16    Lcp1     8.1850
## 12144 16C 5.12        16    Lcp1     9.4450
## 12145  32C 1.1        32    Lcp1     1.2000
## 12146  32C 1.2        32    Lcp1     7.5050
## 12147  32C 1.3        32    Lcp1     1.9350
## 12148  32C 1.4        32    Lcp1     0.8600
## 12149  32C 1.5        32    Lcp1     7.1500
## 12150  32C 1.6        32    Lcp1     5.6950
## 12151  32C 1.7        32    Lcp1     3.5850
## 12152  32C 1.8        32    Lcp1     6.4850
## 12153  32C 1.9        32    Lcp1     7.7050
## 12154 32C 1.10        32    Lcp1     5.5700
## 12155 32C 1.11        32    Lcp1    -2.0550
## 12156 32C 1.12        32    Lcp1     2.0200
## 12157 32C 1.13        32    Lcp1     6.4750
## 12158 32C 1.14        32    Lcp1     4.6650
## 12159 32C 1.15        32    Lcp1     5.6900
## 12160 32C 1.16        32    Lcp1     6.0200
## 12161 32C 1.17        32    Lcp1     8.9300
## 12162 32C 1.18        32    Lcp1     4.8100
## 12163 32C 1.19        32    Lcp1     6.3550
## 12164 32C 1.20        32    Lcp1     5.0150
## 12165 32C 1.21        32    Lcp1     5.3800
## 12166  32C 2.1        32    Lcp1     2.7150
## 12167  32C 2.2        32    Lcp1     5.8250
## 12168  32C 2.3        32    Lcp1     6.6775
## 12169  32C 2.4        32    Lcp1     6.7300
## 12170  32C 2.5        32    Lcp1     7.9350
## 12171  32C 2.6        32    Lcp1     3.9900
## 12172  32C 2.7        32    Lcp1     4.6100
## 12173  32C 2.8        32    Lcp1     4.6650
## 12174  32C 2.9        32    Lcp1     5.1800
## 12175 32C 2.10        32    Lcp1     4.8250
## 12176 32C 2.11        32    Lcp1     6.4100
## 12177 32C 2.12        32    Lcp1     3.2325
## 12178 32C 2.13        32    Lcp1    11.0050
## 12179 32C 2.14        32    Lcp1     8.7150
## 12180 32C 2.15        32    Lcp1     7.4150
## 12181 32C 2.16        32    Lcp1     5.9250
## 12182  32C 3.1        32    Lcp1     2.1500
## 12183  32C 3.2        32    Lcp1     5.0850
## 12184  32C 3.3        32    Lcp1     2.7950
## 12185  32C 3.4        32    Lcp1     5.7450
## 12186  32C 3.5        32    Lcp1     4.4750
## 12187  32C 3.6        32    Lcp1     6.8950
## 12188  32C 3.7        32    Lcp1     3.7400
## 12189  32C 3.8        32    Lcp1     4.2150
## 12190  32C 4.1        32    Lcp1     0.2500
## 12191  32C 4.2        32    Lcp1     2.4650
## 12192  32C 4.3        32    Lcp1     2.0250
## 12193  32C 4.4        32    Lcp1     8.7000
## 12194  32C 4.5        32    Lcp1    11.7150
## 12195  32C 4.6        32    Lcp1     6.6950
## 12196  32C 4.7        32    Lcp1     3.7350
## 12197  32C 4.8        32    Lcp1     0.5350
## 12198 32C 4.10        32    Lcp1     2.1900
## 12199 32C 4.11        32    Lcp1     2.6550
## 12200 32C 4.12        32    Lcp1     0.7850
## 12201 32C 4.13        32    Lcp1     0.1350
## 12202 32C 4.14        32    Lcp1     3.8000
## 12203 32C 4.15        32    Lcp1     5.2050
## 12204 32C 4.16        32    Lcp1     5.6300
## 12205 32C 4.17        32    Lcp1     4.9800
## 12206 32C 4.18        32    Lcp1     3.0350
## 12207 32C 4.19        32    Lcp1     1.7950
## 12208 32C 4.20        32    Lcp1     2.9800
## 12209 32C 4.21        32    Lcp1     7.3200
## 12210 32C 4.22        32    Lcp1     2.6450
## 12211 32C 4.23        32    Lcp1     4.0800
## 12212 32C 4.24        32    Lcp1     4.5550
## 12213  32C 5.1        32    Lcp1     5.8950
## 12214  32C 5.2        32    Lcp1     8.3850
## 12215  32C 5.3        32    Lcp1     8.9150
## 12216  32C 5.4        32    Lcp1     0.5850
## 12217  32C 5.5        32    Lcp1     7.3900
## 12218  32C 5.6        32    Lcp1     3.2900
## 12219  32C 5.7        32    Lcp1     4.1350
## 12220  32C 5.8        32    Lcp1     5.5850
## 12221  32C 5.9        32    Lcp1     4.2050
## 12222 32C 5.10        32    Lcp1     4.2550
## 12223 32C 5.11        32    Lcp1     4.3250
## 12224 32C 5.12        32    Lcp1     6.1300
## 12225 32C 5.13        32    Lcp1     2.7400
## 12226 32C 5.14        32    Lcp1     3.4550
## 12227 32C 5.15        32    Lcp1     2.3950
## 12228 32C 5.16        32    Lcp1     2.0000
## 12229 32C 5.17        32    Lcp1     5.9900
## 12230 32C 5.18        32    Lcp1     4.2850
## 12231 32C 5.19        32    Lcp1     6.8900
## 12232 32C 5.20        32    Lcp1     7.2100
## 12233 32C 5.21        32    Lcp1     4.3350
## 12234 32C 5.22        32    Lcp1     6.5100
## 12235 32C 5.23        32    Lcp1     1.8900
## 12236  32C 6.1        32    Lcp1     5.9650
## 12237  32C 6.2        32    Lcp1     0.6800
## 12238  32C 6.3        32    Lcp1     4.4300
## 12239  32C 6.4        32    Lcp1     7.9750
## 12240  32C 6.6        32    Lcp1     4.2650
## 12241  32C 6.7        32    Lcp1     5.4250
## 12242  32C 7.1        32    Lcp1     3.7000
## 12243  32C 7.2        32    Lcp1     9.7050
## 12244  32C 7.3        32    Lcp1     1.7100
## 12245  32C 7.4        32    Lcp1     4.2450
## 12246  32C 7.5        32    Lcp1     6.2550
## 12247  32C 7.6        32    Lcp1     9.1800
## 12248  32C 7.8        32    Lcp1     6.1650
## 12249  32C 8.1        32    Lcp1     5.7500
## 12250  32C 8.2        32    Lcp1     5.6400
## 12251  32C 8.4        32    Lcp1     9.7800
## 12252  32C 8.5        32    Lcp1     6.6550
## 12253  32C 8.6        32    Lcp1     3.6900
## 12254  64C 1.1        64    Lcp1     9.8450
## 12255  64C 1.2        64    Lcp1     1.3700
## 12256  64C 1.3        64    Lcp1    14.4500
## 12257  64C 1.4        64    Lcp1    13.2950
## 12258  64C 1.5        64    Lcp1    13.6050
## 12259  64C 1.6        64    Lcp1     6.9350
## 12260  64C 1.7        64    Lcp1    14.5650
## 12261  64C 1.8        64    Lcp1     0.8600
## 12262  64C 1.9        64    Lcp1     8.0150
## 12263 64C 1.10        64    Lcp1     3.2600
## 12264 64C 1.11        64    Lcp1     9.3650
## 12265 64C 1.12        64    Lcp1     5.5550
## 12266 64C 1.13        64    Lcp1    10.2200
## 12267 64C 1.14        64    Lcp1     4.8600
## 12268 64C 1.15        64    Lcp1     3.6900
## 12269 64C 1.16        64    Lcp1     3.3300
## 12270 64C 1.17        64    Lcp1     2.6850
## 12271 64C 1.18        64    Lcp1     1.5050
## 12272 64C 1.19        64    Lcp1     1.4900
## 12273 64C 1.20        64    Lcp1     2.8350
## 12274 64C 1.21        64    Lcp1    10.0150
## 12275 64C 1.22        64    Lcp1    10.1675
## 12276 64C 1.23        64    Lcp1     8.4300
## 12277 64C 1.24        64    Lcp1     3.7250
## 12278 64C 1.25        64    Lcp1     3.1700
## 12279 64C 1.26        64    Lcp1    11.8000
## 12280 64C 1.27        64    Lcp1     1.0250
## 12281 64C 1.28        64    Lcp1     2.3800
## 12282 64C 1.29        64    Lcp1     4.3550
## 12283 64C 1.30        64    Lcp1     6.3700
## 12284 64C 1.31        64    Lcp1     3.0225
## 12285 64C 1.32        64    Lcp1     4.6150
## 12286 64C 1.33        64    Lcp1     2.5250
## 12287 64C 1.34        64    Lcp1     5.4050
## 12288 64C 1.35        64    Lcp1    -0.6650
## 12289 64C 1.36        64    Lcp1     1.5000
## 12290 64C 1.37        64    Lcp1     1.6650
## 12291 64C 1.38        64    Lcp1     2.9650
## 12292 64C 1.39        64    Lcp1     4.5550
## 12293 64C 1.40        64    Lcp1     7.8250
## 12294 64C 1.41        64    Lcp1    13.3050
## 12295 64C 1.42        64    Lcp1     5.0200
## 12296 64C 1.43        64    Lcp1     8.3950
## 12297 64C 1.44        64    Lcp1     3.3700
## 12298 64C 1.45        64    Lcp1     2.7150
## 12299 64C 1.46        64    Lcp1    -0.4850
## 12300 64C 1.47        64    Lcp1     3.3100
## 12301 64C 1.48        64    Lcp1     3.3650
## 12302  64C 2.1        64    Lcp1     2.2750
## 12303  64C 2.2        64    Lcp1     2.6350
## 12304  64C 2.3        64    Lcp1     3.6850
## 12305  64C 2.4        64    Lcp1     2.5500
## 12306  64C 2.5        64    Lcp1     5.2550
## 12307  64C 2.6        64    Lcp1     2.0150
## 12308  64C 2.7        64    Lcp1     3.7550
## 12309  64C 2.8        64    Lcp1     7.5500
## 12310  64C 2.9        64    Lcp1     2.4650
## 12311 64C 2.10        64    Lcp1     2.5200
## 12312 64C 2.11        64    Lcp1     4.7900
## 12313 64C 2.12        64    Lcp1     3.6250
## 12314 64C 2.13        64    Lcp1     2.6950
## 12315 64C 2.14        64    Lcp1     0.0200
## 12316 64C 2.15        64    Lcp1     2.4700
## 12317 64C 2.16        64    Lcp1     8.6750
## 12318 64C 2.17        64    Lcp1    11.3500
## 12319 64C 2.18        64    Lcp1     2.0950
## 12320 64C 2.19        64    Lcp1     2.2550
## 12321 64C 2.20        64    Lcp1     4.3850
## 12322 64C 2.21        64    Lcp1     5.6950
## 12323 64C 2.22        64    Lcp1     1.7350
## 12324 64C 2.23        64    Lcp1     1.5900
## 12325 64C 2.24        64    Lcp1     1.9000
## 12326 64C 2.25        64    Lcp1     1.2350
## 12327  64C 3.1        64    Lcp1     4.2250
## 12328  64C 3.2        64    Lcp1     5.0650
## 12329  64C 3.3        64    Lcp1     3.2550
## 12330  64C 3.4        64    Lcp1     2.7750
## 12331  64C 3.5        64    Lcp1    11.6200
## 12332  64C 3.6        64    Lcp1     2.7600
## 12333  64C 3.7        64    Lcp1     2.6450
## 12334  64C 3.8        64    Lcp1     2.0250
## 12335  64C 4.1        64    Lcp1     9.0200
## 12336 64C 4.1b        64    Lcp1    11.1100
## 12337  64C 4.2        64    Lcp1     9.6750
## 12338  64C 4.3        64    Lcp1    11.3000
## 12339  64C 4.4        64    Lcp1    12.4400
## 12340  64C 4.5        64    Lcp1    12.7750
## 12341  64C 4.6        64    Lcp1    13.0500
## 12342  64C 4.7        64    Lcp1     3.7000
## 12343  64C 4.8        64    Lcp1     8.9150
## 12344  64C 4.9        64    Lcp1     3.4100
## 12345 64C 4.10        64    Lcp1     9.3500
## 12346 64C 4.11        64    Lcp1    12.2500
## 12347 64C 4.12        64    Lcp1     5.7200
## 12348 64C 4.13        64    Lcp1     3.4500
## 12349 64C 4.14        64    Lcp1     4.4900
## 12350 64C 4.15        64    Lcp1     3.8850
## 12351 64C 4.16        64    Lcp1     7.1750
## 12352 64C 4.17        64    Lcp1     4.3800
## 12353 64C 4.18        64    Lcp1     2.6600
## 12354 64C 4.19        64    Lcp1     4.7700
## 12355 64C 4.20        64    Lcp1     4.9950
## 12356 64C 4.21        64    Lcp1     4.9650
## 12357 64C 4.22        64    Lcp1     5.4350
## 12358 64C 4.23        64    Lcp1     4.8850
## 12359 64C 4.24        64    Lcp1     4.4800
## 12360 64C 4.25        64    Lcp1     3.3650
## 12361 64C 4.26        64    Lcp1     8.3950
## 12362 64C 4.27        64    Lcp1     3.1800
## 12363 64C 4.28        64    Lcp1    11.2800
## 12364 64C 4.29        64    Lcp1     3.8850
## 12365 64C 4.30        64    Lcp1    10.8950
## 12366 64C 4.31        64    Lcp1     5.4450
## 12367 64C 4.32        64    Lcp1    10.6650
## 12368 64C 4.33        64    Lcp1     2.8400
## 12369 64C 4.34        64    Lcp1    -1.0950
## 12370 64C 4.35        64    Lcp1     9.2600
## 12371 64C 4.36        64    Lcp1     2.2950
## 12372 64C 4.37        64    Lcp1     5.8650
## 12373 64C 4.38        64    Lcp1     3.9300
## 12374 64C 4.39        64    Lcp1     6.9600
## 12375  64C 5.1        64    Lcp1     5.3500
## 12376  64C 5.2        64    Lcp1    10.3800
## 12377  64C 5.3        64    Lcp1    12.3250
## 12378  64C 5.4        64    Lcp1     3.7150
## 12379  64C 5.5        64    Lcp1    10.8300
## 12380  64C 5.6        64    Lcp1     8.1050
## 12381  64C 5.7        64    Lcp1    12.3850
## 12382  64C 5.8        64    Lcp1    15.2575
## 12383  64C 5.9        64    Lcp1    13.8800
## 12384 64C 5.10        64    Lcp1    12.7750
## 12385 64C 5.11        64    Lcp1     5.0400
## 12386 64C 5.12        64    Lcp1     3.3400
## 12387 64C 5.13        64    Lcp1     3.2650
## 12388 64C 5.14        64    Lcp1     5.3300
## 12389 64C 5.15        64    Lcp1     9.7550
## 12390 64C 5.16        64    Lcp1    10.3200
## 12391  64C 6.1        64    Lcp1     9.6125
## 12392  64C 6.2        64    Lcp1    10.1650
## 12393  64C 6.3        64    Lcp1     8.8750
## 12394  64C 6.4        64    Lcp1     8.7950
## 12395  64C 6.5        64    Lcp1     7.4050
## 12396  64C 6.6        64    Lcp1     8.4000
## 12397  64C 6.7        64    Lcp1     8.6650
## 12398  64C 6.8        64    Lcp1     9.1450
## 12399  64C 7.1        64    Lcp1    14.3750
## 12400  64C 7.2        64    Lcp1    13.4050
## 12401  64C 7.3        64    Lcp1    10.0550
## 12402  64C 7.4        64    Lcp1    11.1000
## 12403  64C 7.5        64    Lcp1     7.4850
## 12404  64C 7.6        64    Lcp1     9.2500
## 12405  64C 7.7        64    Lcp1     8.5350
## 12406  64C 7.8        64    Lcp1     5.5350
## 12407  64C 7.9        64    Lcp1    12.9000
## 12408 64C 7.10        64    Lcp1     5.3050
## 12409 64C 7.11        64    Lcp1     3.7250
## 12410 64C 7.12        64    Lcp1     3.9050
## 12411 64C 7.13        64    Lcp1     3.9250
## 12412 64C 7.14        64    Lcp1     3.5400
## 12413   2C 1.1         2   Mbnl3     6.4950
## 12414   2C 1.2         2   Mbnl3     5.7250
## 12415   2C 2.1         2   Mbnl3     3.2100
## 12416   2C 2.2         2   Mbnl3     7.7150
## 12417   2C 3.1         2   Mbnl3     9.2600
## 12418   2C 3.2         2   Mbnl3     9.1800
## 12419   2C 4.1         2   Mbnl3     8.2700
## 12420   2C 5.1         2   Mbnl3     6.0650
## 12421   2C 5.2         2   Mbnl3     5.3500
## 12422   2C 6.1         2   Mbnl3     1.6500
## 12423   2C 6.2         2   Mbnl3     3.5750
## 12424   2C 7.1         2   Mbnl3     7.6650
## 12425   2C 7.2         2   Mbnl3     9.4600
## 12426   2C 8.1         2   Mbnl3     8.6150
## 12427   2C 8.2         2   Mbnl3     6.4500
## 12428   2C 9.1         2   Mbnl3     7.5750
## 12429   2C 9.2         2   Mbnl3     8.8300
## 12430  2C 10.1         2   Mbnl3     7.7350
## 12431  2C 10.2         2   Mbnl3     5.7350
## 12432   4C 1.1         4   Mbnl3     3.4950
## 12433   4C 1.2         4   Mbnl3     5.4550
## 12434   4C 1.3         4   Mbnl3     9.0050
## 12435   4C 1.4         4   Mbnl3     7.7450
## 12436   4C 2.1         4   Mbnl3     6.8750
## 12437   4C 2.2         4   Mbnl3    11.7100
## 12438   4C 2.3         4   Mbnl3     9.5050
## 12439   4C 3.1         4   Mbnl3     8.0350
## 12440   4C 3.2         4   Mbnl3     6.3150
## 12441   4C 3.3         4   Mbnl3     9.8500
## 12442   4C 3.4         4   Mbnl3     8.7550
## 12443   4C 4.1         4   Mbnl3     8.1200
## 12444   4C 4.2         4   Mbnl3     6.2100
## 12445   4C 4.3         4   Mbnl3     7.4400
## 12446   4C 4.4         4   Mbnl3    10.0200
## 12447   4C 5.1         4   Mbnl3    11.9800
## 12448   4C 5.2         4   Mbnl3     9.3350
## 12449   4C 5.3         4   Mbnl3     6.7650
## 12450   4C 5.4         4   Mbnl3     9.7850
## 12451   4C 6.1         4   Mbnl3     5.3550
## 12452   4C 6.2         4   Mbnl3     8.7300
## 12453   4C 6.3         4   Mbnl3     6.3350
## 12454   4C 6.4         4   Mbnl3     6.3850
## 12455   8C 1.1         8   Mbnl3     4.0600
## 12456   8C 1.2         8   Mbnl3     9.4500
## 12457   8C 1.3         8   Mbnl3     3.7850
## 12458   8C 1.4         8   Mbnl3     0.8950
## 12459   8C 1.5         8   Mbnl3     5.1800
## 12460   8C 2.1         8   Mbnl3     1.2800
## 12461   8C 2.2         8   Mbnl3    13.2150
## 12462   8C 2.3         8   Mbnl3    10.9950
## 12463   8C 2.4         8   Mbnl3    12.7650
## 12464   8C 2.5         8   Mbnl3     3.2700
## 12465   8C 2.6         8   Mbnl3     9.6650
## 12466   8C 2.7         8   Mbnl3     7.2850
## 12467   8C 2.8         8   Mbnl3     6.3700
## 12468   8C 3.1         8   Mbnl3     6.5000
## 12469   8C 3.2         8   Mbnl3    11.2450
## 12470   8C 3.3         8   Mbnl3    14.8150
## 12471   8C 3.4         8   Mbnl3     9.6600
## 12472   8C 3.5         8   Mbnl3     9.6100
## 12473   8C 3.6         8   Mbnl3    11.1900
## 12474   8C 3.7         8   Mbnl3    13.1900
## 12475   8C 3.8         8   Mbnl3     7.6950
## 12476   8C 4.2         8   Mbnl3     7.6850
## 12477   8C 4.3         8   Mbnl3     8.1750
## 12478   8C 4.4         8   Mbnl3    10.5250
## 12479   8C 4.5         8   Mbnl3     8.9050
## 12480   8C 4.6         8   Mbnl3     4.3350
## 12481   8C 4.7         8   Mbnl3     7.2100
## 12482   8C 5.1         8   Mbnl3    13.2550
## 12483   8C 5.2         8   Mbnl3     9.1900
## 12484   8C 5.3         8   Mbnl3     6.7000
## 12485   8C 5.4         8   Mbnl3    10.7750
## 12486   8C 5.5         8   Mbnl3     5.1600
## 12487   8C 5.6         8   Mbnl3     6.6500
## 12488   8C 5.7         8   Mbnl3    10.3000
## 12489   8C 5.8         8   Mbnl3    11.7050
## 12490   8C 6.1         8   Mbnl3    11.4600
## 12491   8C 6.2         8   Mbnl3     9.1700
## 12492   8C 6.3         8   Mbnl3     9.7400
## 12493   8C 6.4         8   Mbnl3     6.4150
## 12494   8C 6.5         8   Mbnl3     2.8750
## 12495   8C 6.6         8   Mbnl3     6.0000
## 12496   8C 6.7         8   Mbnl3     5.8700
## 12497   8C 6.8         8   Mbnl3     6.3450
## 12498  16C 1.1        16   Mbnl3    13.6125
## 12499  16C 1.2        16   Mbnl3     9.8800
## 12500  16C 1.3        16   Mbnl3     8.0000
## 12501  16C 1.4        16   Mbnl3     6.7650
## 12502  16C 1.5        16   Mbnl3     7.9650
## 12503  16C 1.6        16   Mbnl3     9.5550
## 12504  16C 1.7        16   Mbnl3     6.0800
## 12505  16C 1.8        16   Mbnl3     8.9300
## 12506  16C 1.9        16   Mbnl3     7.5250
## 12507 16C 1.10        16   Mbnl3     6.2000
## 12508 16C 1.11        16   Mbnl3    12.9800
## 12509 16C 1.12        16   Mbnl3    10.9650
## 12510 16C 1.13        16   Mbnl3     4.1250
## 12511 16C 1.14        16   Mbnl3     5.3550
## 12512 16C 1.15        16   Mbnl3     9.2650
## 12513 16C 1.16        16   Mbnl3    10.8400
## 12514  16C 2.1        16   Mbnl3     8.1900
## 12515  16C 2.2        16   Mbnl3    10.1100
## 12516  16C 2.3        16   Mbnl3     8.8700
## 12517  16C 2.4        16   Mbnl3    10.1200
## 12518  16C 2.5        16   Mbnl3     5.9850
## 12519  16C 2.6        16   Mbnl3     8.7100
## 12520  16C 2.7        16   Mbnl3     3.3050
## 12521  16C 2.8        16   Mbnl3     8.1250
## 12522  16C 2.9        16   Mbnl3     4.2100
## 12523 16C 2.10        16   Mbnl3     7.1350
## 12524 16C 2.11        16   Mbnl3     6.0200
## 12525 16C 2.12        16   Mbnl3     5.7400
## 12526 16C 2.13        16   Mbnl3     8.3600
## 12527 16C 2.14        16   Mbnl3     7.5950
## 12528 16C 2.15        16   Mbnl3     4.4000
## 12529 16C 2.16        16   Mbnl3     6.5400
## 12530  16C 3.1        16   Mbnl3    11.3150
## 12531  16C 3.2        16   Mbnl3    11.0750
## 12532  16C 3.3        16   Mbnl3    13.3600
## 12533  16C 3.4        16   Mbnl3    12.4250
## 12534  16C 3.5        16   Mbnl3     9.3800
## 12535  16C 3.6        16   Mbnl3    10.7250
## 12536  16C 3.7        16   Mbnl3    14.4400
## 12537  16C 3.8        16   Mbnl3    11.8250
## 12538  16C 3.9        16   Mbnl3    11.0450
## 12539 16C 3.10        16   Mbnl3     9.8950
## 12540 16C 3.11        16   Mbnl3    11.5850
## 12541 16C 3.12        16   Mbnl3    12.9550
## 12542 16C 3.13        16   Mbnl3    11.4450
## 12543 16C 3.14        16   Mbnl3    11.0450
## 12544 16C 3.15        16   Mbnl3    12.3700
## 12545  16C 4.1        16   Mbnl3    10.2750
## 12546  16C 4.2        16   Mbnl3     7.4750
## 12547  16C 4.3        16   Mbnl3     7.9450
## 12548  16C 4.4        16   Mbnl3     9.4200
## 12549  16C 4.5        16   Mbnl3     9.6250
## 12550  16C 4.6        16   Mbnl3     9.0200
## 12551  16C 4.7        16   Mbnl3    11.3900
## 12552  16C 4.8        16   Mbnl3     7.7300
## 12553  16C 4.9        16   Mbnl3    13.9100
## 12554 16C 4.10        16   Mbnl3    13.7500
## 12555 16C 4.11        16   Mbnl3    10.4950
## 12556 16C 4.12        16   Mbnl3    11.4450
## 12557 16C 4.13        16   Mbnl3    12.3950
## 12558 16C 4.14        16   Mbnl3     9.4150
## 12559 16C 4.15        16   Mbnl3    10.2900
## 12560 16C 4.16        16   Mbnl3     8.5450
## 12561  16C 5.1        16   Mbnl3    13.4350
## 12562  16C 5.2        16   Mbnl3     9.9600
## 12563  16C 5.3        16   Mbnl3    13.8600
## 12564  16C 5.4        16   Mbnl3    11.5150
## 12565  16C 5.5        16   Mbnl3    11.6750
## 12566  16C 5.6        16   Mbnl3    12.6600
## 12567  16C 5.7        16   Mbnl3    11.7300
## 12568  16C 5.8        16   Mbnl3    13.2150
## 12569  16C 5.9        16   Mbnl3    13.8250
## 12570 16C 5.10        16   Mbnl3    12.7650
## 12571 16C 5.11        16   Mbnl3    13.1700
## 12572 16C 5.12        16   Mbnl3    13.7550
## 12573  32C 1.1        32   Mbnl3     4.3650
## 12574  32C 1.2        32   Mbnl3    11.2700
## 12575  32C 1.3        32   Mbnl3     4.5700
## 12576  32C 1.4        32   Mbnl3     2.8350
## 12577  32C 1.5        32   Mbnl3    14.8150
## 12578  32C 1.6        32   Mbnl3    14.1800
## 12579  32C 1.7        32   Mbnl3     6.5600
## 12580  32C 1.8        32   Mbnl3    12.3500
## 12581  32C 1.9        32   Mbnl3    13.1900
## 12582 32C 1.10        32   Mbnl3    11.6950
## 12583 32C 1.11        32   Mbnl3     3.6050
## 12584 32C 1.12        32   Mbnl3     4.7450
## 12585 32C 1.13        32   Mbnl3    10.5250
## 12586 32C 1.14        32   Mbnl3     6.1650
## 12587 32C 1.15        32   Mbnl3    14.2150
## 12588 32C 1.16        32   Mbnl3    14.1500
## 12589 32C 1.17        32   Mbnl3    13.2550
## 12590 32C 1.18        32   Mbnl3    12.7900
## 12591 32C 1.19        32   Mbnl3    11.2700
## 12592 32C 1.20        32   Mbnl3    10.7750
## 12593 32C 1.21        32   Mbnl3    11.6800
## 12594  32C 2.1        32   Mbnl3     5.6700
## 12595  32C 2.2        32   Mbnl3    14.4400
## 12596  32C 2.3        32   Mbnl3    13.7850
## 12597  32C 2.4        32   Mbnl3    11.9100
## 12598  32C 2.5        32   Mbnl3    12.1700
## 12599  32C 2.6        32   Mbnl3    11.5700
## 12600  32C 2.7        32   Mbnl3     9.3650
## 12601  32C 2.8        32   Mbnl3     9.6150
## 12602  32C 2.9        32   Mbnl3     6.0700
## 12603 32C 2.10        32   Mbnl3     5.8200
## 12604 32C 2.11        32   Mbnl3    13.1150
## 12605 32C 2.12        32   Mbnl3    13.6125
## 12606 32C 2.13        32   Mbnl3    13.8100
## 12607 32C 2.14        32   Mbnl3     8.1800
## 12608 32C 2.15        32   Mbnl3    12.8450
## 12609 32C 2.16        32   Mbnl3    10.6250
## 12610  32C 3.1        32   Mbnl3     5.8150
## 12611  32C 3.2        32   Mbnl3     6.2600
## 12612  32C 3.3        32   Mbnl3     8.1400
## 12613  32C 3.4        32   Mbnl3     7.5950
## 12614  32C 3.5        32   Mbnl3     7.1100
## 12615  32C 3.6        32   Mbnl3    12.8500
## 12616  32C 3.7        32   Mbnl3    10.4250
## 12617  32C 3.8        32   Mbnl3     9.2550
## 12618  32C 4.1        32   Mbnl3     3.1850
## 12619  32C 4.2        32   Mbnl3     6.0550
## 12620  32C 4.3        32   Mbnl3     8.1000
## 12621  32C 4.4        32   Mbnl3    13.0100
## 12622  32C 4.5        32   Mbnl3    13.7200
## 12623  32C 4.6        32   Mbnl3    12.7400
## 12624  32C 4.7        32   Mbnl3     7.4700
## 12625  32C 4.8        32   Mbnl3     3.7650
## 12626 32C 4.10        32   Mbnl3     5.0100
## 12627 32C 4.11        32   Mbnl3     9.5050
## 12628 32C 4.12        32   Mbnl3     6.2350
## 12629 32C 4.13        32   Mbnl3     3.8700
## 12630 32C 4.14        32   Mbnl3    14.7350
## 12631 32C 4.15        32   Mbnl3    13.8200
## 12632 32C 4.16        32   Mbnl3    12.9700
## 12633 32C 4.17        32   Mbnl3    13.2300
## 12634 32C 4.18        32   Mbnl3    12.7150
## 12635 32C 4.19        32   Mbnl3     4.7100
## 12636 32C 4.20        32   Mbnl3     6.0300
## 12637 32C 4.21        32   Mbnl3    11.3150
## 12638 32C 4.22        32   Mbnl3    11.0750
## 12639 32C 4.23        32   Mbnl3     5.6800
## 12640 32C 4.24        32   Mbnl3    14.2750
## 12641  32C 5.1        32   Mbnl3     8.7600
## 12642  32C 5.2        32   Mbnl3     7.7050
## 12643  32C 5.3        32   Mbnl3    14.4400
## 12644  32C 5.4        32   Mbnl3    11.8250
## 12645  32C 5.5        32   Mbnl3     9.0450
## 12646  32C 5.6        32   Mbnl3     6.4050
## 12647  32C 5.7        32   Mbnl3    11.5850
## 12648  32C 5.8        32   Mbnl3    15.2850
## 12649  32C 5.9        32   Mbnl3     9.6550
## 12650 32C 5.10        32   Mbnl3    12.3750
## 12651 32C 5.11        32   Mbnl3    12.1400
## 12652 32C 5.12        32   Mbnl3    13.5150
## 12653 32C 5.13        32   Mbnl3    11.9550
## 12654 32C 5.14        32   Mbnl3    11.2550
## 12655 32C 5.15        32   Mbnl3    12.4100
## 12656 32C 5.16        32   Mbnl3     5.8750
## 12657 32C 5.17        32   Mbnl3     5.5100
## 12658 32C 5.18        32   Mbnl3    13.4100
## 12659 32C 5.19        32   Mbnl3    11.2400
## 12660 32C 5.20        32   Mbnl3     8.3000
## 12661 32C 5.21        32   Mbnl3    10.2600
## 12662 32C 5.22        32   Mbnl3    13.2950
## 12663 32C 5.23        32   Mbnl3     5.1150
## 12664  32C 6.1        32   Mbnl3    12.3950
## 12665  32C 6.2        32   Mbnl3     6.0100
## 12666  32C 6.3        32   Mbnl3     8.2950
## 12667  32C 6.4        32   Mbnl3    12.6150
## 12668  32C 6.6        32   Mbnl3     9.8150
## 12669  32C 6.7        32   Mbnl3     7.4700
## 12670  32C 7.1        32   Mbnl3     6.4150
## 12671  32C 7.2        32   Mbnl3     9.0050
## 12672  32C 7.3        32   Mbnl3     3.8700
## 12673  32C 7.4        32   Mbnl3     4.3800
## 12674  32C 7.5        32   Mbnl3    11.7300
## 12675  32C 7.6        32   Mbnl3    13.2150
## 12676  32C 7.8        32   Mbnl3     7.3350
## 12677  32C 8.1        32   Mbnl3     7.2900
## 12678  32C 8.2        32   Mbnl3     7.0150
## 12679  32C 8.4        32   Mbnl3     9.7550
## 12680  32C 8.5        32   Mbnl3    11.6550
## 12681  32C 8.6        32   Mbnl3     3.4600
## 12682  64C 1.1        64   Mbnl3     8.3100
## 12683  64C 1.2        64   Mbnl3     2.9550
## 12684  64C 1.3        64   Mbnl3    14.8150
## 12685  64C 1.4        64   Mbnl3    12.5900
## 12686  64C 1.5        64   Mbnl3    13.3900
## 12687  64C 1.6        64   Mbnl3    13.9800
## 12688  64C 1.7        64   Mbnl3    11.4900
## 12689  64C 1.8        64   Mbnl3     3.3250
## 12690  64C 1.9        64   Mbnl3    10.4750
## 12691 64C 1.10        64   Mbnl3     5.2650
## 12692 64C 1.11        64   Mbnl3     9.7450
## 12693 64C 1.12        64   Mbnl3     6.4750
## 12694 64C 1.13        64   Mbnl3    14.2150
## 12695 64C 1.14        64   Mbnl3     8.3100
## 12696 64C 1.15        64   Mbnl3     5.5650
## 12697 64C 1.16        64   Mbnl3     5.4400
## 12698 64C 1.17        64   Mbnl3     4.9600
## 12699 64C 1.18        64   Mbnl3     3.7750
## 12700 64C 1.19        64   Mbnl3     5.1000
## 12701 64C 1.20        64   Mbnl3     4.3200
## 12702 64C 1.21        64   Mbnl3    10.2700
## 12703 64C 1.22        64   Mbnl3    13.7850
## 12704 64C 1.23        64   Mbnl3    13.4000
## 12705 64C 1.24        64   Mbnl3     6.1900
## 12706 64C 1.25        64   Mbnl3     4.4000
## 12707 64C 1.26        64   Mbnl3    10.9850
## 12708 64C 1.27        64   Mbnl3     2.2050
## 12709 64C 1.28        64   Mbnl3     3.5700
## 12710 64C 1.29        64   Mbnl3     6.9000
## 12711 64C 1.30        64   Mbnl3     9.1750
## 12712 64C 1.31        64   Mbnl3     5.0025
## 12713 64C 1.32        64   Mbnl3     5.2500
## 12714 64C 1.33        64   Mbnl3     4.0900
## 12715 64C 1.34        64   Mbnl3     5.8050
## 12716 64C 1.35        64   Mbnl3     0.5850
## 12717 64C 1.36        64   Mbnl3     2.9650
## 12718 64C 1.37        64   Mbnl3     3.1200
## 12719 64C 1.38        64   Mbnl3     4.5900
## 12720 64C 1.39        64   Mbnl3     7.1350
## 12721 64C 1.40        64   Mbnl3    12.3100
## 12722 64C 1.41        64   Mbnl3    12.9800
## 12723 64C 1.42        64   Mbnl3     9.8650
## 12724 64C 1.43        64   Mbnl3     9.2550
## 12725 64C 1.44        64   Mbnl3     5.0550
## 12726 64C 1.45        64   Mbnl3     6.5050
## 12727 64C 1.46        64   Mbnl3     2.2200
## 12728 64C 1.47        64   Mbnl3     4.3300
## 12729 64C 1.48        64   Mbnl3     4.3700
## 12730  64C 2.1        64   Mbnl3     4.4300
## 12731  64C 2.2        64   Mbnl3     6.6700
## 12732  64C 2.3        64   Mbnl3     5.8050
## 12733  64C 2.4        64   Mbnl3     5.0800
## 12734  64C 2.5        64   Mbnl3     7.1150
## 12735  64C 2.6        64   Mbnl3     4.7850
## 12736  64C 2.7        64   Mbnl3     7.9600
## 12737  64C 2.8        64   Mbnl3    14.7350
## 12738  64C 2.9        64   Mbnl3     4.9700
## 12739 64C 2.10        64   Mbnl3     3.7100
## 12740 64C 2.11        64   Mbnl3     6.9800
## 12741 64C 2.12        64   Mbnl3     5.4150
## 12742 64C 2.13        64   Mbnl3     3.7500
## 12743 64C 2.14        64   Mbnl3     3.2900
## 12744 64C 2.15        64   Mbnl3     3.9650
## 12745 64C 2.16        64   Mbnl3     4.7250
## 12746 64C 2.17        64   Mbnl3    13.3600
## 12747 64C 2.18        64   Mbnl3     4.4750
## 12748 64C 2.19        64   Mbnl3     4.9100
## 12749 64C 2.20        64   Mbnl3     5.4950
## 12750 64C 2.21        64   Mbnl3     6.5300
## 12751 64C 2.22        64   Mbnl3     5.0850
## 12752 64C 2.23        64   Mbnl3     4.7850
## 12753 64C 2.24        64   Mbnl3     1.3950
## 12754 64C 2.25        64   Mbnl3    11.5850
## 12755  64C 3.1        64   Mbnl3    10.7950
## 12756  64C 3.2        64   Mbnl3     6.8450
## 12757  64C 3.3        64   Mbnl3     5.1650
## 12758  64C 3.4        64   Mbnl3     7.8400
## 12759  64C 3.5        64   Mbnl3    13.5150
## 12760  64C 3.6        64   Mbnl3     5.1350
## 12761  64C 3.7        64   Mbnl3     5.2150
## 12762  64C 3.8        64   Mbnl3     4.9100
## 12763  64C 4.1        64   Mbnl3    12.4750
## 12764 64C 4.1b        64   Mbnl3    13.4600
## 12765  64C 4.2        64   Mbnl3    13.4100
## 12766  64C 4.3        64   Mbnl3    11.5100
## 12767  64C 4.4        64   Mbnl3    13.9100
## 12768  64C 4.5        64   Mbnl3    13.7500
## 12769  64C 4.6        64   Mbnl3    13.1250
## 12770  64C 4.7        64   Mbnl3     5.1050
## 12771  64C 4.8        64   Mbnl3    12.3950
## 12772  64C 4.9        64   Mbnl3     4.0350
## 12773 64C 4.10        64   Mbnl3    14.2400
## 12774 64C 4.11        64   Mbnl3    12.6150
## 12775 64C 4.12        64   Mbnl3    13.4350
## 12776 64C 4.13        64   Mbnl3     1.7500
## 12777 64C 4.14        64   Mbnl3     6.8300
## 12778 64C 4.15        64   Mbnl3     4.4750
## 12779 64C 4.16        64   Mbnl3     4.3450
## 12780 64C 4.17        64   Mbnl3     8.0400
## 12781 64C 4.18        64   Mbnl3     4.0700
## 12782 64C 4.19        64   Mbnl3     5.7250
## 12783 64C 4.20        64   Mbnl3     6.5750
## 12784 64C 4.21        64   Mbnl3     5.7350
## 12785 64C 4.22        64   Mbnl3     5.2300
## 12786 64C 4.23        64   Mbnl3     6.5250
## 12787 64C 4.24        64   Mbnl3     5.6850
## 12788 64C 4.25        64   Mbnl3    11.2700
## 12789 64C 4.26        64   Mbnl3    11.3700
## 12790 64C 4.27        64   Mbnl3    10.0350
## 12791 64C 4.28        64   Mbnl3    13.6750
## 12792 64C 4.29        64   Mbnl3     5.4200
## 12793 64C 4.30        64   Mbnl3    10.6400
## 12794 64C 4.31        64   Mbnl3     5.4800
## 12795 64C 4.32        64   Mbnl3    13.1900
## 12796 64C 4.33        64   Mbnl3     4.1050
## 12797 64C 4.34        64   Mbnl3     3.5350
## 12798 64C 4.35        64   Mbnl3    12.1450
## 12799 64C 4.36        64   Mbnl3     2.9850
## 12800 64C 4.37        64   Mbnl3     4.1950
## 12801 64C 4.38        64   Mbnl3     5.7550
## 12802 64C 4.39        64   Mbnl3     8.5800
## 12803  64C 5.1        64   Mbnl3     8.0150
## 12804  64C 5.2        64   Mbnl3     8.0900
## 12805  64C 5.3        64   Mbnl3     7.8400
## 12806  64C 5.4        64   Mbnl3     5.6350
## 12807  64C 5.5        64   Mbnl3     8.5600
## 12808  64C 5.6        64   Mbnl3     9.6900
## 12809  64C 5.7        64   Mbnl3    14.4400
## 12810  64C 5.8        64   Mbnl3    11.4750
## 12811  64C 5.9        64   Mbnl3    13.4000
## 12812 64C 5.10        64   Mbnl3    11.7300
## 12813 64C 5.11        64   Mbnl3     3.6500
## 12814 64C 5.12        64   Mbnl3     3.6050
## 12815 64C 5.13        64   Mbnl3     1.9650
## 12816 64C 5.14        64   Mbnl3     5.5300
## 12817 64C 5.15        64   Mbnl3     7.5700
## 12818 64C 5.16        64   Mbnl3     9.4250
## 12819  64C 6.1        64   Mbnl3    12.0525
## 12820  64C 6.2        64   Mbnl3    13.8100
## 12821  64C 6.3        64   Mbnl3    11.9800
## 12822  64C 6.4        64   Mbnl3    12.8450
## 12823  64C 6.5        64   Mbnl3    10.6250
## 12824  64C 6.6        64   Mbnl3    12.3050
## 12825  64C 6.7        64   Mbnl3    10.4200
## 12826  64C 6.8        64   Mbnl3    13.2600
## 12827  64C 7.1        64   Mbnl3    14.1050
## 12828  64C 7.2        64   Mbnl3     9.4700
## 12829  64C 7.3        64   Mbnl3    12.9800
## 12830  64C 7.4        64   Mbnl3    13.5250
## 12831  64C 7.5        64   Mbnl3     9.2550
## 12832  64C 7.6        64   Mbnl3    10.2250
## 12833  64C 7.7        64   Mbnl3    12.6350
## 12834  64C 7.8        64   Mbnl3    10.8400
## 12835  64C 7.9        64   Mbnl3    11.2100
## 12836 64C 7.10        64   Mbnl3     9.0500
## 12837 64C 7.11        64   Mbnl3     4.6900
## 12838 64C 7.12        64   Mbnl3     5.4200
## 12839 64C 7.13        64   Mbnl3     5.9650
## 12840 64C 7.14        64   Mbnl3     6.0700
## 12841   2C 1.1         2     Msc     9.5850
## 12842   2C 1.2         2     Msc    10.6800
## 12843   2C 2.1         2     Msc    10.3450
## 12844   2C 2.2         2     Msc    13.4050
## 12845   2C 3.1         2     Msc    14.0950
## 12846   2C 3.2         2     Msc    12.8700
## 12847   2C 4.1         2     Msc    15.0900
## 12848   2C 5.1         2     Msc    14.0750
## 12849   2C 5.2         2     Msc     9.1850
## 12850   2C 6.1         2     Msc    10.5950
## 12851   2C 6.2         2     Msc    11.2950
## 12852   2C 7.1         2     Msc    10.8700
## 12853   2C 7.2         2     Msc    12.5350
## 12854   2C 8.1         2     Msc    13.9250
## 12855   2C 8.2         2     Msc    12.1200
## 12856   2C 9.1         2     Msc    13.1350
## 12857   2C 9.2         2     Msc    13.9900
## 12858  2C 10.1         2     Msc    11.9200
## 12859  2C 10.2         2     Msc    11.9500
## 12860   4C 1.1         4     Msc    12.4350
## 12861   4C 1.2         4     Msc    10.6400
## 12862   4C 1.3         4     Msc    14.3400
## 12863   4C 1.4         4     Msc    13.3150
## 12864   4C 2.1         4     Msc    12.6950
## 12865   4C 2.2         4     Msc    14.4300
## 12866   4C 2.3         4     Msc    13.4450
## 12867   4C 3.1         4     Msc    11.9400
## 12868   4C 3.2         4     Msc    10.8900
## 12869   4C 3.3         4     Msc    11.8150
## 12870   4C 3.4         4     Msc    12.2600
## 12871   4C 4.1         4     Msc    13.5550
## 12872   4C 4.2         4     Msc    13.5000
## 12873   4C 4.3         4     Msc    10.1800
## 12874   4C 4.4         4     Msc    10.8500
## 12875   4C 5.1         4     Msc    13.0200
## 12876   4C 5.2         4     Msc    12.1900
## 12877   4C 5.3         4     Msc    11.5150
## 12878   4C 5.4         4     Msc    12.3600
## 12879   4C 6.1         4     Msc    11.6750
## 12880   4C 6.2         4     Msc    15.0050
## 12881   4C 6.3         4     Msc    13.3050
## 12882   4C 6.4         4     Msc    13.6650
## 12883   8C 1.1         8     Msc    15.9200
## 12884   8C 1.2         8     Msc    12.7750
## 12885   8C 1.3         8     Msc    11.7950
## 12886   8C 1.4         8     Msc     9.5250
## 12887   8C 1.5         8     Msc    13.1700
## 12888   8C 2.1         8     Msc    11.3100
## 12889   8C 2.2         8     Msc    10.5150
## 12890   8C 2.3         8     Msc    14.0350
## 12891   8C 2.4         8     Msc    11.7500
## 12892   8C 2.5         8     Msc    13.7500
## 12893   8C 2.6         8     Msc    10.9450
## 12894   8C 2.7         8     Msc    11.7000
## 12895   8C 2.8         8     Msc    11.3000
## 12896   8C 3.1         8     Msc     9.2350
## 12897   8C 3.2         8     Msc    11.6700
## 12898   8C 3.3         8     Msc    14.3350
## 12899   8C 3.4         8     Msc    10.4550
## 12900   8C 3.5         8     Msc    12.5350
## 12901   8C 3.6         8     Msc    13.8350
## 12902   8C 3.7         8     Msc    12.9500
## 12903   8C 3.8         8     Msc     8.2150
## 12904   8C 4.2         8     Msc    11.5450
## 12905   8C 4.3         8     Msc    12.3000
## 12906   8C 4.4         8     Msc    10.8750
## 12907   8C 4.5         8     Msc    10.8450
## 12908   8C 4.6         8     Msc    10.2200
## 12909   8C 4.7         8     Msc     9.5300
## 12910   8C 5.1         8     Msc    13.0850
## 12911   8C 5.2         8     Msc     7.1850
## 12912   8C 5.3         8     Msc     8.5400
## 12913   8C 5.4         8     Msc    11.5800
## 12914   8C 5.5         8     Msc    11.6000
## 12915   8C 5.6         8     Msc     8.8600
## 12916   8C 5.7         8     Msc     8.4900
## 12917   8C 5.8         8     Msc    12.2975
## 12918   8C 6.1         8     Msc    12.7250
## 12919   8C 6.2         8     Msc    12.0700
## 12920   8C 6.3         8     Msc    12.1200
## 12921   8C 6.4         8     Msc    11.2750
## 12922   8C 6.5         8     Msc     9.0650
## 12923   8C 6.6         8     Msc    12.8250
## 12924   8C 6.7         8     Msc    13.2950
## 12925   8C 6.8         8     Msc    13.6250
## 12926  16C 1.1        16     Msc    12.0575
## 12927  16C 1.2        16     Msc     9.3650
## 12928  16C 1.3        16     Msc    12.0500
## 12929  16C 1.4        16     Msc     7.0000
## 12930  16C 1.5        16     Msc     5.1150
## 12931  16C 1.6        16     Msc     6.1600
## 12932  16C 1.7        16     Msc     5.5550
## 12933  16C 1.8        16     Msc     6.4950
## 12934  16C 1.9        16     Msc    11.2300
## 12935 16C 1.10        16     Msc     8.9925
## 12936 16C 1.11        16     Msc     7.6750
## 12937 16C 1.12        16     Msc     5.4650
## 12938 16C 1.13        16     Msc     5.7100
## 12939 16C 1.14        16     Msc     4.6950
## 12940 16C 1.15        16     Msc    12.3650
## 12941 16C 1.16        16     Msc    11.6550
## 12942  16C 2.1        16     Msc    12.1150
## 12943  16C 2.2        16     Msc    10.7350
## 12944  16C 2.3        16     Msc    12.5000
## 12945  16C 2.4        16     Msc     8.6850
## 12946  16C 2.5        16     Msc     9.2650
## 12947  16C 2.6        16     Msc     7.5000
## 12948  16C 2.7        16     Msc     5.7450
## 12949  16C 2.8        16     Msc     5.6700
## 12950  16C 2.9        16     Msc     4.9950
## 12951 16C 2.10        16     Msc    13.4050
## 12952 16C 2.11        16     Msc    14.0950
## 12953 16C 2.12        16     Msc    11.3400
## 12954 16C 2.13        16     Msc    13.9000
## 12955 16C 2.14        16     Msc    11.1650
## 12956 16C 2.15        16     Msc     4.3350
## 12957 16C 2.16        16     Msc     5.8850
## 12958  16C 3.1        16     Msc     5.0950
## 12959  16C 3.2        16     Msc     5.9500
## 12960  16C 3.3        16     Msc     8.6050
## 12961  16C 3.4        16     Msc    10.2950
## 12962  16C 3.5        16     Msc     7.5200
## 12963  16C 3.6        16     Msc     8.0050
## 12964  16C 3.7        16     Msc     9.5100
## 12965  16C 3.8        16     Msc    11.9200
## 12966  16C 3.9        16     Msc     6.8200
## 12967 16C 3.10        16     Msc     7.0450
## 12968 16C 3.11        16     Msc     5.8500
## 12969 16C 3.12        16     Msc    10.2000
## 12970 16C 3.13        16     Msc     7.4450
## 12971 16C 3.14        16     Msc     7.3050
## 12972 16C 3.15        16     Msc    10.4100
## 12973  16C 4.1        16     Msc     8.1950
## 12974  16C 4.2        16     Msc     5.6100
## 12975  16C 4.3        16     Msc     5.5600
## 12976  16C 4.4        16     Msc     6.0650
## 12977  16C 4.5        16     Msc     6.5300
## 12978  16C 4.6        16     Msc     9.7650
## 12979  16C 4.7        16     Msc    13.5000
## 12980  16C 4.8        16     Msc     7.1700
## 12981  16C 4.9        16     Msc     9.2100
## 12982 16C 4.10        16     Msc     8.1800
## 12983 16C 4.11        16     Msc     6.7500
## 12984 16C 4.12        16     Msc     5.4850
## 12985 16C 4.13        16     Msc     6.3400
## 12986 16C 4.14        16     Msc     7.2450
## 12987 16C 4.15        16     Msc    10.1950
## 12988 16C 4.16        16     Msc    13.3050
## 12989  16C 5.1        16     Msc     9.2450
## 12990  16C 5.2        16     Msc    10.5800
## 12991  16C 5.3        16     Msc     7.3850
## 12992  16C 5.4        16     Msc    11.6350
## 12993  16C 5.5        16     Msc     4.0350
## 12994  16C 5.6        16     Msc    10.9600
## 12995  16C 5.7        16     Msc     9.7800
## 12996  16C 5.8        16     Msc     7.9650
## 12997  16C 5.9        16     Msc     8.7850
## 12998 16C 5.10        16     Msc    11.7500
## 12999 16C 5.11        16     Msc     9.4500
## 13000 16C 5.12        16     Msc    11.5750
## 13001  32C 1.1        32     Msc    11.7000
## 13002  32C 1.2        32     Msc     7.6700
## 13003  32C 1.3        32     Msc     9.6950
## 13004  32C 1.4        32     Msc     4.5100
## 13005  32C 1.5        32     Msc     9.0850
## 13006  32C 1.6        32     Msc     9.3950
## 13007  32C 1.7        32     Msc     7.1450
## 13008  32C 1.8        32     Msc    13.8350
## 13009  32C 1.9        32     Msc    10.1200
## 13010 32C 1.10        32     Msc     5.7550
## 13011 32C 1.11        32     Msc    11.5250
## 13012 32C 1.12        32     Msc     9.5400
## 13013 32C 1.13        32     Msc    12.4050
## 13014 32C 1.14        32     Msc     8.6650
## 13015 32C 1.15        32     Msc     7.7300
## 13016 32C 1.16        32     Msc     7.3800
## 13017 32C 1.17        32     Msc     7.3050
## 13018 32C 1.18        32     Msc     8.8650
## 13019 32C 1.19        32     Msc     6.5700
## 13020 32C 1.20        32     Msc     6.4100
## 13021 32C 1.21        32     Msc     6.6000
## 13022  32C 2.1        32     Msc     6.8000
## 13023  32C 2.2        32     Msc     8.7600
## 13024  32C 2.3        32     Msc     9.1375
## 13025  32C 2.4        32     Msc     6.1750
## 13026  32C 2.5        32     Msc     6.5900
## 13027  32C 2.6        32     Msc     7.9800
## 13028  32C 2.7        32     Msc     8.3050
## 13029  32C 2.8        32     Msc     9.0650
## 13030  32C 2.9        32     Msc     8.6150
## 13031 32C 2.10        32     Msc     7.0050
## 13032 32C 2.11        32     Msc     9.2550
## 13033 32C 2.12        32     Msc    12.0575
## 13034 32C 2.13        32     Msc    10.1650
## 13035 32C 2.14        32     Msc    12.2000
## 13036 32C 2.15        32     Msc     9.0400
## 13037 32C 2.16        32     Msc     6.9550
## 13038  32C 3.1        32     Msc     6.8200
## 13039  32C 3.2        32     Msc     4.9350
## 13040  32C 3.3        32     Msc     7.9450
## 13041  32C 3.4        32     Msc     9.0800
## 13042  32C 3.5        32     Msc    12.5225
## 13043  32C 3.6        32     Msc    13.5650
## 13044  32C 3.7        32     Msc     5.8250
## 13045  32C 3.8        32     Msc     8.4300
## 13046  32C 4.1        32     Msc     4.8850
## 13047  32C 4.2        32     Msc     8.4650
## 13048  32C 4.3        32     Msc    11.6550
## 13049  32C 4.4        32     Msc    12.8950
## 13050  32C 4.5        32     Msc     8.3250
## 13051  32C 4.6        32     Msc     7.0800
## 13052  32C 4.7        32     Msc    14.3950
## 13053  32C 4.8        32     Msc     4.0650
## 13054 32C 4.10        32     Msc     4.5800
## 13055 32C 4.11        32     Msc     0.7950
## 13056 32C 4.12        32     Msc     7.2000
## 13057 32C 4.13        32     Msc     5.0050
## 13058 32C 4.14        32     Msc    13.4050
## 13059 32C 4.15        32     Msc     6.8950
## 13060 32C 4.16        32     Msc     8.1300
## 13061 32C 4.17        32     Msc    10.4700
## 13062 32C 4.18        32     Msc     7.8350
## 13063 32C 4.19        32     Msc     3.6950
## 13064 32C 4.20        32     Msc    10.5950
## 13065 32C 4.21        32     Msc     7.9450
## 13066 32C 4.22        32     Msc    10.8700
## 13067 32C 4.23        32     Msc    12.5350
## 13068 32C 4.24        32     Msc     8.2250
## 13069  32C 5.1        32     Msc    12.1200
## 13070  32C 5.2        32     Msc    11.3050
## 13071  32C 5.3        32     Msc    13.9900
## 13072  32C 5.4        32     Msc     5.8900
## 13073  32C 5.5        32     Msc    11.9500
## 13074  32C 5.6        32     Msc    12.4350
## 13075  32C 5.7        32     Msc     6.5100
## 13076  32C 5.8        32     Msc     8.4800
## 13077  32C 5.9        32     Msc     9.1550
## 13078 32C 5.10        32     Msc     6.4750
## 13079 32C 5.11        32     Msc     7.3700
## 13080 32C 5.12        32     Msc     8.2950
## 13081 32C 5.13        32     Msc     4.3200
## 13082 32C 5.14        32     Msc     4.4800
## 13083 32C 5.15        32     Msc     8.1750
## 13084 32C 5.16        32     Msc    11.2900
## 13085 32C 5.17        32     Msc    13.5550
## 13086 32C 5.18        32     Msc    13.5000
## 13087 32C 5.19        32     Msc    13.2900
## 13088 32C 5.20        32     Msc    14.0200
## 13089 32C 5.21        32     Msc    13.0200
## 13090 32C 5.22        32     Msc     6.4100
## 13091 32C 5.23        32     Msc    11.5150
## 13092  32C 6.1        32     Msc     6.4250
## 13093  32C 6.2        32     Msc     4.0600
## 13094  32C 6.3        32     Msc     9.8700
## 13095  32C 6.4        32     Msc    13.3050
## 13096  32C 6.6        32     Msc     6.5450
## 13097  32C 6.7        32     Msc    15.9200
## 13098  32C 7.1        32     Msc     8.5900
## 13099  32C 7.2        32     Msc     6.3550
## 13100  32C 7.3        32     Msc     4.8100
## 13101  32C 7.4        32     Msc    10.7950
## 13102  32C 7.5        32     Msc    11.3100
## 13103  32C 7.6        32     Msc    13.8250
## 13104  32C 7.8        32     Msc     9.0300
## 13105  32C 8.1        32     Msc    11.7500
## 13106  32C 8.2        32     Msc    13.7500
## 13107  32C 8.4        32     Msc    11.0750
## 13108  32C 8.5        32     Msc     8.8250
## 13109  32C 8.6        32     Msc     6.7050
## 13110  64C 1.1        64     Msc    12.3250
## 13111  64C 1.2        64     Msc     7.9700
## 13112  64C 1.3        64     Msc     9.1650
## 13113  64C 1.4        64     Msc    13.7550
## 13114  64C 1.5        64     Msc    12.5350
## 13115  64C 1.6        64     Msc     8.0550
## 13116  64C 1.7        64     Msc    12.9500
## 13117  64C 1.8        64     Msc     7.1150
## 13118  64C 1.9        64     Msc    11.5450
## 13119 64C 1.10        64     Msc    13.4900
## 13120 64C 1.11        64     Msc    12.4050
## 13121 64C 1.12        64     Msc    14.1050
## 13122 64C 1.13        64     Msc     9.5900
## 13123 64C 1.14        64     Msc     8.4800
## 13124 64C 1.15        64     Msc     7.7250
## 13125 64C 1.16        64     Msc    12.2750
## 13126 64C 1.17        64     Msc    11.7900
## 13127 64C 1.18        64     Msc     7.4300
## 13128 64C 1.19        64     Msc     7.6900
## 13129 64C 1.20        64     Msc     9.5100
## 13130 64C 1.21        64     Msc    13.2800
## 13131 64C 1.22        64     Msc    12.2475
## 13132 64C 1.23        64     Msc    12.7250
## 13133 64C 1.24        64     Msc    12.0700
## 13134 64C 1.25        64     Msc     9.2700
## 13135 64C 1.26        64     Msc    11.2750
## 13136 64C 1.27        64     Msc     6.3050
## 13137 64C 1.28        64     Msc     9.3350
## 13138 64C 1.29        64     Msc    11.2050
## 13139 64C 1.30        64     Msc    13.6250
## 13140 64C 1.31        64     Msc    12.0575
## 13141 64C 1.32        64     Msc     8.4650
## 13142 64C 1.33        64     Msc     7.9400
## 13143 64C 1.34        64     Msc     9.4900
## 13144 64C 1.35        64     Msc     5.5750
## 13145 64C 1.36        64     Msc    12.1400
## 13146 64C 1.37        64     Msc    10.7950
## 13147 64C 1.38        64     Msc     9.0150
## 13148 64C 1.39        64     Msc    10.8200
## 13149 64C 1.40        64     Msc    12.7325
## 13150 64C 1.41        64     Msc    13.5650
## 13151 64C 1.42        64     Msc    11.6150
## 13152 64C 1.43        64     Msc    12.4200
## 13153 64C 1.44        64     Msc     9.2850
## 13154 64C 1.45        64     Msc    12.3650
## 13155 64C 1.46        64     Msc    11.6550
## 13156 64C 1.47        64     Msc    12.8950
## 13157 64C 1.48        64     Msc    13.8650
## 13158  64C 2.1        64     Msc     7.8100
## 13159  64C 2.2        64     Msc     8.9250
## 13160  64C 2.3        64     Msc    13.1550
## 13161  64C 2.4        64     Msc     7.0600
## 13162  64C 2.5        64     Msc     7.5650
## 13163  64C 2.6        64     Msc     7.3000
## 13164  64C 2.7        64     Msc    10.3450
## 13165  64C 2.8        64     Msc    13.4050
## 13166  64C 2.9        64     Msc     7.8550
## 13167 64C 2.10        64     Msc     8.3900
## 13168 64C 2.11        64     Msc     9.7700
## 13169 64C 2.12        64     Msc     8.9250
## 13170 64C 2.13        64     Msc     5.1650
## 13171 64C 2.14        64     Msc     4.1850
## 13172 64C 2.15        64     Msc     6.3850
## 13173 64C 2.16        64     Msc    10.8700
## 13174 64C 2.17        64     Msc    12.5350
## 13175 64C 2.18        64     Msc    10.4450
## 13176 64C 2.19        64     Msc    12.1200
## 13177 64C 2.20        64     Msc    13.1350
## 13178 64C 2.21        64     Msc    13.9900
## 13179 64C 2.22        64     Msc     9.1600
## 13180 64C 2.23        64     Msc     7.3600
## 13181 64C 2.24        64     Msc     7.8350
## 13182 64C 2.25        64     Msc     3.7800
## 13183  64C 3.1        64     Msc    14.3400
## 13184  64C 3.2        64     Msc     9.3450
## 13185  64C 3.3        64     Msc     8.0150
## 13186  64C 3.4        64     Msc    10.4900
## 13187  64C 3.5        64     Msc    13.4450
## 13188  64C 3.6        64     Msc     7.0800
## 13189  64C 3.7        64     Msc     8.1100
## 13190  64C 3.8        64     Msc     7.5450
## 13191  64C 4.1        64     Msc    12.2600
## 13192 64C 4.1b        64     Msc     7.3150
## 13193  64C 4.2        64     Msc    13.5000
## 13194  64C 4.3        64     Msc     6.4300
## 13195  64C 4.4        64     Msc     8.3800
## 13196  64C 4.5        64     Msc    13.0200
## 13197  64C 4.6        64     Msc     7.9500
## 13198  64C 4.7        64     Msc     9.4750
## 13199  64C 4.8        64     Msc     8.3500
## 13200  64C 4.9        64     Msc     5.2950
## 13201 64C 4.10        64     Msc    10.3350
## 13202 64C 4.11        64     Msc    13.3050
## 13203 64C 4.12        64     Msc    12.3750
## 13204 64C 4.13        64     Msc    10.1900
## 13205 64C 4.14        64     Msc    12.7750
## 13206 64C 4.15        64     Msc     8.5050
## 13207 64C 4.16        64     Msc     3.1050
## 13208 64C 4.17        64     Msc    13.1700
## 13209 64C 4.18        64     Msc     7.1700
## 13210 64C 4.19        64     Msc    10.8850
## 13211 64C 4.20        64     Msc     7.9350
## 13212 64C 4.21        64     Msc     8.4100
## 13213 64C 4.22        64     Msc     8.2800
## 13214 64C 4.23        64     Msc     9.3650
## 13215 64C 4.24        64     Msc    11.7000
## 13216 64C 4.25        64     Msc     5.0200
## 13217 64C 4.26        64     Msc    12.3250
## 13218 64C 4.27        64     Msc     6.2700
## 13219 64C 4.28        64     Msc     7.8150
## 13220 64C 4.29        64     Msc    12.5750
## 13221 64C 4.30        64     Msc     7.9250
## 13222 64C 4.31        64     Msc     9.6950
## 13223 64C 4.32        64     Msc     6.8200
## 13224 64C 4.33        64     Msc    12.4350
## 13225 64C 4.34        64     Msc     7.5350
## 13226 64C 4.35        64     Msc    13.9600
## 13227 64C 4.36        64     Msc     6.2850
## 13228 64C 4.37        64     Msc     8.9950
## 13229 64C 4.38        64     Msc     6.7900
## 13230 64C 4.39        64     Msc     8.4300
## 13231  64C 5.1        64     Msc    13.0850
## 13232  64C 5.2        64     Msc    12.2750
## 13233  64C 5.3        64     Msc    11.7900
## 13234  64C 5.4        64     Msc     5.4900
## 13235  64C 5.5        64     Msc    11.6000
## 13236  64C 5.6        64     Msc    12.6300
## 13237  64C 5.7        64     Msc    13.2800
## 13238  64C 5.8        64     Msc     7.5275
## 13239  64C 5.9        64     Msc    12.7250
## 13240 64C 5.10        64     Msc    12.0700
## 13241 64C 5.11        64     Msc     8.5000
## 13242 64C 5.12        64     Msc    11.2750
## 13243 64C 5.13        64     Msc     9.0650
## 13244 64C 5.14        64     Msc    12.8250
## 13245 64C 5.15        64     Msc    13.2950
## 13246 64C 5.16        64     Msc     9.3750
## 13247  64C 6.1        64     Msc    12.0575
## 13248  64C 6.2        64     Msc     7.9650
## 13249  64C 6.3        64     Msc     4.3500
## 13250  64C 6.4        64     Msc     5.9600
## 13251  64C 6.5        64     Msc     5.6850
## 13252  64C 6.6        64     Msc     5.6500
## 13253  64C 6.7        64     Msc    10.7950
## 13254  64C 6.8        64     Msc     7.5650
## 13255  64C 7.1        64     Msc    13.5600
## 13256  64C 7.2        64     Msc    12.7325
## 13257  64C 7.3        64     Msc     6.7650
## 13258  64C 7.4        64     Msc    11.6150
## 13259  64C 7.5        64     Msc    12.4200
## 13260  64C 7.6        64     Msc     5.5250
## 13261  64C 7.7        64     Msc    12.3650
## 13262  64C 7.8        64     Msc    11.6550
## 13263  64C 7.9        64     Msc    12.8950
## 13264 64C 7.10        64     Msc    13.8650
## 13265 64C 7.11        64     Msc     6.6600
## 13266 64C 7.12        64     Msc    11.4250
## 13267 64C 7.13        64     Msc    13.1550
## 13268 64C 7.14        64     Msc     9.5900
## 13269   2C 1.1         2    Msx2     9.4650
## 13270   2C 1.2         2    Msx2    11.1450
## 13271   2C 2.1         2    Msx2     9.7950
## 13272   2C 2.2         2    Msx2     9.5200
## 13273   2C 3.1         2    Msx2    13.7500
## 13274   2C 3.2         2    Msx2    11.4600
## 13275   2C 4.1         2    Msx2    13.8850
## 13276   2C 5.1         2    Msx2     8.5800
## 13277   2C 5.2         2    Msx2    11.7650
## 13278   2C 6.1         2    Msx2    11.2100
## 13279   2C 6.2         2    Msx2    11.3750
## 13280   2C 7.1         2    Msx2    10.9100
## 13281   2C 7.2         2    Msx2    12.5900
## 13282   2C 8.1         2    Msx2    10.2550
## 13283   2C 8.2         2    Msx2    12.1600
## 13284   2C 9.1         2    Msx2    13.3950
## 13285   2C 9.2         2    Msx2     9.4000
## 13286  2C 10.1         2    Msx2    11.8600
## 13287  2C 10.2         2    Msx2    11.6300
## 13288   4C 1.1         4    Msx2    12.1650
## 13289   4C 1.2         4    Msx2    11.1400
## 13290   4C 1.3         4    Msx2    14.7500
## 13291   4C 1.4         4    Msx2    14.1500
## 13292   4C 2.1         4    Msx2    12.2850
## 13293   4C 2.2         4    Msx2    14.0100
## 13294   4C 2.3         4    Msx2    13.3200
## 13295   4C 3.1         4    Msx2    12.5450
## 13296   4C 3.2         4    Msx2    11.2900
## 13297   4C 3.3         4    Msx2    11.8950
## 13298   4C 3.4         4    Msx2     9.9900
## 13299   4C 4.1         4    Msx2    14.7350
## 13300   4C 4.2         4    Msx2    13.0900
## 13301   4C 4.3         4    Msx2    13.3850
## 13302   4C 4.4         4    Msx2    14.8100
## 13303   4C 5.1         4    Msx2    14.4450
## 13304   4C 5.2         4    Msx2    12.3950
## 13305   4C 5.3         4    Msx2    12.1750
## 13306   4C 5.4         4    Msx2    12.4150
## 13307   4C 6.1         4    Msx2    11.6200
## 13308   4C 6.2         4    Msx2    13.4600
## 13309   4C 6.3         4    Msx2    12.9150
## 13310   4C 6.4         4    Msx2     9.1050
## 13311   8C 1.1         8    Msx2    14.6800
## 13312   8C 1.2         8    Msx2    13.8750
## 13313   8C 1.3         8    Msx2    11.1850
## 13314   8C 1.4         8    Msx2    11.5100
## 13315   8C 1.5         8    Msx2    12.4300
## 13316   8C 2.1         8    Msx2    11.7000
## 13317   8C 2.2         8    Msx2    14.3100
## 13318   8C 2.3         8    Msx2    13.5650
## 13319   8C 2.4         8    Msx2    11.6700
## 13320   8C 2.5         8    Msx2    13.9200
## 13321   8C 2.6         8    Msx2    14.7300
## 13322   8C 2.7         8    Msx2    12.0900
## 13323   8C 2.8         8    Msx2     9.6850
## 13324   8C 3.1         8    Msx2     7.8400
## 13325   8C 3.2         8    Msx2    12.6600
## 13326   8C 3.3         8    Msx2    14.2350
## 13327   8C 3.4         8    Msx2    12.9600
## 13328   8C 3.5         8    Msx2    14.3950
## 13329   8C 3.6         8    Msx2    13.2600
## 13330   8C 3.7         8    Msx2    12.7300
## 13331   8C 3.8         8    Msx2     7.4450
## 13332   8C 4.2         8    Msx2    11.5450
## 13333   8C 4.3         8    Msx2     8.1350
## 13334   8C 4.4         8    Msx2     6.6000
## 13335   8C 4.5         8    Msx2    14.1900
## 13336   8C 4.6         8    Msx2    13.0850
## 13337   8C 4.7         8    Msx2     8.7650
## 13338   8C 5.1         8    Msx2    13.1700
## 13339   8C 5.2         8    Msx2     7.5000
## 13340   8C 5.3         8    Msx2    11.5150
## 13341   8C 5.4         8    Msx2     8.3950
## 13342   8C 5.5         8    Msx2    11.5650
## 13343   8C 5.6         8    Msx2    11.3750
## 13344   8C 5.7         8    Msx2    13.6700
## 13345   8C 5.8         8    Msx2    14.3150
## 13346   8C 6.1         8    Msx2    11.1000
## 13347   8C 6.2         8    Msx2    11.7400
## 13348   8C 6.3         8    Msx2    12.2750
## 13349   8C 6.4         8    Msx2    10.6750
## 13350   8C 6.5         8    Msx2    11.5250
## 13351   8C 6.6         8    Msx2    12.4650
## 13352   8C 6.7         8    Msx2     9.4950
## 13353   8C 6.8         8    Msx2     9.2700
## 13354  16C 1.1        16    Msx2    13.1050
## 13355  16C 1.2        16    Msx2    13.8700
## 13356  16C 1.3        16    Msx2     5.7200
## 13357  16C 1.4        16    Msx2     6.7050
## 13358  16C 1.5        16    Msx2     6.3650
## 13359  16C 1.6        16    Msx2    11.9650
## 13360  16C 1.7        16    Msx2     4.1850
## 13361  16C 1.8        16    Msx2     7.6800
## 13362  16C 1.9        16    Msx2     6.1650
## 13363 16C 1.10        16    Msx2     7.4025
## 13364 16C 1.11        16    Msx2     6.7700
## 13365 16C 1.12        16    Msx2    13.0100
## 13366 16C 1.13        16    Msx2     5.0300
## 13367 16C 1.14        16    Msx2     4.0600
## 13368 16C 1.15        16    Msx2    11.8050
## 13369 16C 1.16        16    Msx2     4.5200
## 13370  16C 2.1        16    Msx2     9.9700
## 13371  16C 2.2        16    Msx2     9.7650
## 13372  16C 2.3        16    Msx2    12.0825
## 13373  16C 2.4        16    Msx2    14.2450
## 13374  16C 2.5        16    Msx2     9.3050
## 13375  16C 2.6        16    Msx2    12.0950
## 13376  16C 2.7        16    Msx2     9.4650
## 13377  16C 2.8        16    Msx2     6.2250
## 13378  16C 2.9        16    Msx2     9.7950
## 13379 16C 2.10        16    Msx2    12.9200
## 13380 16C 2.11        16    Msx2     9.2900
## 13381 16C 2.12        16    Msx2     6.5500
## 13382 16C 2.13        16    Msx2     9.1350
## 13383 16C 2.14        16    Msx2    13.1300
## 13384 16C 2.15        16    Msx2     7.0550
## 13385 16C 2.16        16    Msx2     5.8500
## 13386  16C 3.1        16    Msx2     4.4750
## 13387  16C 3.2        16    Msx2     4.6100
## 13388  16C 3.3        16    Msx2     8.6300
## 13389  16C 3.4        16    Msx2     9.3650
## 13390  16C 3.5        16    Msx2     7.9200
## 13391  16C 3.6        16    Msx2     7.3950
## 13392  16C 3.7        16    Msx2     7.8400
## 13393  16C 3.8        16    Msx2    11.8600
## 13394  16C 3.9        16    Msx2    11.6300
## 13395 16C 3.10        16    Msx2     7.3950
## 13396 16C 3.11        16    Msx2    11.1400
## 13397 16C 3.12        16    Msx2    11.2600
## 13398 16C 3.13        16    Msx2     8.9400
## 13399 16C 3.14        16    Msx2     9.9450
## 13400 16C 3.15        16    Msx2     8.3800
## 13401  16C 4.1        16    Msx2    13.3200
## 13402  16C 4.2        16    Msx2     8.1350
## 13403  16C 4.3        16    Msx2     7.2800
## 13404  16C 4.4        16    Msx2    11.8950
## 13405  16C 4.5        16    Msx2    11.2000
## 13406  16C 4.6        16    Msx2    14.7350
## 13407  16C 4.7        16    Msx2     9.4300
## 13408  16C 4.8        16    Msx2     7.5750
## 13409  16C 4.9        16    Msx2    14.8100
## 13410 16C 4.10        16    Msx2    14.4450
## 13411 16C 4.11        16    Msx2    12.3950
## 13412 16C 4.12        16    Msx2     8.1450
## 13413 16C 4.13        16    Msx2    12.4150
## 13414 16C 4.14        16    Msx2     6.7100
## 13415 16C 4.15        16    Msx2    13.4600
## 13416 16C 4.16        16    Msx2    11.7650
## 13417  16C 5.1        16    Msx2    13.2550
## 13418  16C 5.2        16    Msx2     9.1800
## 13419  16C 5.3        16    Msx2     8.2450
## 13420  16C 5.4        16    Msx2     5.5250
## 13421  16C 5.5        16    Msx2     7.7000
## 13422  16C 5.6        16    Msx2    12.4300
## 13423  16C 5.7        16    Msx2    11.7000
## 13424  16C 5.8        16    Msx2    14.3100
## 13425  16C 5.9        16    Msx2    12.9350
## 13426 16C 5.10        16    Msx2    11.6700
## 13427 16C 5.11        16    Msx2     8.1200
## 13428 16C 5.12        16    Msx2    14.7300
## 13429  32C 1.1        32    Msx2     7.9700
## 13430  32C 1.2        32    Msx2     9.6850
## 13431  32C 1.3        32    Msx2     5.7400
## 13432  32C 1.4        32    Msx2     5.6800
## 13433  32C 1.5        32    Msx2    14.2350
## 13434  32C 1.6        32    Msx2    12.9600
## 13435  32C 1.7        32    Msx2    10.1950
## 13436  32C 1.8        32    Msx2     9.0600
## 13437  32C 1.9        32    Msx2     8.1300
## 13438 32C 1.10        32    Msx2     6.6550
## 13439 32C 1.11        32    Msx2     5.8450
## 13440 32C 1.12        32    Msx2     4.6950
## 13441 32C 1.13        32    Msx2    10.9800
## 13442 32C 1.14        32    Msx2     8.2300
## 13443 32C 1.15        32    Msx2     8.3750
## 13444 32C 1.16        32    Msx2    13.9450
## 13445 32C 1.17        32    Msx2    13.1700
## 13446 32C 1.18        32    Msx2     9.3700
## 13447 32C 1.19        32    Msx2     7.6450
## 13448 32C 1.20        32    Msx2     8.3950
## 13449 32C 1.21        32    Msx2     5.8950
## 13450  32C 2.1        32    Msx2     4.3150
## 13451  32C 2.2        32    Msx2     5.7300
## 13452  32C 2.3        32    Msx2     7.1950
## 13453  32C 2.4        32    Msx2    15.2400
## 13454  32C 2.5        32    Msx2     6.6700
## 13455  32C 2.6        32    Msx2     6.2250
## 13456  32C 2.7        32    Msx2     4.1750
## 13457  32C 2.8        32    Msx2     6.9950
## 13458  32C 2.9        32    Msx2     4.9650
## 13459 32C 2.10        32    Msx2     6.4950
## 13460 32C 2.11        32    Msx2    10.5700
## 13461 32C 2.12        32    Msx2     5.8550
## 13462 32C 2.13        32    Msx2    13.8700
## 13463 32C 2.14        32    Msx2    11.2600
## 13464 32C 2.15        32    Msx2     5.8050
## 13465 32C 2.16        32    Msx2    10.4450
## 13466  32C 3.1        32    Msx2     5.0950
## 13467  32C 3.2        32    Msx2    10.7850
## 13468  32C 3.3        32    Msx2     6.3600
## 13469  32C 3.4        32    Msx2     6.7150
## 13470  32C 3.5        32    Msx2     8.7225
## 13471  32C 3.6        32    Msx2     5.4300
## 13472  32C 3.7        32    Msx2     9.3000
## 13473  32C 3.8        32    Msx2     6.7000
## 13474  32C 4.1        32    Msx2     1.7700
## 13475  32C 4.2        32    Msx2     8.7150
## 13476  32C 4.3        32    Msx2     5.9200
## 13477  32C 4.4        32    Msx2     7.9800
## 13478  32C 4.5        32    Msx2     9.5450
## 13479  32C 4.6        32    Msx2     8.8025
## 13480  32C 4.7        32    Msx2    10.7050
## 13481  32C 4.8        32    Msx2     5.8050
## 13482 32C 4.10        32    Msx2    12.0950
## 13483 32C 4.11        32    Msx2     9.4650
## 13484 32C 4.12        32    Msx2     6.2750
## 13485 32C 4.13        32    Msx2     3.4050
## 13486 32C 4.14        32    Msx2    12.9200
## 13487 32C 4.15        32    Msx2    13.7500
## 13488 32C 4.16        32    Msx2     6.8400
## 13489 32C 4.17        32    Msx2     9.7250
## 13490 32C 4.18        32    Msx2     6.1300
## 13491 32C 4.19        32    Msx2     3.2050
## 13492 32C 4.20        32    Msx2     3.9900
## 13493 32C 4.21        32    Msx2    11.3750
## 13494 32C 4.22        32    Msx2    10.9100
## 13495 32C 4.23        32    Msx2     5.7300
## 13496 32C 4.24        32    Msx2     8.4350
## 13497  32C 5.1        32    Msx2     5.2000
## 13498  32C 5.2        32    Msx2     8.3850
## 13499  32C 5.3        32    Msx2    10.2000
## 13500  32C 5.4        32    Msx2    11.1500
## 13501  32C 5.5        32    Msx2    11.6300
## 13502  32C 5.6        32    Msx2     5.4650
## 13503  32C 5.7        32    Msx2    11.1400
## 13504  32C 5.8        32    Msx2    14.7500
## 13505  32C 5.9        32    Msx2     6.9500
## 13506 32C 5.10        32    Msx2     7.0850
## 13507 32C 5.11        32    Msx2    14.0100
## 13508 32C 5.12        32    Msx2    13.3200
## 13509 32C 5.13        32    Msx2     5.7150
## 13510 32C 5.14        32    Msx2     6.4200
## 13511 32C 5.15        32    Msx2    11.8950
## 13512 32C 5.16        32    Msx2    11.2000
## 13513 32C 5.17        32    Msx2     7.5850
## 13514 32C 5.18        32    Msx2     7.0100
## 13515 32C 5.19        32    Msx2    10.5750
## 13516 32C 5.20        32    Msx2     9.1800
## 13517 32C 5.21        32    Msx2     9.4050
## 13518 32C 5.22        32    Msx2     7.6850
## 13519 32C 5.23        32    Msx2     5.1850
## 13520  32C 6.1        32    Msx2     9.5900
## 13521  32C 6.2        32    Msx2     3.6750
## 13522  32C 6.3        32    Msx2     9.3600
## 13523  32C 6.4        32    Msx2    12.9150
## 13524  32C 6.6        32    Msx2    13.2550
## 13525  32C 6.7        32    Msx2     9.5300
## 13526  32C 7.1        32    Msx2     6.9700
## 13527  32C 7.2        32    Msx2    11.1850
## 13528  32C 7.3        32    Msx2    11.5100
## 13529  32C 7.4        32    Msx2     8.4300
## 13530  32C 7.5        32    Msx2     7.5500
## 13531  32C 7.6        32    Msx2    11.3050
## 13532  32C 7.8        32    Msx2     7.8050
## 13533  32C 8.1        32    Msx2     7.6650
## 13534  32C 8.2        32    Msx2     8.0400
## 13535  32C 8.4        32    Msx2     8.8200
## 13536  32C 8.5        32    Msx2    12.0900
## 13537  32C 8.6        32    Msx2     2.4600
## 13538  64C 1.1        64    Msx2     5.1300
## 13539  64C 1.2        64    Msx2     7.7900
## 13540  64C 1.3        64    Msx2    14.2350
## 13541  64C 1.4        64    Msx2     8.5400
## 13542  64C 1.5        64    Msx2    11.1350
## 13543  64C 1.6        64    Msx2    13.2600
## 13544  64C 1.7        64    Msx2    10.0100
## 13545  64C 1.8        64    Msx2    12.4350
## 13546  64C 1.9        64    Msx2     6.3050
## 13547 64C 1.10        64    Msx2     5.7150
## 13548 64C 1.11        64    Msx2     7.5900
## 13549 64C 1.12        64    Msx2    10.9900
## 13550 64C 1.13        64    Msx2     7.7650
## 13551 64C 1.14        64    Msx2    13.9450
## 13552 64C 1.15        64    Msx2     7.3800
## 13553 64C 1.16        64    Msx2     6.8400
## 13554 64C 1.17        64    Msx2     5.8650
## 13555 64C 1.18        64    Msx2     3.6050
## 13556 64C 1.19        64    Msx2     8.4150
## 13557 64C 1.20        64    Msx2     7.9150
## 13558 64C 1.21        64    Msx2    13.6700
## 13559 64C 1.22        64    Msx2    14.3150
## 13560 64C 1.23        64    Msx2    11.4300
## 13561 64C 1.24        64    Msx2     6.2000
## 13562 64C 1.25        64    Msx2     5.6250
## 13563 64C 1.26        64    Msx2    10.6750
## 13564 64C 1.27        64    Msx2     6.2550
## 13565 64C 1.28        64    Msx2     9.5250
## 13566 64C 1.29        64    Msx2     9.7350
## 13567 64C 1.30        64    Msx2     8.2100
## 13568 64C 1.31        64    Msx2     9.4250
## 13569 64C 1.32        64    Msx2    13.8700
## 13570 64C 1.33        64    Msx2     5.1500
## 13571 64C 1.34        64    Msx2     7.9750
## 13572 64C 1.35        64    Msx2     5.5150
## 13573 64C 1.36        64    Msx2    11.9650
## 13574 64C 1.37        64    Msx2     6.2950
## 13575 64C 1.38        64    Msx2     7.6700
## 13576 64C 1.39        64    Msx2    13.6550
## 13577 64C 1.40        64    Msx2    13.4025
## 13578 64C 1.41        64    Msx2     8.1300
## 13579 64C 1.42        64    Msx2     8.0400
## 13580 64C 1.43        64    Msx2    12.2600
## 13581 64C 1.44        64    Msx2     5.5300
## 13582 64C 1.45        64    Msx2     6.7050
## 13583 64C 1.46        64    Msx2     6.8200
## 13584 64C 1.47        64    Msx2    13.3600
## 13585 64C 1.48        64    Msx2    13.4950
## 13586  64C 2.1        64    Msx2     6.3725
## 13587  64C 2.2        64    Msx2     6.9450
## 13588  64C 2.3        64    Msx2     8.8150
## 13589  64C 2.4        64    Msx2     6.0150
## 13590  64C 2.5        64    Msx2     3.2350
## 13591  64C 2.6        64    Msx2     5.8750
## 13592  64C 2.7        64    Msx2     4.6950
## 13593  64C 2.8        64    Msx2     7.6600
## 13594  64C 2.9        64    Msx2     8.4600
## 13595 64C 2.10        64    Msx2     7.2800
## 13596 64C 2.11        64    Msx2    10.4250
## 13597 64C 2.12        64    Msx2     6.4900
## 13598 64C 2.13        64    Msx2     6.1250
## 13599 64C 2.14        64    Msx2     4.3000
## 13600 64C 2.15        64    Msx2     6.1850
## 13601 64C 2.16        64    Msx2    10.9100
## 13602 64C 2.17        64    Msx2     6.8500
## 13603 64C 2.18        64    Msx2     9.4950
## 13604 64C 2.19        64    Msx2     6.2800
## 13605 64C 2.20        64    Msx2    13.3950
## 13606 64C 2.21        64    Msx2    14.0200
## 13607 64C 2.22        64    Msx2    11.8600
## 13608 64C 2.23        64    Msx2     6.3400
## 13609 64C 2.24        64    Msx2     5.6750
## 13610 64C 2.25        64    Msx2     4.5900
## 13611  64C 3.1        64    Msx2    14.7500
## 13612  64C 3.2        64    Msx2     7.9600
## 13613  64C 3.3        64    Msx2    12.2850
## 13614  64C 3.4        64    Msx2    14.0100
## 13615  64C 3.5        64    Msx2     6.2200
## 13616  64C 3.6        64    Msx2    12.5450
## 13617  64C 3.7        64    Msx2    11.2900
## 13618  64C 3.8        64    Msx2    11.8950
## 13619  64C 4.1        64    Msx2    11.2000
## 13620 64C 4.1b        64    Msx2    14.7350
## 13621  64C 4.2        64    Msx2    13.0900
## 13622  64C 4.3        64    Msx2    13.3850
## 13623  64C 4.4        64    Msx2    14.8100
## 13624  64C 4.5        64    Msx2     8.6650
## 13625  64C 4.6        64    Msx2     7.8250
## 13626  64C 4.7        64    Msx2    12.1750
## 13627  64C 4.8        64    Msx2    12.4150
## 13628  64C 4.9        64    Msx2     6.1900
## 13629 64C 4.10        64    Msx2    13.4600
## 13630 64C 4.11        64    Msx2    12.9150
## 13631 64C 4.12        64    Msx2    10.1050
## 13632 64C 4.13        64    Msx2    10.2800
## 13633 64C 4.14        64    Msx2    13.8750
## 13634 64C 4.15        64    Msx2     6.6950
## 13635 64C 4.16        64    Msx2     8.0800
## 13636 64C 4.17        64    Msx2     8.1800
## 13637 64C 4.18        64    Msx2     5.5500
## 13638 64C 4.19        64    Msx2     9.9300
## 13639 64C 4.20        64    Msx2     9.8950
## 13640 64C 4.21        64    Msx2     5.3600
## 13641 64C 4.22        64    Msx2     6.7500
## 13642 64C 4.23        64    Msx2    10.5800
## 13643 64C 4.24        64    Msx2    12.0900
## 13644 64C 4.25        64    Msx2     6.4750
## 13645 64C 4.26        64    Msx2     6.8800
## 13646 64C 4.27        64    Msx2     7.5200
## 13647 64C 4.28        64    Msx2     8.4050
## 13648 64C 4.29        64    Msx2     7.8100
## 13649 64C 4.30        64    Msx2     9.1450
## 13650 64C 4.31        64    Msx2     9.8400
## 13651 64C 4.32        64    Msx2    12.7300
## 13652 64C 4.33        64    Msx2    12.4350
## 13653 64C 4.34        64    Msx2     6.8050
## 13654 64C 4.35        64    Msx2     4.9550
## 13655 64C 4.36        64    Msx2     4.1900
## 13656 64C 4.37        64    Msx2    10.9000
## 13657 64C 4.38        64    Msx2    10.2450
## 13658 64C 4.39        64    Msx2     9.1250
## 13659  64C 5.1        64    Msx2    13.1700
## 13660  64C 5.2        64    Msx2     6.1600
## 13661  64C 5.3        64    Msx2     6.4250
## 13662  64C 5.4        64    Msx2     8.3950
## 13663  64C 5.5        64    Msx2     6.5450
## 13664  64C 5.6        64    Msx2    11.3750
## 13665  64C 5.7        64    Msx2     8.1900
## 13666  64C 5.8        64    Msx2    14.3150
## 13667  64C 5.9        64    Msx2    15.2400
## 13668 64C 5.10        64    Msx2     5.6700
## 13669 64C 5.11        64    Msx2    12.2750
## 13670 64C 5.12        64    Msx2     6.6350
## 13671 64C 5.13        64    Msx2    11.5250
## 13672 64C 5.14        64    Msx2    12.4650
## 13673 64C 5.15        64    Msx2    10.1850
## 13674 64C 5.16        64    Msx2    13.6300
## 13675  64C 6.1        64    Msx2     8.2950
## 13676  64C 6.2        64    Msx2    13.8700
## 13677  64C 6.3        64    Msx2    11.2600
## 13678  64C 6.4        64    Msx2    12.5750
## 13679  64C 6.5        64    Msx2    10.4450
## 13680  64C 6.6        64    Msx2    11.9650
## 13681  64C 6.7        64    Msx2    10.7850
## 13682  64C 6.8        64    Msx2    13.1800
## 13683  64C 7.1        64    Msx2    13.6550
## 13684  64C 7.2        64    Msx2     7.7325
## 13685  64C 7.3        64    Msx2    12.2800
## 13686  64C 7.4        64    Msx2     6.5200
## 13687  64C 7.5        64    Msx2    12.2600
## 13688  64C 7.6        64    Msx2    10.3100
## 13689  64C 7.7        64    Msx2     5.7150
## 13690  64C 7.8        64    Msx2    11.2000
## 13691  64C 7.9        64    Msx2    13.3600
## 13692 64C 7.10        64    Msx2     9.3350
## 13693 64C 7.11        64    Msx2     6.5225
## 13694 64C 7.12        64    Msx2    14.2450
## 13695 64C 7.13        64    Msx2     9.3350
## 13696 64C 7.14        64    Msx2     7.8750
## 13697   2C 1.1         2   Nanog     9.5100
## 13698   2C 1.2         2   Nanog    11.1900
## 13699   2C 2.1         2   Nanog     4.6650
## 13700   2C 2.2         2   Nanog     8.5500
## 13701   2C 3.1         2   Nanog     9.5350
## 13702   2C 3.2         2   Nanog     7.8650
## 13703   2C 4.1         2   Nanog    13.6850
## 13704   2C 5.1         2   Nanog    13.1850
## 13705   2C 5.2         2   Nanog     7.6250
## 13706   2C 6.1         2   Nanog     5.9000
## 13707   2C 6.2         2   Nanog     8.4600
## 13708   2C 7.1         2   Nanog    11.7950
## 13709   2C 7.2         2   Nanog    13.2550
## 13710   2C 8.1         2   Nanog    11.1850
## 13711   2C 8.2         2   Nanog     9.4850
## 13712   2C 9.1         2   Nanog    11.4150
## 13713   2C 9.2         2   Nanog    13.1100
## 13714  2C 10.1         2   Nanog     7.3700
## 13715  2C 10.2         2   Nanog     7.0050
## 13716   4C 1.1         4   Nanog     5.4150
## 13717   4C 1.2         4   Nanog     4.8000
## 13718   4C 1.3         4   Nanog     5.8500
## 13719   4C 1.4         4   Nanog     6.6350
## 13720   4C 2.1         4   Nanog     6.1400
## 13721   4C 2.2         4   Nanog     7.2600
## 13722   4C 2.3         4   Nanog     5.8450
## 13723   4C 3.1         4   Nanog     4.9600
## 13724   4C 3.2         4   Nanog     6.8700
## 13725   4C 3.3         4   Nanog     6.7050
## 13726   4C 3.4         4   Nanog     5.6900
## 13727   4C 4.1         4   Nanog     8.2500
## 13728   4C 4.2         4   Nanog     7.2900
## 13729   4C 4.3         4   Nanog     8.6500
## 13730   4C 4.4         4   Nanog     5.0000
## 13731   4C 5.1         4   Nanog     8.4800
## 13732   4C 5.2         4   Nanog     4.7450
## 13733   4C 5.3         4   Nanog     4.4550
## 13734   4C 5.4         4   Nanog     4.8500
## 13735   4C 6.1         4   Nanog     5.7700
## 13736   4C 6.2         4   Nanog     6.1600
## 13737   4C 6.3         4   Nanog     6.3150
## 13738   4C 6.4         4   Nanog     5.5450
## 13739   8C 1.1         8   Nanog     7.8250
## 13740   8C 1.2         8   Nanog     4.8250
## 13741   8C 1.3         8   Nanog     5.6000
## 13742   8C 1.4         8   Nanog     4.1450
## 13743   8C 1.5         8   Nanog     4.1350
## 13744   8C 2.1         8   Nanog     1.9300
## 13745   8C 2.2         8   Nanog     5.3000
## 13746   8C 2.3         8   Nanog     6.3950
## 13747   8C 2.4         8   Nanog     9.8250
## 13748   8C 2.5         8   Nanog     4.3150
## 13749   8C 2.6         8   Nanog     5.0250
## 13750   8C 2.7         8   Nanog     3.2700
## 13751   8C 2.8         8   Nanog     0.3950
## 13752   8C 3.1         8   Nanog     5.3600
## 13753   8C 3.2         8   Nanog     6.3350
## 13754   8C 3.3         8   Nanog     6.5550
## 13755   8C 3.4         8   Nanog     4.0800
## 13756   8C 3.5         8   Nanog     4.6500
## 13757   8C 3.6         8   Nanog     3.9500
## 13758   8C 3.7         8   Nanog     3.9500
## 13759   8C 3.8         8   Nanog     3.2950
## 13760   8C 4.2         8   Nanog     9.5850
## 13761   8C 4.3         8   Nanog     3.5500
## 13762   8C 4.4         8   Nanog     9.1450
## 13763   8C 4.5         8   Nanog    11.1550
## 13764   8C 4.6         8   Nanog     6.8475
## 13765   8C 4.7         8   Nanog     5.4000
## 13766   8C 5.1         8   Nanog     3.2150
## 13767   8C 5.2         8   Nanog     3.3100
## 13768   8C 5.3         8   Nanog     1.9400
## 13769   8C 5.4         8   Nanog     1.3150
## 13770   8C 5.5         8   Nanog     4.8500
## 13771   8C 5.6         8   Nanog     3.9550
## 13772   8C 5.7         8   Nanog     5.1200
## 13773   8C 5.8         8   Nanog     3.2725
## 13774   8C 6.1         8   Nanog     4.8450
## 13775   8C 6.2         8   Nanog     2.9250
## 13776   8C 6.3         8   Nanog     3.8050
## 13777   8C 6.4         8   Nanog     3.9250
## 13778   8C 6.5         8   Nanog     3.1300
## 13779   8C 6.6         8   Nanog     2.6450
## 13780   8C 6.7         8   Nanog     3.7750
## 13781   8C 6.8         8   Nanog     4.9050
## 13782  16C 1.1        16   Nanog     6.9750
## 13783  16C 1.2        16   Nanog     3.5550
## 13784  16C 1.3        16   Nanog     3.7200
## 13785  16C 1.4        16   Nanog    -0.5850
## 13786  16C 1.5        16   Nanog     3.0300
## 13787  16C 1.6        16   Nanog     1.9350
## 13788  16C 1.7        16   Nanog     3.6950
## 13789  16C 1.8        16   Nanog     2.8400
## 13790  16C 1.9        16   Nanog     3.5950
## 13791 16C 1.10        16   Nanog     1.4550
## 13792 16C 1.11        16   Nanog     5.4350
## 13793 16C 1.12        16   Nanog     2.1850
## 13794 16C 1.13        16   Nanog     3.3900
## 13795 16C 1.14        16   Nanog    -0.1250
## 13796 16C 1.15        16   Nanog     2.2450
## 13797 16C 1.16        16   Nanog     2.2450
## 13798  16C 2.1        16   Nanog     7.1400
## 13799  16C 2.2        16   Nanog     4.1350
## 13800  16C 2.3        16   Nanog     1.8600
## 13801  16C 2.4        16   Nanog     7.8000
## 13802  16C 2.5        16   Nanog     2.4850
## 13803  16C 2.6        16   Nanog     1.0950
## 13804  16C 2.7        16   Nanog    -1.1100
## 13805  16C 2.8        16   Nanog     2.0300
## 13806  16C 2.9        16   Nanog     2.2650
## 13807 16C 2.10        16   Nanog     3.7800
## 13808 16C 2.11        16   Nanog     3.0050
## 13809 16C 2.12        16   Nanog     3.5250
## 13810 16C 2.13        16   Nanog     4.0150
## 13811 16C 2.14        16   Nanog     3.0450
## 13812 16C 2.15        16   Nanog     2.4050
## 13813 16C 2.16        16   Nanog     0.1200
## 13814  16C 3.1        16   Nanog     6.7000
## 13815  16C 3.2        16   Nanog     3.2550
## 13816  16C 3.3        16   Nanog     4.1650
## 13817  16C 3.4        16   Nanog     7.6950
## 13818  16C 3.5        16   Nanog     5.7350
## 13819  16C 3.6        16   Nanog     9.5450
## 13820  16C 3.7        16   Nanog     5.0600
## 13821  16C 3.8        16   Nanog     4.6900
## 13822  16C 3.9        16   Nanog     6.1250
## 13823 16C 3.10        16   Nanog     2.8350
## 13824 16C 3.11        16   Nanog     5.6400
## 13825 16C 3.12        16   Nanog     6.7200
## 13826 16C 3.13        16   Nanog     8.2150
## 13827 16C 3.14        16   Nanog     3.6000
## 13828 16C 3.15        16   Nanog     4.1900
## 13829  16C 4.1        16   Nanog     7.5250
## 13830  16C 4.2        16   Nanog     3.4000
## 13831  16C 4.3        16   Nanog     7.4100
## 13832  16C 4.4        16   Nanog     7.4250
## 13833  16C 4.5        16   Nanog     3.2900
## 13834  16C 4.6        16   Nanog     9.3500
## 13835  16C 4.7        16   Nanog     8.1600
## 13836  16C 4.8        16   Nanog     7.0700
## 13837  16C 4.9        16   Nanog     7.2500
## 13838 16C 4.10        16   Nanog     7.2900
## 13839 16C 4.11        16   Nanog     7.2250
## 13840 16C 4.12        16   Nanog     5.6350
## 13841 16C 4.13        16   Nanog     5.1400
## 13842 16C 4.14        16   Nanog     3.5600
## 13843 16C 4.15        16   Nanog     7.3000
## 13844 16C 4.16        16   Nanog     6.8350
## 13845  16C 5.1        16   Nanog     5.5150
## 13846  16C 5.2        16   Nanog     3.1250
## 13847  16C 5.3        16   Nanog     5.8950
## 13848  16C 5.4        16   Nanog     3.8000
## 13849  16C 5.5        16   Nanog     0.7150
## 13850  16C 5.6        16   Nanog     1.3650
## 13851  16C 5.7        16   Nanog    -0.3800
## 13852  16C 5.8        16   Nanog     5.7200
## 13853  16C 5.9        16   Nanog     3.8550
## 13854 16C 5.10        16   Nanog     3.5150
## 13855 16C 5.11        16   Nanog     2.9250
## 13856 16C 5.12        16   Nanog     4.0150
## 13857  32C 1.1        32   Nanog     4.2300
## 13858  32C 1.2        32   Nanog    -2.4750
## 13859  32C 1.3        32   Nanog     8.2900
## 13860  32C 1.4        32   Nanog     5.7950
## 13861  32C 1.5        32   Nanog     4.3150
## 13862  32C 1.6        32   Nanog     4.8600
## 13863  32C 1.7        32   Nanog     7.6700
## 13864  32C 1.8        32   Nanog     3.1700
## 13865  32C 1.9        32   Nanog     2.3200
## 13866 32C 1.10        32   Nanog     5.9750
## 13867 32C 1.11        32   Nanog     4.0750
## 13868 32C 1.12        32   Nanog     3.8600
## 13869 32C 1.13        32   Nanog     5.9950
## 13870 32C 1.14        32   Nanog     7.1650
## 13871 32C 1.15        32   Nanog     4.7975
## 13872 32C 1.16        32   Nanog     5.1300
## 13873 32C 1.17        32   Nanog     6.0350
## 13874 32C 1.18        32   Nanog     2.4300
## 13875 32C 1.19        32   Nanog     5.6100
## 13876 32C 1.20        32   Nanog     2.7550
## 13877 32C 1.21        32   Nanog     3.8100
## 13878  32C 2.1        32   Nanog     3.2150
## 13879  32C 2.2        32   Nanog     5.3000
## 13880  32C 2.3        32   Nanog     3.5925
## 13881  32C 2.4        32   Nanog     4.0450
## 13882  32C 2.5        32   Nanog     3.7650
## 13883  32C 2.6        32   Nanog     5.6950
## 13884  32C 2.7        32   Nanog    -0.3550
## 13885  32C 2.8        32   Nanog     1.2300
## 13886  32C 2.9        32   Nanog     0.7150
## 13887 32C 2.10        32   Nanog     6.9150
## 13888 32C 2.11        32   Nanog     5.3850
## 13889 32C 2.12        32   Nanog     5.9250
## 13890 32C 2.13        32   Nanog     5.4750
## 13891 32C 2.14        32   Nanog     0.5200
## 13892 32C 2.15        32   Nanog    -0.1950
## 13893 32C 2.16        32   Nanog    -0.0300
## 13894  32C 3.1        32   Nanog     7.0850
## 13895  32C 3.2        32   Nanog     4.8750
## 13896  32C 3.3        32   Nanog    10.6100
## 13897  32C 3.4        32   Nanog     4.7350
## 13898  32C 3.5        32   Nanog     5.9350
## 13899  32C 3.6        32   Nanog     3.7850
## 13900  32C 3.7        32   Nanog     2.3450
## 13901  32C 3.8        32   Nanog     2.0900
## 13902  32C 4.1        32   Nanog     2.2950
## 13903  32C 4.2        32   Nanog     9.1950
## 13904  32C 4.3        32   Nanog    -0.5650
## 13905  32C 4.4        32   Nanog     6.1100
## 13906  32C 4.5        32   Nanog     6.4650
## 13907  32C 4.6        32   Nanog     1.6700
## 13908  32C 4.7        32   Nanog     8.6400
## 13909  32C 4.8        32   Nanog     8.5350
## 13910 32C 4.10        32   Nanog     5.5150
## 13911 32C 4.11        32   Nanog    -1.4000
## 13912 32C 4.12        32   Nanog     7.0800
## 13913 32C 4.13        32   Nanog     3.6550
## 13914 32C 4.14        32   Nanog     4.1900
## 13915 32C 4.15        32   Nanog     2.6650
## 13916 32C 4.16        32   Nanog     8.8250
## 13917 32C 4.17        32   Nanog     9.8350
## 13918 32C 4.18        32   Nanog     6.8750
## 13919 32C 4.19        32   Nanog     1.8350
## 13920 32C 4.20        32   Nanog     1.1500
## 13921 32C 4.21        32   Nanog     5.3100
## 13922 32C 4.22        32   Nanog     0.5750
## 13923 32C 4.23        32   Nanog    12.2250
## 13924 32C 4.24        32   Nanog     4.9450
## 13925  32C 5.1        32   Nanog     8.2350
## 13926  32C 5.2        32   Nanog     5.8650
## 13927  32C 5.3        32   Nanog     9.4000
## 13928  32C 5.4        32   Nanog     3.9400
## 13929  32C 5.5        32   Nanog     5.7350
## 13930  32C 5.6        32   Nanog    12.2150
## 13931  32C 5.7        32   Nanog     5.5800
## 13932  32C 5.8        32   Nanog     7.4100
## 13933  32C 5.9        32   Nanog     4.8450
## 13934 32C 5.10        32   Nanog     7.2800
## 13935 32C 5.11        32   Nanog     6.4400
## 13936 32C 5.12        32   Nanog     5.3150
## 13937 32C 5.13        32   Nanog     6.6300
## 13938 32C 5.14        32   Nanog     2.5500
## 13939 32C 5.15        32   Nanog    12.4950
## 13940 32C 5.16        32   Nanog     6.0600
## 13941 32C 5.17        32   Nanog     5.0900
## 13942 32C 5.18        32   Nanog     8.1800
## 13943 32C 5.19        32   Nanog     4.1900
## 13944 32C 5.20        32   Nanog     5.1500
## 13945 32C 5.21        32   Nanog    13.1200
## 13946 32C 5.22        32   Nanog     5.3850
## 13947 32C 5.23        32   Nanog     5.4250
## 13948  32C 6.1        32   Nanog     1.7350
## 13949  32C 6.2        32   Nanog     1.5150
## 13950  32C 6.3        32   Nanog     6.7750
## 13951  32C 6.4        32   Nanog     7.1450
## 13952  32C 6.6        32   Nanog     4.6800
## 13953  32C 6.7        32   Nanog     5.3800
## 13954  32C 7.1        32   Nanog     7.6350
## 13955  32C 7.2        32   Nanog     3.7950
## 13956  32C 7.3        32   Nanog     6.2300
## 13957  32C 7.4        32   Nanog     5.3350
## 13958  32C 7.5        32   Nanog     5.2550
## 13959  32C 7.6        32   Nanog     7.4650
## 13960  32C 7.8        32   Nanog    13.2950
## 13961  32C 8.1        32   Nanog     6.3100
## 13962  32C 8.2        32   Nanog     7.7250
## 13963  32C 8.4        32   Nanog     5.7300
## 13964  32C 8.5        32   Nanog     3.1750
## 13965  32C 8.6        32   Nanog     4.0800
## 13966  64C 1.1        64   Nanog     9.3700
## 13967  64C 1.2        64   Nanog    12.0050
## 13968  64C 1.3        64   Nanog     5.7350
## 13969  64C 1.4        64   Nanog    13.7700
## 13970  64C 1.5        64   Nanog    12.0300
## 13971  64C 1.6        64   Nanog     4.1300
## 13972  64C 1.7        64   Nanog    11.4500
## 13973  64C 1.8        64   Nanog     9.4650
## 13974  64C 1.9        64   Nanog    10.9550
## 13975 64C 1.10        64   Nanog     6.4200
## 13976 64C 1.11        64   Nanog     7.5950
## 13977 64C 1.12        64   Nanog    10.9550
## 13978 64C 1.13        64   Nanog    11.4575
## 13979 64C 1.14        64   Nanog    13.8800
## 13980 64C 1.15        64   Nanog    13.1450
## 13981 64C 1.16        64   Nanog    10.8500
## 13982 64C 1.17        64   Nanog     7.3700
## 13983 64C 1.18        64   Nanog    11.4350
## 13984 64C 1.19        64   Nanog    12.4900
## 13985 64C 1.20        64   Nanog     6.7950
## 13986 64C 1.21        64   Nanog     8.0400
## 13987 64C 1.22        64   Nanog     3.4525
## 13988 64C 1.23        64   Nanog     5.1950
## 13989 64C 1.24        64   Nanog    11.9350
## 13990 64C 1.25        64   Nanog     6.2150
## 13991 64C 1.26        64   Nanog     5.7450
## 13992 64C 1.27        64   Nanog    11.9300
## 13993 64C 1.28        64   Nanog    11.3350
## 13994 64C 1.29        64   Nanog     9.3250
## 13995 64C 1.30        64   Nanog    14.3750
## 13996 64C 1.31        64   Nanog    13.4050
## 13997 64C 1.32        64   Nanog    13.3050
## 13998 64C 1.33        64   Nanog     8.4700
## 13999 64C 1.34        64   Nanog     9.6750
## 14000 64C 1.35        64   Nanog    10.5100
## 14001 64C 1.36        64   Nanog     6.1150
## 14002 64C 1.37        64   Nanog     6.5150
## 14003 64C 1.38        64   Nanog    12.9000
## 14004 64C 1.39        64   Nanog    11.0950
## 14005 64C 1.40        64   Nanog     2.7250
## 14006 64C 1.41        64   Nanog    10.5950
## 14007 64C 1.42        64   Nanog     6.1850
## 14008 64C 1.43        64   Nanog     7.9500
## 14009 64C 1.44        64   Nanog     2.7550
## 14010 64C 1.45        64   Nanog     4.4150
## 14011 64C 1.46        64   Nanog     4.5050
## 14012 64C 1.47        64   Nanog    12.4600
## 14013 64C 1.48        64   Nanog    13.3750
## 14014  64C 2.1        64   Nanog    12.9000
## 14015  64C 2.2        64   Nanog    10.9600
## 14016  64C 2.3        64   Nanog     9.9950
## 14017  64C 2.4        64   Nanog     9.9450
## 14018  64C 2.5        64   Nanog     5.3400
## 14019  64C 2.6        64   Nanog     9.0100
## 14020  64C 2.7        64   Nanog     6.4850
## 14021  64C 2.8        64   Nanog    10.9100
## 14022  64C 2.9        64   Nanog    11.4550
## 14023 64C 2.10        64   Nanog    12.5450
## 14024 64C 2.11        64   Nanog    11.2150
## 14025 64C 2.12        64   Nanog    10.8350
## 14026 64C 2.13        64   Nanog     6.4450
## 14027 64C 2.14        64   Nanog     2.5000
## 14028 64C 2.15        64   Nanog     3.7500
## 14029 64C 2.16        64   Nanog     6.3850
## 14030 64C 2.17        64   Nanog    11.6150
## 14031 64C 2.18        64   Nanog    10.7750
## 14032 64C 2.19        64   Nanog    12.3950
## 14033 64C 2.20        64   Nanog    12.4750
## 14034 64C 2.21        64   Nanog    10.2300
## 14035 64C 2.22        64   Nanog     7.3300
## 14036 64C 2.23        64   Nanog    11.4450
## 14037 64C 2.24        64   Nanog     8.5850
## 14038 64C 2.25        64   Nanog     3.1500
## 14039  64C 3.1        64   Nanog    11.3000
## 14040  64C 3.2        64   Nanog     9.9750
## 14041  64C 3.3        64   Nanog     7.3200
## 14042  64C 3.4        64   Nanog    11.1200
## 14043  64C 3.5        64   Nanog     8.6150
## 14044  64C 3.6        64   Nanog    13.0500
## 14045  64C 3.7        64   Nanog    11.7000
## 14046  64C 3.8        64   Nanog     7.6850
## 14047  64C 4.1        64   Nanog     8.2200
## 14048 64C 4.1b        64   Nanog     5.1900
## 14049  64C 4.2        64   Nanog     5.1700
## 14050  64C 4.3        64   Nanog     9.3300
## 14051  64C 4.4        64   Nanog    10.8600
## 14052  64C 4.5        64   Nanog    13.1200
## 14053  64C 4.6        64   Nanog     9.0050
## 14054  64C 4.7        64   Nanog     7.9450
## 14055  64C 4.8        64   Nanog     7.2200
## 14056  64C 4.9        64   Nanog     9.3100
## 14057 64C 4.10        64   Nanog     6.2400
## 14058 64C 4.11        64   Nanog     5.8350
## 14059 64C 4.12        64   Nanog    12.0950
## 14060 64C 4.13        64   Nanog     7.7750
## 14061 64C 4.14        64   Nanog    14.1850
## 14062 64C 4.15        64   Nanog     7.5000
## 14063 64C 4.16        64   Nanog    11.6050
## 14064 64C 4.17        64   Nanog     5.6950
## 14065 64C 4.18        64   Nanog     9.3600
## 14066 64C 4.19        64   Nanog     9.2500
## 14067 64C 4.20        64   Nanog     8.1250
## 14068 64C 4.21        64   Nanog    11.3950
## 14069 64C 4.22        64   Nanog    10.0250
## 14070 64C 4.23        64   Nanog     9.4150
## 14071 64C 4.24        64   Nanog     4.9300
## 14072 64C 4.25        64   Nanog     5.5050
## 14073 64C 4.26        64   Nanog     6.9600
## 14074 64C 4.27        64   Nanog    11.2950
## 14075 64C 4.28        64   Nanog     9.9950
## 14076 64C 4.29        64   Nanog    10.5100
## 14077 64C 4.30        64   Nanog    14.3000
## 14078 64C 4.31        64   Nanog     9.8500
## 14079 64C 4.32        64   Nanog     3.3900
## 14080 64C 4.33        64   Nanog     6.6550
## 14081 64C 4.34        64   Nanog     5.5650
## 14082 64C 4.35        64   Nanog     5.2200
## 14083 64C 4.36        64   Nanog     5.2850
## 14084 64C 4.37        64   Nanog    10.3550
## 14085 64C 4.38        64   Nanog     5.6175
## 14086 64C 4.39        64   Nanog    12.8500
## 14087  64C 5.1        64   Nanog    13.1450
## 14088  64C 5.2        64   Nanog     8.0800
## 14089  64C 5.3        64   Nanog    11.8000
## 14090  64C 5.4        64   Nanog    11.4350
## 14091  64C 5.5        64   Nanog     7.8500
## 14092  64C 5.6        64   Nanog     7.6150
## 14093  64C 5.7        64   Nanog    11.7600
## 14094  64C 5.8        64   Nanog     2.9825
## 14095  64C 5.9        64   Nanog    10.2550
## 14096 64C 5.10        64   Nanog     8.2550
## 14097 64C 5.11        64   Nanog     7.4950
## 14098 64C 5.12        64   Nanog     8.7050
## 14099 64C 5.13        64   Nanog     8.5400
## 14100 64C 5.14        64   Nanog     4.8250
## 14101 64C 5.15        64   Nanog    12.5650
## 14102 64C 5.16        64   Nanog    14.3750
## 14103  64C 6.1        64   Nanog     8.6450
## 14104  64C 6.2        64   Nanog     3.5950
## 14105  64C 6.3        64   Nanog     1.7600
## 14106  64C 6.4        64   Nanog     1.1850
## 14107  64C 6.5        64   Nanog     1.4700
## 14108  64C 6.6        64   Nanog     1.1050
## 14109  64C 6.7        64   Nanog     7.5050
## 14110  64C 6.8        64   Nanog     2.0700
## 14111  64C 7.1        64   Nanog    13.7550
## 14112  64C 7.2        64   Nanog    12.7250
## 14113  64C 7.3        64   Nanog     4.9050
## 14114  64C 7.4        64   Nanog     8.9950
## 14115  64C 7.5        64   Nanog     7.6200
## 14116  64C 7.6        64   Nanog     9.8150
## 14117  64C 7.7        64   Nanog    10.8950
## 14118  64C 7.8        64   Nanog     2.9850
## 14119  64C 7.9        64   Nanog    11.3700
## 14120 64C 7.10        64   Nanog     8.7850
## 14121 64C 7.11        64   Nanog    10.4600
## 14122 64C 7.12        64   Nanog    12.7300
## 14123 64C 7.13        64   Nanog    10.3550
## 14124 64C 7.14        64   Nanog     9.8550
## 14125   2C 1.1         2   Pdgfa     9.2200
## 14126   2C 1.2         2   Pdgfa     6.2650
## 14127   2C 2.1         2   Pdgfa     2.6050
## 14128   2C 2.2         2   Pdgfa     5.3200
## 14129   2C 3.1         2   Pdgfa     8.2850
## 14130   2C 3.2         2   Pdgfa     5.6300
## 14131   2C 4.1         2   Pdgfa     5.7850
## 14132   2C 5.1         2   Pdgfa     8.1500
## 14133   2C 5.2         2   Pdgfa     6.3850
## 14134   2C 6.1         2   Pdgfa     5.8550
## 14135   2C 6.2         2   Pdgfa     3.4050
## 14136   2C 7.1         2   Pdgfa     1.6350
## 14137   2C 7.2         2   Pdgfa    15.2850
## 14138   2C 8.1         2   Pdgfa     7.8350
## 14139   2C 8.2         2   Pdgfa     5.6850
## 14140   2C 9.1         2   Pdgfa     9.0200
## 14141   2C 9.2         2   Pdgfa     5.9150
## 14142  2C 10.1         2   Pdgfa     6.9550
## 14143  2C 10.2         2   Pdgfa     7.6150
## 14144   4C 1.1         4   Pdgfa     3.4900
## 14145   4C 1.2         4   Pdgfa     6.8150
## 14146   4C 1.3         4   Pdgfa     6.1300
## 14147   4C 1.4         4   Pdgfa    13.4100
## 14148   4C 2.1         4   Pdgfa     4.9300
## 14149   4C 2.2         4   Pdgfa     6.8100
## 14150   4C 2.3         4   Pdgfa     7.0200
## 14151   4C 3.1         4   Pdgfa    13.2950
## 14152   4C 3.2         4   Pdgfa     6.1550
## 14153   4C 3.3         4   Pdgfa     8.2550
## 14154   4C 3.4         4   Pdgfa     3.9650
## 14155   4C 4.1         4   Pdgfa     5.6600
## 14156   4C 4.2         4   Pdgfa     6.0450
## 14157   4C 4.3         4   Pdgfa     9.4450
## 14158   4C 4.4         4   Pdgfa     3.1400
## 14159   4C 5.1         4   Pdgfa     8.4500
## 14160   4C 5.2         4   Pdgfa     6.3050
## 14161   4C 5.3         4   Pdgfa    11.6750
## 14162   4C 5.4         4   Pdgfa     4.5600
## 14163   4C 6.1         4   Pdgfa     7.8400
## 14164   4C 6.2         4   Pdgfa     7.8050
## 14165   4C 6.3         4   Pdgfa     9.1750
## 14166   4C 6.4         4   Pdgfa     5.9950
## 14167   8C 1.1         8   Pdgfa     7.8000
## 14168   8C 1.2         8   Pdgfa    13.7550
## 14169   8C 1.3         8   Pdgfa     4.2550
## 14170   8C 1.4         8   Pdgfa    11.2700
## 14171   8C 1.5         8   Pdgfa     5.7100
## 14172   8C 2.1         8   Pdgfa     2.9550
## 14173   8C 2.2         8   Pdgfa     5.7750
## 14174   8C 2.3         8   Pdgfa     6.2200
## 14175   8C 2.4         8   Pdgfa    13.3900
## 14176   8C 2.5         8   Pdgfa     5.8300
## 14177   8C 2.6         8   Pdgfa     4.2700
## 14178   8C 2.7         8   Pdgfa     4.7650
## 14179   8C 2.8         8   Pdgfa     5.0450
## 14180   8C 3.1         8   Pdgfa     6.3550
## 14181   8C 3.2         8   Pdgfa     6.9150
## 14182   8C 3.3         8   Pdgfa     5.3850
## 14183   8C 3.4         8   Pdgfa     8.9250
## 14184   8C 3.5         8   Pdgfa     4.3500
## 14185   8C 3.6         8   Pdgfa     5.9650
## 14186   8C 3.7         8   Pdgfa     5.4600
## 14187   8C 3.8         8   Pdgfa     1.7700
## 14188   8C 4.2         8   Pdgfa     4.2350
## 14189   8C 4.3         8   Pdgfa     3.9500
## 14190   8C 4.4         8   Pdgfa     4.0100
## 14191   8C 4.5         8   Pdgfa     7.8500
## 14192   8C 4.6         8   Pdgfa     6.0950
## 14193   8C 4.7         8   Pdgfa     3.8100
## 14194   8C 5.1         8   Pdgfa     1.9200
## 14195   8C 5.2         8   Pdgfa     0.9700
## 14196   8C 5.3         8   Pdgfa     2.1350
## 14197   8C 5.4         8   Pdgfa    -0.7450
## 14198   8C 5.5         8   Pdgfa     3.9700
## 14199   8C 5.6         8   Pdgfa     3.0900
## 14200   8C 5.7         8   Pdgfa     5.7950
## 14201   8C 5.8         8   Pdgfa     5.3525
## 14202   8C 6.1         8   Pdgfa     4.1500
## 14203   8C 6.2         8   Pdgfa     3.5400
## 14204   8C 6.3         8   Pdgfa     7.1350
## 14205   8C 6.4         8   Pdgfa     1.7450
## 14206   8C 6.5         8   Pdgfa     3.9750
## 14207   8C 6.6         8   Pdgfa     1.8900
## 14208   8C 6.7         8   Pdgfa     4.0600
## 14209   8C 6.8         8   Pdgfa     5.0150
## 14210  16C 1.1        16   Pdgfa     3.8500
## 14211  16C 1.2        16   Pdgfa     3.9400
## 14212  16C 1.3        16   Pdgfa     5.4450
## 14213  16C 1.4        16   Pdgfa    -1.5650
## 14214  16C 1.5        16   Pdgfa     0.3450
## 14215  16C 1.6        16   Pdgfa     2.6550
## 14216  16C 1.7        16   Pdgfa     1.3600
## 14217  16C 1.8        16   Pdgfa     3.3600
## 14218  16C 1.9        16   Pdgfa     3.2200
## 14219 16C 1.10        16   Pdgfa     4.2900
## 14220 16C 1.11        16   Pdgfa     3.0600
## 14221 16C 1.12        16   Pdgfa     1.7550
## 14222 16C 1.13        16   Pdgfa     1.5300
## 14223 16C 1.14        16   Pdgfa    -0.8550
## 14224 16C 1.15        16   Pdgfa     1.6650
## 14225 16C 1.16        16   Pdgfa    -0.2900
## 14226  16C 2.1        16   Pdgfa     5.1750
## 14227  16C 2.2        16   Pdgfa     4.5600
## 14228  16C 2.3        16   Pdgfa     3.8500
## 14229  16C 2.4        16   Pdgfa     5.8400
## 14230  16C 2.5        16   Pdgfa     3.4150
## 14231  16C 2.6        16   Pdgfa     1.4800
## 14232  16C 2.7        16   Pdgfa     3.9800
## 14233  16C 2.8        16   Pdgfa     2.2750
## 14234  16C 2.9        16   Pdgfa     2.8450
## 14235 16C 2.10        16   Pdgfa     4.5600
## 14236 16C 2.11        16   Pdgfa     4.9650
## 14237 16C 2.12        16   Pdgfa     3.9400
## 14238 16C 2.13        16   Pdgfa     4.6850
## 14239 16C 2.14        16   Pdgfa     5.1900
## 14240 16C 2.15        16   Pdgfa     2.6950
## 14241 16C 2.16        16   Pdgfa     1.9850
## 14242  16C 3.1        16   Pdgfa     0.4450
## 14243  16C 3.2        16   Pdgfa     2.2650
## 14244  16C 3.3        16   Pdgfa     5.9050
## 14245  16C 3.4        16   Pdgfa     4.9150
## 14246  16C 3.5        16   Pdgfa     3.0650
## 14247  16C 3.6        16   Pdgfa     5.1600
## 14248  16C 3.7        16   Pdgfa     3.2950
## 14249  16C 3.8        16   Pdgfa     2.8550
## 14250  16C 3.9        16   Pdgfa     3.5950
## 14251 16C 3.10        16   Pdgfa     4.0100
## 14252 16C 3.11        16   Pdgfa     3.8450
## 14253 16C 3.12        16   Pdgfa     3.5400
## 14254 16C 3.13        16   Pdgfa     4.2100
## 14255 16C 3.14        16   Pdgfa     2.6200
## 14256 16C 3.15        16   Pdgfa     4.9100
## 14257  16C 4.1        16   Pdgfa     5.9600
## 14258  16C 4.2        16   Pdgfa     4.3450
## 14259  16C 4.3        16   Pdgfa     1.5350
## 14260  16C 4.4        16   Pdgfa     2.2750
## 14261  16C 4.5        16   Pdgfa     2.4050
## 14262  16C 4.6        16   Pdgfa     4.8300
## 14263  16C 4.7        16   Pdgfa     4.0950
## 14264  16C 4.8        16   Pdgfa     3.4750
## 14265  16C 4.9        16   Pdgfa     0.9300
## 14266 16C 4.10        16   Pdgfa     4.0500
## 14267 16C 4.11        16   Pdgfa     1.6650
## 14268 16C 4.12        16   Pdgfa     1.6750
## 14269 16C 4.13        16   Pdgfa     2.3100
## 14270 16C 4.14        16   Pdgfa     1.9700
## 14271 16C 4.15        16   Pdgfa     3.6350
## 14272 16C 4.16        16   Pdgfa     4.0850
## 14273  16C 5.1        16   Pdgfa     2.9150
## 14274  16C 5.2        16   Pdgfa     3.7000
## 14275  16C 5.3        16   Pdgfa     4.6950
## 14276  16C 5.4        16   Pdgfa     1.7750
## 14277  16C 5.5        16   Pdgfa     1.7100
## 14278  16C 5.6        16   Pdgfa     2.8400
## 14279  16C 5.7        16   Pdgfa     0.9450
## 14280  16C 5.8        16   Pdgfa     5.3150
## 14281  16C 5.9        16   Pdgfa     4.3300
## 14282 16C 5.10        16   Pdgfa     4.2500
## 14283 16C 5.11        16   Pdgfa     3.5100
## 14284 16C 5.12        16   Pdgfa     4.1500
## 14285  32C 1.1        32   Pdgfa     1.8650
## 14286  32C 1.2        32   Pdgfa     3.3350
## 14287  32C 1.3        32   Pdgfa     2.4750
## 14288  32C 1.4        32   Pdgfa    -0.3250
## 14289  32C 1.5        32   Pdgfa     9.0050
## 14290  32C 1.6        32   Pdgfa     8.1350
## 14291  32C 1.7        32   Pdgfa     5.6800
## 14292  32C 1.8        32   Pdgfa     4.9750
## 14293  32C 1.9        32   Pdgfa     6.7600
## 14294 32C 1.10        32   Pdgfa     3.0900
## 14295 32C 1.11        32   Pdgfa     1.1850
## 14296 32C 1.12        32   Pdgfa     1.6200
## 14297 32C 1.13        32   Pdgfa     4.0900
## 14298 32C 1.14        32   Pdgfa     4.3800
## 14299 32C 1.15        32   Pdgfa     6.6750
## 14300 32C 1.16        32   Pdgfa     5.7400
## 14301 32C 1.17        32   Pdgfa     8.5100
## 14302 32C 1.18        32   Pdgfa     4.0900
## 14303 32C 1.19        32   Pdgfa     3.9550
## 14304 32C 1.20        32   Pdgfa     3.6350
## 14305 32C 1.21        32   Pdgfa     6.7800
## 14306  32C 2.1        32   Pdgfa     1.6900
## 14307  32C 2.2        32   Pdgfa     3.6850
## 14308  32C 2.3        32   Pdgfa     3.4725
## 14309  32C 2.4        32   Pdgfa     3.4100
## 14310  32C 2.5        32   Pdgfa     3.0700
## 14311  32C 2.6        32   Pdgfa     1.6750
## 14312  32C 2.7        32   Pdgfa    -0.6650
## 14313  32C 2.8        32   Pdgfa     5.3350
## 14314  32C 2.9        32   Pdgfa     0.3900
## 14315 32C 2.10        32   Pdgfa     2.8400
## 14316 32C 2.11        32   Pdgfa     4.1950
## 14317 32C 2.12        32   Pdgfa     2.4500
## 14318 32C 2.13        32   Pdgfa     5.0800
## 14319 32C 2.14        32   Pdgfa     3.0450
## 14320 32C 2.15        32   Pdgfa    -1.1750
## 14321 32C 2.16        32   Pdgfa    -0.8950
## 14322  32C 3.1        32   Pdgfa     2.3050
## 14323  32C 3.2        32   Pdgfa     0.0900
## 14324  32C 3.3        32   Pdgfa     1.8200
## 14325  32C 3.4        32   Pdgfa     2.5100
## 14326  32C 3.5        32   Pdgfa     2.5000
## 14327  32C 3.6        32   Pdgfa     2.9100
## 14328  32C 3.7        32   Pdgfa     1.1550
## 14329  32C 3.8        32   Pdgfa     1.5500
## 14330  32C 4.1        32   Pdgfa    -1.4650
## 14331  32C 4.2        32   Pdgfa     1.5250
## 14332  32C 4.3        32   Pdgfa     3.2200
## 14333  32C 4.4        32   Pdgfa     6.6950
## 14334  32C 4.5        32   Pdgfa     7.3300
## 14335  32C 4.6        32   Pdgfa     4.4800
## 14336  32C 4.7        32   Pdgfa     4.1500
## 14337  32C 4.8        32   Pdgfa     1.7950
## 14338 32C 4.10        32   Pdgfa     0.8300
## 14339 32C 4.11        32   Pdgfa     0.2500
## 14340 32C 4.12        32   Pdgfa     0.9750
## 14341 32C 4.13        32   Pdgfa     0.9050
## 14342 32C 4.14        32   Pdgfa     5.1900
## 14343 32C 4.15        32   Pdgfa     5.9250
## 14344 32C 4.16        32   Pdgfa     3.7900
## 14345 32C 4.17        32   Pdgfa     4.2450
## 14346 32C 4.18        32   Pdgfa     4.4700
## 14347 32C 4.19        32   Pdgfa     1.7550
## 14348 32C 4.20        32   Pdgfa     3.6850
## 14349 32C 4.21        32   Pdgfa     4.0550
## 14350 32C 4.22        32   Pdgfa     4.2750
## 14351 32C 4.23        32   Pdgfa     4.2950
## 14352 32C 4.24        32   Pdgfa     4.7250
## 14353  32C 5.1        32   Pdgfa     0.0750
## 14354  32C 5.2        32   Pdgfa     4.9700
## 14355  32C 5.3        32   Pdgfa     4.5750
## 14356  32C 5.4        32   Pdgfa     0.7650
## 14357  32C 5.5        32   Pdgfa     3.1350
## 14358  32C 5.6        32   Pdgfa     3.1300
## 14359  32C 5.7        32   Pdgfa     2.9350
## 14360  32C 5.8        32   Pdgfa     3.3400
## 14361  32C 5.9        32   Pdgfa     2.7500
## 14362 32C 5.10        32   Pdgfa     5.7800
## 14363 32C 5.11        32   Pdgfa     4.8500
## 14364 32C 5.12        32   Pdgfa     4.7400
## 14365 32C 5.13        32   Pdgfa     3.2750
## 14366 32C 5.14        32   Pdgfa     0.9550
## 14367 32C 5.15        32   Pdgfa     2.7050
## 14368 32C 5.16        32   Pdgfa     1.8350
## 14369 32C 5.17        32   Pdgfa     4.9600
## 14370 32C 5.18        32   Pdgfa     2.2050
## 14371 32C 5.19        32   Pdgfa     3.8650
## 14372 32C 5.20        32   Pdgfa     0.6100
## 14373 32C 5.21        32   Pdgfa     3.6800
## 14374 32C 5.22        32   Pdgfa     1.0950
## 14375 32C 5.23        32   Pdgfa     1.5850
## 14376  32C 6.1        32   Pdgfa     4.7700
## 14377  32C 6.2        32   Pdgfa     0.4950
## 14378  32C 6.3        32   Pdgfa     2.9550
## 14379  32C 6.4        32   Pdgfa     5.7100
## 14380  32C 6.6        32   Pdgfa     4.0650
## 14381  32C 6.7        32   Pdgfa     4.8150
## 14382  32C 7.1        32   Pdgfa     3.7600
## 14383  32C 7.2        32   Pdgfa     3.2600
## 14384  32C 7.3        32   Pdgfa     2.7250
## 14385  32C 7.4        32   Pdgfa     3.6100
## 14386  32C 7.5        32   Pdgfa     5.7400
## 14387  32C 7.6        32   Pdgfa     7.0800
## 14388  32C 7.8        32   Pdgfa     4.9650
## 14389  32C 8.1        32   Pdgfa     4.6200
## 14390  32C 8.2        32   Pdgfa     5.6150
## 14391  32C 8.4        32   Pdgfa     4.2750
## 14392  32C 8.5        32   Pdgfa     5.4100
## 14393  32C 8.6        32   Pdgfa     2.1700
## 14394  64C 1.1        64   Pdgfa     3.1650
## 14395  64C 1.2        64   Pdgfa     1.9050
## 14396  64C 1.3        64   Pdgfa     5.5150
## 14397  64C 1.4        64   Pdgfa    14.2150
## 14398  64C 1.5        64   Pdgfa     7.2300
## 14399  64C 1.6        64   Pdgfa     3.8650
## 14400  64C 1.7        64   Pdgfa     4.8400
## 14401  64C 1.8        64   Pdgfa     2.9600
## 14402  64C 1.9        64   Pdgfa     3.4350
## 14403 64C 1.10        64   Pdgfa     3.7500
## 14404 64C 1.11        64   Pdgfa     5.6800
## 14405 64C 1.12        64   Pdgfa     8.6700
## 14406 64C 1.13        64   Pdgfa     8.1550
## 14407 64C 1.14        64   Pdgfa     5.2300
## 14408 64C 1.15        64   Pdgfa     6.0500
## 14409 64C 1.16        64   Pdgfa     3.6300
## 14410 64C 1.17        64   Pdgfa     2.7250
## 14411 64C 1.18        64   Pdgfa     1.8250
## 14412 64C 1.19        64   Pdgfa     4.7300
## 14413 64C 1.20        64   Pdgfa     7.6700
## 14414 64C 1.21        64   Pdgfa     4.9550
## 14415 64C 1.22        64   Pdgfa     5.0425
## 14416 64C 1.23        64   Pdgfa     5.5200
## 14417 64C 1.24        64   Pdgfa     4.0800
## 14418 64C 1.25        64   Pdgfa     5.4350
## 14419 64C 1.26        64   Pdgfa     3.2450
## 14420 64C 1.27        64   Pdgfa     5.0750
## 14421 64C 1.28        64   Pdgfa     1.6600
## 14422 64C 1.29        64   Pdgfa     5.9400
## 14423 64C 1.30        64   Pdgfa    10.0850
## 14424 64C 1.31        64   Pdgfa     5.8100
## 14425 64C 1.32        64   Pdgfa     5.8200
## 14426 64C 1.33        64   Pdgfa     7.4150
## 14427 64C 1.34        64   Pdgfa     5.4850
## 14428 64C 1.35        64   Pdgfa     0.1550
## 14429 64C 1.36        64   Pdgfa     5.1850
## 14430 64C 1.37        64   Pdgfa     2.5100
## 14431 64C 1.38        64   Pdgfa     6.2600
## 14432 64C 1.39        64   Pdgfa     4.9000
## 14433 64C 1.40        64   Pdgfa     3.4100
## 14434 64C 1.41        64   Pdgfa    10.2100
## 14435 64C 1.42        64   Pdgfa     4.3850
## 14436 64C 1.43        64   Pdgfa     6.5200
## 14437 64C 1.44        64   Pdgfa     9.3650
## 14438 64C 1.45        64   Pdgfa     3.2050
## 14439 64C 1.46        64   Pdgfa     2.1600
## 14440 64C 1.47        64   Pdgfa     7.4050
## 14441 64C 1.48        64   Pdgfa     5.4900
## 14442  64C 2.1        64   Pdgfa     3.7800
## 14443  64C 2.2        64   Pdgfa     5.6200
## 14444  64C 2.3        64   Pdgfa     3.5950
## 14445  64C 2.4        64   Pdgfa     2.9700
## 14446  64C 2.5        64   Pdgfa     2.2700
## 14447  64C 2.6        64   Pdgfa     2.7650
## 14448  64C 2.7        64   Pdgfa     3.5250
## 14449  64C 2.8        64   Pdgfa     6.4100
## 14450  64C 2.9        64   Pdgfa     5.1250
## 14451 64C 2.10        64   Pdgfa     4.2500
## 14452 64C 2.11        64   Pdgfa     2.9350
## 14453 64C 2.12        64   Pdgfa     5.7400
## 14454 64C 2.13        64   Pdgfa     3.1550
## 14455 64C 2.14        64   Pdgfa     2.6750
## 14456 64C 2.15        64   Pdgfa     0.7850
## 14457 64C 2.16        64   Pdgfa     5.5650
## 14458 64C 2.17        64   Pdgfa     9.6450
## 14459 64C 2.18        64   Pdgfa     3.6550
## 14460 64C 2.19        64   Pdgfa     3.6250
## 14461 64C 2.20        64   Pdgfa     5.2900
## 14462 64C 2.21        64   Pdgfa     5.1950
## 14463 64C 2.22        64   Pdgfa     2.9150
## 14464 64C 2.23        64   Pdgfa     2.8950
## 14465 64C 2.24        64   Pdgfa     4.4900
## 14466 64C 2.25        64   Pdgfa     4.7850
## 14467  64C 3.1        64   Pdgfa     6.2400
## 14468  64C 3.2        64   Pdgfa     8.0200
## 14469  64C 3.3        64   Pdgfa     3.4700
## 14470  64C 3.4        64   Pdgfa     5.9400
## 14471  64C 3.5        64   Pdgfa     5.6600
## 14472  64C 3.6        64   Pdgfa     6.3450
## 14473  64C 3.7        64   Pdgfa     4.4650
## 14474  64C 3.8        64   Pdgfa     3.6250
## 14475  64C 4.1        64   Pdgfa    11.3550
## 14476 64C 4.1b        64   Pdgfa     6.0300
## 14477  64C 4.2        64   Pdgfa     4.1350
## 14478  64C 4.3        64   Pdgfa     8.9750
## 14479  64C 4.4        64   Pdgfa     3.8000
## 14480  64C 4.5        64   Pdgfa    13.8600
## 14481  64C 4.6        64   Pdgfa    11.5150
## 14482  64C 4.7        64   Pdgfa     3.3950
## 14483  64C 4.8        64   Pdgfa     7.2600
## 14484  64C 4.9        64   Pdgfa     2.9500
## 14485 64C 4.10        64   Pdgfa     7.2950
## 14486 64C 4.11        64   Pdgfa     6.1550
## 14487 64C 4.12        64   Pdgfa     3.5950
## 14488 64C 4.13        64   Pdgfa     5.6800
## 14489 64C 4.14        64   Pdgfa     6.3750
## 14490 64C 4.15        64   Pdgfa     4.3150
## 14491 64C 4.16        64   Pdgfa     4.2600
## 14492 64C 4.17        64   Pdgfa     2.8800
## 14493 64C 4.18        64   Pdgfa     2.4450
## 14494 64C 4.19        64   Pdgfa     6.8750
## 14495 64C 4.20        64   Pdgfa     5.3300
## 14496 64C 4.21        64   Pdgfa     5.1100
## 14497 64C 4.22        64   Pdgfa     5.8400
## 14498 64C 4.23        64   Pdgfa     6.2500
## 14499 64C 4.24        64   Pdgfa     4.6250
## 14500 64C 4.25        64   Pdgfa     2.4750
## 14501 64C 4.26        64   Pdgfa     4.2250
## 14502 64C 4.27        64   Pdgfa     2.3950
## 14503 64C 4.28        64   Pdgfa    13.5550
## 14504 64C 4.29        64   Pdgfa     7.5550
## 14505 64C 4.30        64   Pdgfa     8.5000
## 14506 64C 4.31        64   Pdgfa     4.8650
## 14507 64C 4.32        64   Pdgfa     4.1500
## 14508 64C 4.33        64   Pdgfa     4.7700
## 14509 64C 4.34        64   Pdgfa     2.5650
## 14510 64C 4.35        64   Pdgfa     3.9100
## 14511 64C 4.36        64   Pdgfa     3.6400
## 14512 64C 4.37        64   Pdgfa     6.2100
## 14513 64C 4.38        64   Pdgfa     4.9750
## 14514 64C 4.39        64   Pdgfa     8.3300
## 14515  64C 5.1        64   Pdgfa     5.6600
## 14516  64C 5.2        64   Pdgfa     3.4500
## 14517  64C 5.3        64   Pdgfa     0.9750
## 14518  64C 5.4        64   Pdgfa     1.2550
## 14519  64C 5.5        64   Pdgfa     4.3800
## 14520  64C 5.6        64   Pdgfa     7.7300
## 14521  64C 5.7        64   Pdgfa     4.4750
## 14522  64C 5.8        64   Pdgfa     5.4425
## 14523  64C 5.9        64   Pdgfa     6.3400
## 14524 64C 5.10        64   Pdgfa     2.2900
## 14525 64C 5.11        64   Pdgfa     3.2750
## 14526 64C 5.12        64   Pdgfa     0.8950
## 14527 64C 5.13        64   Pdgfa     2.6250
## 14528 64C 5.14        64   Pdgfa     0.2000
## 14529 64C 5.15        64   Pdgfa     7.6800
## 14530 64C 5.16        64   Pdgfa     6.7050
## 14531  64C 6.1        64   Pdgfa     4.8200
## 14532  64C 6.2        64   Pdgfa     3.6900
## 14533  64C 6.3        64   Pdgfa     4.1850
## 14534  64C 6.4        64   Pdgfa     0.1250
## 14535  64C 6.5        64   Pdgfa     1.7150
## 14536  64C 6.6        64   Pdgfa     2.8850
## 14537  64C 6.7        64   Pdgfa     2.2000
## 14538  64C 6.8        64   Pdgfa     4.8900
## 14539  64C 7.1        64   Pdgfa     5.9900
## 14540  64C 7.2        64   Pdgfa     6.9200
## 14541  64C 7.3        64   Pdgfa     4.8600
## 14542  64C 7.4        64   Pdgfa     4.6250
## 14543  64C 7.5        64   Pdgfa     7.4600
## 14544  64C 7.6        64   Pdgfa     2.4550
## 14545  64C 7.7        64   Pdgfa     6.1450
## 14546  64C 7.8        64   Pdgfa     9.3900
## 14547  64C 7.9        64   Pdgfa     8.1050
## 14548 64C 7.10        64   Pdgfa     6.5900
## 14549 64C 7.11        64   Pdgfa     5.7900
## 14550 64C 7.12        64   Pdgfa     8.8600
## 14551 64C 7.13        64   Pdgfa     8.3650
## 14552 64C 7.14        64   Pdgfa     6.0200
## 14553   2C 1.1         2  Pdgfra    10.5950
## 14554   2C 1.2         2  Pdgfra    11.2950
## 14555   2C 2.1         2  Pdgfra     5.4800
## 14556   2C 2.2         2  Pdgfra     8.8650
## 14557   2C 3.1         2  Pdgfra    13.9250
## 14558   2C 3.2         2  Pdgfra    11.6400
## 14559   2C 4.1         2  Pdgfra     8.6750
## 14560   2C 5.1         2  Pdgfra    10.5900
## 14561   2C 5.2         2  Pdgfra     6.5000
## 14562   2C 6.1         2  Pdgfra     8.5000
## 14563   2C 6.2         2  Pdgfra     7.8250
## 14564   2C 7.1         2  Pdgfra     6.9900
## 14565   2C 7.2         2  Pdgfra     9.3200
## 14566   2C 8.1         2  Pdgfra    13.3150
## 14567   2C 8.2         2  Pdgfra    10.0750
## 14568   2C 9.1         2  Pdgfra    10.0400
## 14569   2C 9.2         2  Pdgfra     9.3850
## 14570  2C 10.1         2  Pdgfra    11.9400
## 14571  2C 10.2         2  Pdgfra    11.1700
## 14572   4C 1.1         4  Pdgfra     8.3850
## 14573   4C 1.2         4  Pdgfra    12.2600
## 14574   4C 1.3         4  Pdgfra    10.2350
## 14575   4C 1.4         4  Pdgfra    13.5000
## 14576   4C 2.1         4  Pdgfra    10.3000
## 14577   4C 2.2         4  Pdgfra    11.0000
## 14578   4C 2.3         4  Pdgfra    13.0200
## 14579   4C 3.1         4  Pdgfra     9.5100
## 14580   4C 3.2         4  Pdgfra     7.4350
## 14581   4C 3.3         4  Pdgfra    11.5900
## 14582   4C 3.4         4  Pdgfra     6.9450
## 14583   4C 4.1         4  Pdgfra    15.0050
## 14584   4C 4.2         4  Pdgfra    13.3050
## 14585   4C 4.3         4  Pdgfra     8.3150
## 14586   4C 4.4         4  Pdgfra    13.4400
## 14587   4C 5.1         4  Pdgfra     6.3050
## 14588   4C 5.2         4  Pdgfra     6.7550
## 14589   4C 5.3         4  Pdgfra     9.5250
## 14590   4C 5.4         4  Pdgfra     7.8100
## 14591   4C 6.1         4  Pdgfra     5.9200
## 14592   4C 6.2         4  Pdgfra     8.9850
## 14593   4C 6.3         4  Pdgfra     9.4050
## 14594   4C 6.4         4  Pdgfra    11.7500
## 14595   8C 1.1         8  Pdgfra    10.4800
## 14596   8C 1.2         8  Pdgfra    12.2950
## 14597   8C 1.3         8  Pdgfra     7.3100
## 14598   8C 1.4         8  Pdgfra     5.2200
## 14599   8C 1.5         8  Pdgfra     7.2450
## 14600   8C 2.1         8  Pdgfra     5.9400
## 14601   8C 2.2         8  Pdgfra     8.3650
## 14602   8C 2.3         8  Pdgfra    10.5150
## 14603   8C 2.4         8  Pdgfra     8.4250
## 14604   8C 2.5         8  Pdgfra     9.5250
## 14605   8C 2.6         8  Pdgfra     6.6500
## 14606   8C 2.7         8  Pdgfra    12.4350
## 14607   8C 2.8         8  Pdgfra     8.4850
## 14608   8C 3.1         8  Pdgfra    13.9600
## 14609   8C 3.2         8  Pdgfra    12.4050
## 14610   8C 3.3         8  Pdgfra    14.1050
## 14611   8C 3.4         8  Pdgfra     8.7800
## 14612   8C 3.5         8  Pdgfra     8.3600
## 14613   8C 3.6         8  Pdgfra     8.9350
## 14614   8C 3.7         8  Pdgfra     8.4550
## 14615   8C 3.8         8  Pdgfra     5.2700
## 14616   8C 4.2         8  Pdgfra    11.5800
## 14617   8C 4.3         8  Pdgfra    11.6000
## 14618   8C 4.4         8  Pdgfra     8.9000
## 14619   8C 4.5         8  Pdgfra    13.2800
## 14620   8C 4.6         8  Pdgfra     8.9875
## 14621   8C 4.7         8  Pdgfra     7.7350
## 14622   8C 5.1         8  Pdgfra     4.3800
## 14623   8C 5.2         8  Pdgfra     5.9700
## 14624   8C 5.3         8  Pdgfra     6.6850
## 14625   8C 5.4         8  Pdgfra     1.6850
## 14626   8C 5.5         8  Pdgfra     6.1850
## 14627   8C 5.6         8  Pdgfra     7.2450
## 14628   8C 5.7         8  Pdgfra     8.2950
## 14629   8C 5.8         8  Pdgfra     5.8275
## 14630   8C 6.1         8  Pdgfra    14.2550
## 14631   8C 6.2         8  Pdgfra     8.1200
## 14632   8C 6.3         8  Pdgfra     7.7300
## 14633   8C 6.4         8  Pdgfra     4.4650
## 14634   8C 6.5         8  Pdgfra     7.2600
## 14635   8C 6.6         8  Pdgfra     4.6250
## 14636   8C 6.7         8  Pdgfra     6.7850
## 14637   8C 6.8         8  Pdgfra    11.5600
## 14638  16C 1.1        16  Pdgfra    12.7325
## 14639  16C 1.2        16  Pdgfra     8.6750
## 14640  16C 1.3        16  Pdgfra     4.4750
## 14641  16C 1.4        16  Pdgfra     8.1700
## 14642  16C 1.5        16  Pdgfra    10.4750
## 14643  16C 1.6        16  Pdgfra     8.3350
## 14644  16C 1.7        16  Pdgfra    11.6550
## 14645  16C 1.8        16  Pdgfra     9.6850
## 14646  16C 1.9        16  Pdgfra     7.8350
## 14647 16C 1.10        16  Pdgfra    12.5000
## 14648 16C 1.11        16  Pdgfra     9.7750
## 14649 16C 1.12        16  Pdgfra     9.0050
## 14650 16C 1.13        16  Pdgfra     9.0900
## 14651 16C 1.14        16  Pdgfra     9.5450
## 14652 16C 1.15        16  Pdgfra     4.5100
## 14653 16C 1.16        16  Pdgfra     4.6950
## 14654  16C 2.1        16  Pdgfra    13.4050
## 14655  16C 2.2        16  Pdgfra    12.0050
## 14656  16C 2.3        16  Pdgfra     8.7600
## 14657  16C 2.4        16  Pdgfra    15.0900
## 14658  16C 2.5        16  Pdgfra    10.5150
## 14659  16C 2.6        16  Pdgfra     2.8550
## 14660  16C 2.7        16  Pdgfra     6.2150
## 14661  16C 2.8        16  Pdgfra     8.2550
## 14662  16C 2.9        16  Pdgfra     5.4800
## 14663 16C 2.10        16  Pdgfra     7.8550
## 14664 16C 2.11        16  Pdgfra    12.6350
## 14665 16C 2.12        16  Pdgfra    10.9300
## 14666 16C 2.13        16  Pdgfra     6.1550
## 14667 16C 2.14        16  Pdgfra    13.9900
## 14668 16C 2.15        16  Pdgfra     7.7800
## 14669 16C 2.16        16  Pdgfra    11.9500
## 14670  16C 3.1        16  Pdgfra     9.0250
## 14671  16C 3.2        16  Pdgfra     8.6100
## 14672  16C 3.3        16  Pdgfra    14.3400
## 14673  16C 3.4        16  Pdgfra    10.2650
## 14674  16C 3.5        16  Pdgfra    12.6950
## 14675  16C 3.6        16  Pdgfra    10.0100
## 14676  16C 3.7        16  Pdgfra    13.4450
## 14677  16C 3.8        16  Pdgfra    11.9400
## 14678  16C 3.9        16  Pdgfra    11.1700
## 14679 16C 3.10        16  Pdgfra     9.5750
## 14680 16C 3.11        16  Pdgfra     8.5200
## 14681 16C 3.12        16  Pdgfra    13.5550
## 14682 16C 3.13        16  Pdgfra    11.5500
## 14683 16C 3.14        16  Pdgfra     9.3000
## 14684 16C 3.15        16  Pdgfra    10.7400
## 14685  16C 4.1        16  Pdgfra    13.0200
## 14686  16C 4.2        16  Pdgfra    12.1900
## 14687  16C 4.3        16  Pdgfra     9.2850
## 14688  16C 4.4        16  Pdgfra    12.3600
## 14689  16C 4.5        16  Pdgfra     8.3250
## 14690  16C 4.6        16  Pdgfra     9.1750
## 14691  16C 4.7        16  Pdgfra     9.9750
## 14692  16C 4.8        16  Pdgfra    13.6650
## 14693  16C 4.9        16  Pdgfra    13.1800
## 14694 16C 4.10        16  Pdgfra    11.3650
## 14695 16C 4.11        16  Pdgfra    11.7950
## 14696 16C 4.12        16  Pdgfra     6.6150
## 14697 16C 4.13        16  Pdgfra     8.5100
## 14698 16C 4.14        16  Pdgfra    11.3100
## 14699 16C 4.15        16  Pdgfra    13.4750
## 14700 16C 4.16        16  Pdgfra    10.5150
## 14701  16C 5.1        16  Pdgfra     9.1300
## 14702  16C 5.2        16  Pdgfra    13.7500
## 14703  16C 5.3        16  Pdgfra    11.4550
## 14704  16C 5.4        16  Pdgfra    11.7000
## 14705  16C 5.5        16  Pdgfra    11.3000
## 14706  16C 5.6        16  Pdgfra     6.2350
## 14707  16C 5.7        16  Pdgfra     9.6600
## 14708  16C 5.8        16  Pdgfra    14.3350
## 14709  16C 5.9        16  Pdgfra    13.7550
## 14710 16C 5.10        16  Pdgfra    12.5350
## 14711 16C 5.11        16  Pdgfra    13.8350
## 14712 16C 5.12        16  Pdgfra     8.6800
## 14713  32C 1.1        32  Pdgfra    12.4350
## 14714  32C 1.2        32  Pdgfra     2.4650
## 14715  32C 1.3        32  Pdgfra    13.9600
## 14716  32C 1.4        32  Pdgfra    12.4050
## 14717  32C 1.5        32  Pdgfra     6.6050
## 14718  32C 1.6        32  Pdgfra     3.4000
## 14719  32C 1.7        32  Pdgfra    13.4500
## 14720  32C 1.8        32  Pdgfra     4.7350
## 14721  32C 1.9        32  Pdgfra     6.6650
## 14722 32C 1.10        32  Pdgfra     1.4500
## 14723 32C 1.11        32  Pdgfra    11.5800
## 14724 32C 1.12        32  Pdgfra    11.6000
## 14725 32C 1.13        32  Pdgfra     3.0100
## 14726 32C 1.14        32  Pdgfra     8.1900
## 14727 32C 1.15        32  Pdgfra     4.1475
## 14728 32C 1.16        32  Pdgfra     4.1650
## 14729 32C 1.17        32  Pdgfra     1.8300
## 14730 32C 1.18        32  Pdgfra     7.4100
## 14731 32C 1.19        32  Pdgfra     1.1050
## 14732 32C 1.20        32  Pdgfra    -1.1950
## 14733 32C 1.21        32  Pdgfra     2.5750
## 14734  32C 2.1        32  Pdgfra     7.6650
## 14735  32C 2.2        32  Pdgfra    10.9050
## 14736  32C 2.3        32  Pdgfra    12.0575
## 14737  32C 2.4        32  Pdgfra     5.0550
## 14738  32C 2.5        32  Pdgfra     5.6800
## 14739  32C 2.6        32  Pdgfra    12.7000
## 14740  32C 2.7        32  Pdgfra     6.2550
## 14741  32C 2.8        32  Pdgfra     2.6600
## 14742  32C 2.9        32  Pdgfra    10.7950
## 14743 32C 2.10        32  Pdgfra    12.8150
## 14744 32C 2.11        32  Pdgfra     5.5600
## 14745 32C 2.12        32  Pdgfra     9.5825
## 14746 32C 2.13        32  Pdgfra     6.0350
## 14747 32C 2.14        32  Pdgfra     3.8950
## 14748 32C 2.15        32  Pdgfra     2.4700
## 14749 32C 2.16        32  Pdgfra     2.3850
## 14750  32C 3.1        32  Pdgfra    12.3650
## 14751  32C 3.2        32  Pdgfra    11.6550
## 14752  32C 3.3        32  Pdgfra    12.8950
## 14753  32C 3.4        32  Pdgfra    13.8650
## 14754  32C 3.5        32  Pdgfra    12.5000
## 14755  32C 3.6        32  Pdgfra     7.3250
## 14756  32C 3.7        32  Pdgfra     7.6750
## 14757  32C 3.8        32  Pdgfra     2.2100
## 14758  32C 4.1        32  Pdgfra     9.5850
## 14759  32C 4.2        32  Pdgfra    10.6800
## 14760  32C 4.3        32  Pdgfra     0.5150
## 14761  32C 4.4        32  Pdgfra     3.1350
## 14762  32C 4.5        32  Pdgfra     3.9550
## 14763  32C 4.6        32  Pdgfra     3.1100
## 14764  32C 4.7        32  Pdgfra    15.0900
## 14765  32C 4.8        32  Pdgfra    14.0750
## 14766 32C 4.10        32  Pdgfra     9.1850
## 14767 32C 4.11        32  Pdgfra     1.4350
## 14768 32C 4.12        32  Pdgfra    11.2950
## 14769 32C 4.13        32  Pdgfra    10.8700
## 14770 32C 4.14        32  Pdgfra     3.6250
## 14771 32C 4.15        32  Pdgfra     5.2150
## 14772 32C 4.16        32  Pdgfra     1.7800
## 14773 32C 4.17        32  Pdgfra    13.1350
## 14774 32C 4.18        32  Pdgfra    13.9900
## 14775 32C 4.19        32  Pdgfra    11.9200
## 14776 32C 4.20        32  Pdgfra     4.2100
## 14777 32C 4.21        32  Pdgfra     2.8450
## 14778 32C 4.22        32  Pdgfra     2.0200
## 14779 32C 4.23        32  Pdgfra    14.3400
## 14780 32C 4.24        32  Pdgfra     4.9850
## 14781  32C 5.1        32  Pdgfra    12.6950
## 14782  32C 5.2        32  Pdgfra    14.4300
## 14783  32C 5.3        32  Pdgfra     7.4250
## 14784  32C 5.4        32  Pdgfra    11.9400
## 14785  32C 5.5        32  Pdgfra     7.0900
## 14786  32C 5.6        32  Pdgfra    11.8150
## 14787  32C 5.7        32  Pdgfra    12.2600
## 14788  32C 5.8        32  Pdgfra     4.0850
## 14789  32C 5.9        32  Pdgfra    13.5000
## 14790 32C 5.10        32  Pdgfra     3.7100
## 14791 32C 5.11        32  Pdgfra    14.0200
## 14792 32C 5.12        32  Pdgfra     5.0500
## 14793 32C 5.13        32  Pdgfra     9.5300
## 14794 32C 5.14        32  Pdgfra    11.5150
## 14795 32C 5.15        32  Pdgfra    12.3600
## 14796 32C 5.16        32  Pdgfra    11.6750
## 14797 32C 5.17        32  Pdgfra    15.0050
## 14798 32C 5.18        32  Pdgfra    13.3050
## 14799 32C 5.19        32  Pdgfra     4.4550
## 14800 32C 5.20        32  Pdgfra    15.9200
## 14801 32C 5.21        32  Pdgfra    12.7750
## 14802 32C 5.22        32  Pdgfra    11.7950
## 14803 32C 5.23        32  Pdgfra     9.5250
## 14804  32C 6.1        32  Pdgfra     5.2650
## 14805  32C 6.2        32  Pdgfra    11.3100
## 14806  32C 6.3        32  Pdgfra    14.0950
## 14807  32C 6.4        32  Pdgfra     8.0450
## 14808  32C 6.6        32  Pdgfra    11.7500
## 14809  32C 6.7        32  Pdgfra    13.7500
## 14810  32C 7.1        32  Pdgfra    14.7950
## 14811  32C 7.2        32  Pdgfra     4.9150
## 14812  32C 7.3        32  Pdgfra    11.3000
## 14813  32C 7.4        32  Pdgfra    12.3250
## 14814  32C 7.5        32  Pdgfra     3.2900
## 14815  32C 7.6        32  Pdgfra     5.7050
## 14816  32C 7.8        32  Pdgfra    13.7550
## 14817  32C 8.1        32  Pdgfra    12.5350
## 14818  32C 8.2        32  Pdgfra    13.8350
## 14819  32C 8.4        32  Pdgfra    10.7300
## 14820  32C 8.5        32  Pdgfra     5.8900
## 14821  32C 8.6        32  Pdgfra    11.5450
## 14822  64C 1.1        64  Pdgfra     4.7900
## 14823  64C 1.2        64  Pdgfra    12.4050
## 14824  64C 1.3        64  Pdgfra    14.1050
## 14825  64C 1.4        64  Pdgfra     5.1600
## 14826  64C 1.5        64  Pdgfra     4.3000
## 14827  64C 1.6        64  Pdgfra    13.0850
## 14828  64C 1.7        64  Pdgfra     3.7650
## 14829  64C 1.8        64  Pdgfra    11.7900
## 14830  64C 1.9        64  Pdgfra     3.6000
## 14831 64C 1.10        64  Pdgfra    11.6000
## 14832 64C 1.11        64  Pdgfra     4.0700
## 14833 64C 1.12        64  Pdgfra    13.2800
## 14834 64C 1.13        64  Pdgfra     3.1575
## 14835 64C 1.14        64  Pdgfra    12.7250
## 14836 64C 1.15        64  Pdgfra    12.0700
## 14837 64C 1.16        64  Pdgfra    12.1200
## 14838 64C 1.17        64  Pdgfra    11.2750
## 14839 64C 1.18        64  Pdgfra     9.0650
## 14840 64C 1.19        64  Pdgfra    12.8250
## 14841 64C 1.20        64  Pdgfra    13.2950
## 14842 64C 1.21        64  Pdgfra     5.3750
## 14843 64C 1.22        64  Pdgfra     8.0575
## 14844 64C 1.23        64  Pdgfra    14.2550
## 14845 64C 1.24        64  Pdgfra    12.2000
## 14846 64C 1.25        64  Pdgfra    12.7000
## 14847 64C 1.26        64  Pdgfra     1.0950
## 14848 64C 1.27        64  Pdgfra    12.1400
## 14849 64C 1.28        64  Pdgfra    10.7950
## 14850 64C 1.29        64  Pdgfra    12.8150
## 14851 64C 1.30        64  Pdgfra    13.5600
## 14852 64C 1.31        64  Pdgfra    12.7325
## 14853 64C 1.32        64  Pdgfra    13.5650
## 14854 64C 1.33        64  Pdgfra    11.6150
## 14855 64C 1.34        64  Pdgfra    12.4200
## 14856 64C 1.35        64  Pdgfra    10.4750
## 14857 64C 1.36        64  Pdgfra    12.3650
## 14858 64C 1.37        64  Pdgfra    11.6550
## 14859 64C 1.38        64  Pdgfra    12.8950
## 14860 64C 1.39        64  Pdgfra    13.8650
## 14861 64C 1.40        64  Pdgfra    10.0500
## 14862 64C 1.41        64  Pdgfra     6.2350
## 14863 64C 1.42        64  Pdgfra     4.7950
## 14864 64C 1.43        64  Pdgfra     2.5700
## 14865 64C 1.44        64  Pdgfra     9.5850
## 14866 64C 1.45        64  Pdgfra    10.6800
## 14867 64C 1.46        64  Pdgfra    10.3450
## 14868 64C 1.47        64  Pdgfra    13.4050
## 14869 64C 1.48        64  Pdgfra    14.0950
## 14870  64C 2.1        64  Pdgfra    12.8700
## 14871  64C 2.2        64  Pdgfra    15.0900
## 14872  64C 2.3        64  Pdgfra    14.0750
## 14873  64C 2.4        64  Pdgfra     9.1850
## 14874  64C 2.5        64  Pdgfra     1.5650
## 14875  64C 2.6        64  Pdgfra    11.2950
## 14876  64C 2.7        64  Pdgfra     2.2200
## 14877  64C 2.8        64  Pdgfra     4.6250
## 14878  64C 2.9        64  Pdgfra    13.9250
## 14879 64C 2.10        64  Pdgfra    12.1200
## 14880 64C 2.11        64  Pdgfra    13.1350
## 14881 64C 2.12        64  Pdgfra    13.9900
## 14882 64C 2.13        64  Pdgfra    11.9200
## 14883 64C 2.14        64  Pdgfra    11.9500
## 14884 64C 2.15        64  Pdgfra    12.4350
## 14885 64C 2.16        64  Pdgfra     1.8700
## 14886 64C 2.17        64  Pdgfra     7.4800
## 14887 64C 2.18        64  Pdgfra    13.3150
## 14888 64C 2.19        64  Pdgfra    12.6950
## 14889 64C 2.20        64  Pdgfra    14.4300
## 14890 64C 2.21        64  Pdgfra    13.4450
## 14891 64C 2.22        64  Pdgfra    11.9400
## 14892 64C 2.23        64  Pdgfra    11.1700
## 14893 64C 2.24        64  Pdgfra    11.8150
## 14894 64C 2.25        64  Pdgfra    12.2600
## 14895  64C 3.1        64  Pdgfra    13.5550
## 14896  64C 3.2        64  Pdgfra    13.5000
## 14897  64C 3.3        64  Pdgfra    13.2900
## 14898  64C 3.4        64  Pdgfra    14.0200
## 14899  64C 3.5        64  Pdgfra     4.3100
## 14900  64C 3.6        64  Pdgfra    12.1900
## 14901  64C 3.7        64  Pdgfra    11.5150
## 14902  64C 3.8        64  Pdgfra    12.3600
## 14903  64C 4.1        64  Pdgfra     1.6350
## 14904 64C 4.1b        64  Pdgfra    12.5250
## 14905  64C 4.2        64  Pdgfra     8.8950
## 14906  64C 4.3        64  Pdgfra     4.3850
## 14907  64C 4.4        64  Pdgfra     5.7300
## 14908  64C 4.5        64  Pdgfra     3.1450
## 14909  64C 4.6        64  Pdgfra     2.7750
## 14910  64C 4.7        64  Pdgfra     9.5250
## 14911  64C 4.8        64  Pdgfra     3.6600
## 14912  64C 4.9        64  Pdgfra    11.3100
## 14913 64C 4.10        64  Pdgfra     5.1950
## 14914 64C 4.11        64  Pdgfra    10.3850
## 14915 64C 4.12        64  Pdgfra    11.7500
## 14916 64C 4.13        64  Pdgfra    13.7500
## 14917 64C 4.14        64  Pdgfra    14.7950
## 14918 64C 4.15        64  Pdgfra    11.7000
## 14919 64C 4.16        64  Pdgfra    11.3000
## 14920 64C 4.17        64  Pdgfra    12.3250
## 14921 64C 4.18        64  Pdgfra    11.6700
## 14922 64C 4.19        64  Pdgfra    14.3350
## 14923 64C 4.20        64  Pdgfra    13.7550
## 14924 64C 4.21        64  Pdgfra    12.5350
## 14925 64C 4.22        64  Pdgfra    13.8350
## 14926 64C 4.23        64  Pdgfra    12.9500
## 14927 64C 4.24        64  Pdgfra    12.4350
## 14928 64C 4.25        64  Pdgfra    11.5450
## 14929 64C 4.26        64  Pdgfra     4.0900
## 14930 64C 4.27        64  Pdgfra    12.4050
## 14931 64C 4.28        64  Pdgfra     4.0250
## 14932 64C 4.29        64  Pdgfra    13.9300
## 14933 64C 4.30        64  Pdgfra     3.0700
## 14934 64C 4.31        64  Pdgfra    13.0850
## 14935 64C 4.32        64  Pdgfra    12.2750
## 14936 64C 4.33        64  Pdgfra    11.7900
## 14937 64C 4.34        64  Pdgfra    11.5800
## 14938 64C 4.35        64  Pdgfra     0.3500
## 14939 64C 4.36        64  Pdgfra    12.6300
## 14940 64C 4.37        64  Pdgfra    13.2800
## 14941 64C 4.38        64  Pdgfra    12.2975
## 14942 64C 4.39        64  Pdgfra    12.7250
## 14943  64C 5.1        64  Pdgfra    12.0700
## 14944  64C 5.2        64  Pdgfra     2.7900
## 14945  64C 5.3        64  Pdgfra     2.6550
## 14946  64C 5.4        64  Pdgfra     9.0650
## 14947  64C 5.5        64  Pdgfra     3.1050
## 14948  64C 5.6        64  Pdgfra     4.3050
## 14949  64C 5.7        64  Pdgfra     4.5450
## 14950  64C 5.8        64  Pdgfra     9.2475
## 14951  64C 5.9        64  Pdgfra     4.5350
## 14952 64C 5.10        64  Pdgfra     2.9200
## 14953 64C 5.11        64  Pdgfra    12.7000
## 14954 64C 5.12        64  Pdgfra    10.3550
## 14955 64C 5.13        64  Pdgfra    12.1400
## 14956 64C 5.14        64  Pdgfra    10.7950
## 14957 64C 5.15        64  Pdgfra    12.8150
## 14958 64C 5.16        64  Pdgfra    13.5600
## 14959  64C 6.1        64  Pdgfra     2.6125
## 14960  64C 6.2        64  Pdgfra    13.5650
## 14961  64C 6.3        64  Pdgfra    11.6150
## 14962  64C 6.4        64  Pdgfra    12.4200
## 14963  64C 6.5        64  Pdgfra    10.4750
## 14964  64C 6.6        64  Pdgfra    12.3650
## 14965  64C 6.7        64  Pdgfra     1.4850
## 14966  64C 6.8        64  Pdgfra    12.8950
## 14967  64C 7.1        64  Pdgfra     6.6150
## 14968  64C 7.2        64  Pdgfra     2.7500
## 14969  64C 7.3        64  Pdgfra    14.3950
## 14970  64C 7.4        64  Pdgfra     3.7750
## 14971  64C 7.5        64  Pdgfra     1.2800
## 14972  64C 7.6        64  Pdgfra     0.0450
## 14973  64C 7.7        64  Pdgfra     1.3800
## 14974  64C 7.8        64  Pdgfra     6.4650
## 14975  64C 7.9        64  Pdgfra     4.4650
## 14976 64C 7.10        64  Pdgfra    11.8350
## 14977 64C 7.11        64  Pdgfra    12.8700
## 14978 64C 7.12        64  Pdgfra    15.0900
## 14979 64C 7.13        64  Pdgfra    14.0750
## 14980 64C 7.14        64  Pdgfra     9.1850
## 14981   2C 1.1         2  Pecam1     1.7700
## 14982   2C 1.2         2  Pecam1     2.3750
## 14983   2C 2.1         2  Pecam1     1.5800
## 14984   2C 2.2         2  Pecam1     4.2600
## 14985   2C 3.1         2  Pecam1     4.4250
## 14986   2C 3.2         2  Pecam1     2.5600
## 14987   2C 4.1         2  Pecam1     4.4650
## 14988   2C 5.1         2  Pecam1     5.3700
## 14989   2C 5.2         2  Pecam1     3.0400
## 14990   2C 6.1         2  Pecam1     2.7800
## 14991   2C 6.2         2  Pecam1     3.9750
## 14992   2C 7.1         2  Pecam1     1.8200
## 14993   2C 7.2         2  Pecam1     5.7800
## 14994   2C 8.1         2  Pecam1     5.2800
## 14995   2C 8.2         2  Pecam1     3.4650
## 14996   2C 9.1         2  Pecam1     6.5300
## 14997   2C 9.2         2  Pecam1     5.1000
## 14998  2C 10.1         2  Pecam1     5.7450
## 14999  2C 10.2         2  Pecam1     3.4500
## 15000   4C 1.1         4  Pecam1     5.8450
## 15001   4C 1.2         4  Pecam1    11.2000
## 15002   4C 1.3         4  Pecam1    11.7350
## 15003   4C 1.4         4  Pecam1     6.9500
## 15004   4C 2.1         4  Pecam1     4.3350
## 15005   4C 2.2         4  Pecam1     7.8300
## 15006   4C 2.3         4  Pecam1     7.6350
## 15007   4C 3.1         4  Pecam1     5.1750
## 15008   4C 3.2         4  Pecam1     5.0950
## 15009   4C 3.3         4  Pecam1     6.1550
## 15010   4C 3.4         4  Pecam1     6.7600
## 15011   4C 4.1         4  Pecam1     8.4300
## 15012   4C 4.2         4  Pecam1     8.1150
## 15013   4C 4.3         4  Pecam1     6.6350
## 15014   4C 4.4         4  Pecam1    10.2100
## 15015   4C 5.1         4  Pecam1     7.5750
## 15016   4C 5.2         4  Pecam1     5.5950
## 15017   4C 5.3         4  Pecam1     6.3200
## 15018   4C 5.4         4  Pecam1     5.2600
## 15019   4C 6.1         4  Pecam1     3.0000
## 15020   4C 6.2         4  Pecam1     7.2600
## 15021   4C 6.3         4  Pecam1     6.1950
## 15022   4C 6.4         4  Pecam1     3.6000
## 15023   8C 1.1         8  Pecam1     8.1100
## 15024   8C 1.2         8  Pecam1    11.4300
## 15025   8C 1.3         8  Pecam1     7.3400
## 15026   8C 1.4         8  Pecam1     3.9050
## 15027   8C 1.5         8  Pecam1     3.1700
## 15028   8C 2.1         8  Pecam1     7.1200
## 15029   8C 2.2         8  Pecam1    10.2350
## 15030   8C 2.3         8  Pecam1     7.3500
## 15031   8C 2.4         8  Pecam1    14.3950
## 15032   8C 2.5         8  Pecam1    13.2600
## 15033   8C 2.6         8  Pecam1     6.7600
## 15034   8C 2.7         8  Pecam1     7.0550
## 15035   8C 2.8         8  Pecam1    11.5450
## 15036   8C 3.1         8  Pecam1     3.5450
## 15037   8C 3.2         8  Pecam1     7.5100
## 15038   8C 3.3         8  Pecam1     8.0300
## 15039   8C 3.4         8  Pecam1     6.5450
## 15040   8C 3.5         8  Pecam1     7.3150
## 15041   8C 3.6         8  Pecam1     6.8600
## 15042   8C 3.7         8  Pecam1     5.5700
## 15043   8C 3.8         8  Pecam1     8.3650
## 15044   8C 4.2         8  Pecam1     8.3950
## 15045   8C 4.3         8  Pecam1     5.1950
## 15046   8C 4.4         8  Pecam1    11.3750
## 15047   8C 4.5         8  Pecam1     9.6300
## 15048   8C 4.6         8  Pecam1     8.6450
## 15049   8C 4.7         8  Pecam1     9.3500
## 15050   8C 5.1         8  Pecam1     4.8600
## 15051   8C 5.2         8  Pecam1     5.3050
## 15052   8C 5.3         8  Pecam1     4.2550
## 15053   8C 5.4         8  Pecam1     8.0550
## 15054   8C 5.5         8  Pecam1     6.3850
## 15055   8C 5.6         8  Pecam1     5.9550
## 15056   8C 5.7         8  Pecam1     7.7200
## 15057   8C 5.8         8  Pecam1     7.6550
## 15058   8C 6.1         8  Pecam1     7.2100
## 15059   8C 6.2         8  Pecam1     5.8700
## 15060   8C 6.3         8  Pecam1     6.5550
## 15061   8C 6.4         8  Pecam1     5.9250
## 15062   8C 6.5         8  Pecam1     7.6150
## 15063   8C 6.6         8  Pecam1     5.6150
## 15064   8C 6.7         8  Pecam1     6.3500
## 15065   8C 6.8         8  Pecam1     5.3950
## 15066  16C 1.1        16  Pecam1    10.0025
## 15067  16C 1.2        16  Pecam1     5.8200
## 15068  16C 1.3        16  Pecam1     8.8700
## 15069  16C 1.4        16  Pecam1     8.9000
## 15070  16C 1.5        16  Pecam1    10.3100
## 15071  16C 1.6        16  Pecam1     7.1350
## 15072  16C 1.7        16  Pecam1     6.8100
## 15073  16C 1.8        16  Pecam1     7.2800
## 15074  16C 1.9        16  Pecam1     8.0150
## 15075 16C 1.10        16  Pecam1     7.1025
## 15076 16C 1.11        16  Pecam1     9.4050
## 15077 16C 1.12        16  Pecam1    10.1950
## 15078 16C 1.13        16  Pecam1     7.7550
## 15079 16C 1.14        16  Pecam1     2.1550
## 15080 16C 1.15        16  Pecam1     5.3050
## 15081 16C 1.16        16  Pecam1     4.9450
## 15082  16C 2.1        16  Pecam1    12.9200
## 15083  16C 2.2        16  Pecam1     8.8600
## 15084  16C 2.3        16  Pecam1     7.5000
## 15085  16C 2.4        16  Pecam1    11.3450
## 15086  16C 2.5        16  Pecam1     9.8200
## 15087  16C 2.6        16  Pecam1     5.9350
## 15088  16C 2.7        16  Pecam1    11.2100
## 15089  16C 2.8        16  Pecam1     6.6950
## 15090  16C 2.9        16  Pecam1     6.8000
## 15091 16C 2.10        16  Pecam1     6.7200
## 15092 16C 2.11        16  Pecam1    13.5550
## 15093 16C 2.12        16  Pecam1    12.1600
## 15094 16C 2.13        16  Pecam1     8.4850
## 15095 16C 2.14        16  Pecam1     9.8100
## 15096 16C 2.15        16  Pecam1     8.0000
## 15097 16C 2.16        16  Pecam1     7.1800
## 15098  16C 3.1        16  Pecam1    12.1650
## 15099  16C 3.2        16  Pecam1    11.1400
## 15100  16C 3.3        16  Pecam1     9.3400
## 15101  16C 3.4        16  Pecam1    10.2600
## 15102  16C 3.5        16  Pecam1     7.7950
## 15103  16C 3.6        16  Pecam1     9.0500
## 15104  16C 3.7        16  Pecam1     9.2300
## 15105  16C 3.8        16  Pecam1     9.2050
## 15106  16C 3.9        16  Pecam1     6.7900
## 15107 16C 3.10        16  Pecam1     8.2150
## 15108 16C 3.11        16  Pecam1    11.2000
## 15109 16C 3.12        16  Pecam1     8.6550
## 15110 16C 3.13        16  Pecam1    10.2300
## 15111 16C 3.14        16  Pecam1     8.7250
## 15112 16C 3.15        16  Pecam1    11.3300
## 15113  16C 4.1        16  Pecam1     9.1750
## 15114  16C 4.2        16  Pecam1    12.3950
## 15115  16C 4.3        16  Pecam1    12.1750
## 15116  16C 4.4        16  Pecam1     8.6950
## 15117  16C 4.5        16  Pecam1     6.0200
## 15118  16C 4.6        16  Pecam1     7.1800
## 15119  16C 4.7        16  Pecam1     8.2850
## 15120  16C 4.8        16  Pecam1    13.2550
## 15121  16C 4.9        16  Pecam1     8.6700
## 15122 16C 4.10        16  Pecam1    10.1850
## 15123 16C 4.11        16  Pecam1    11.1850
## 15124 16C 4.12        16  Pecam1     7.0000
## 15125 16C 4.13        16  Pecam1     8.1400
## 15126 16C 4.14        16  Pecam1     5.7100
## 15127 16C 4.15        16  Pecam1     8.0200
## 15128 16C 4.16        16  Pecam1     8.4150
## 15129  16C 5.1        16  Pecam1     6.1500
## 15130  16C 5.2        16  Pecam1     6.7600
## 15131  16C 5.3        16  Pecam1     8.7300
## 15132  16C 5.4        16  Pecam1     6.1500
## 15133  16C 5.5        16  Pecam1     3.1750
## 15134  16C 5.6        16  Pecam1     5.0100
## 15135  16C 5.7        16  Pecam1     5.6400
## 15136  16C 5.8        16  Pecam1    14.2350
## 15137  16C 5.9        16  Pecam1     5.3800
## 15138 16C 5.10        16  Pecam1    10.3750
## 15139 16C 5.11        16  Pecam1     7.2500
## 15140 16C 5.12        16  Pecam1     5.2300
## 15141  32C 1.1        32  Pecam1    12.4350
## 15142  32C 1.2        32  Pecam1     3.5050
## 15143  32C 1.3        32  Pecam1    10.8650
## 15144  32C 1.4        32  Pecam1    10.9800
## 15145  32C 1.5        32  Pecam1     7.8200
## 15146  32C 1.6        32  Pecam1     6.1750
## 15147  32C 1.7        32  Pecam1    13.9450
## 15148  32C 1.8        32  Pecam1     4.7700
## 15149  32C 1.9        32  Pecam1     3.6600
## 15150 32C 1.10        32  Pecam1     3.7850
## 15151 32C 1.11        32  Pecam1     8.3950
## 15152 32C 1.12        32  Pecam1    11.5650
## 15153 32C 1.13        32  Pecam1     3.2150
## 15154 32C 1.14        32  Pecam1    13.6700
## 15155 32C 1.15        32  Pecam1     5.5450
## 15156 32C 1.16        32  Pecam1     7.9300
## 15157 32C 1.17        32  Pecam1     3.6800
## 15158 32C 1.18        32  Pecam1     4.7850
## 15159 32C 1.19        32  Pecam1     1.5550
## 15160 32C 1.20        32  Pecam1     4.1050
## 15161 32C 1.21        32  Pecam1     4.8750
## 15162  32C 2.1        32  Pecam1    13.3750
## 15163  32C 2.2        32  Pecam1     9.5300
## 15164  32C 2.3        32  Pecam1    13.1050
## 15165  32C 2.4        32  Pecam1     7.8700
## 15166  32C 2.5        32  Pecam1     5.1500
## 15167  32C 2.6        32  Pecam1    12.5750
## 15168  32C 2.7        32  Pecam1     4.8950
## 15169  32C 2.8        32  Pecam1     5.1150
## 15170  32C 2.9        32  Pecam1    10.7850
## 15171 32C 2.10        32  Pecam1    13.1800
## 15172 32C 2.11        32  Pecam1     6.2350
## 15173 32C 2.12        32  Pecam1    13.4025
## 15174 32C 2.13        32  Pecam1     8.2500
## 15175 32C 2.14        32  Pecam1     3.5500
## 15176 32C 2.15        32  Pecam1     4.7600
## 15177 32C 2.16        32  Pecam1     2.9900
## 15178  32C 3.1        32  Pecam1    11.8050
## 15179  32C 3.2        32  Pecam1    11.2000
## 15180  32C 3.3        32  Pecam1    13.3600
## 15181  32C 3.4        32  Pecam1    13.4950
## 15182  32C 3.5        32  Pecam1    12.0825
## 15183  32C 3.6        32  Pecam1     5.4550
## 15184  32C 3.7        32  Pecam1     4.7850
## 15185  32C 3.8        32  Pecam1     2.5450
## 15186  32C 4.1        32  Pecam1     9.4650
## 15187  32C 4.2        32  Pecam1    11.1450
## 15188  32C 4.3        32  Pecam1     1.5850
## 15189  32C 4.4        32  Pecam1     6.6100
## 15190  32C 4.5        32  Pecam1     6.8200
## 15191  32C 4.6        32  Pecam1     2.8400
## 15192  32C 4.7        32  Pecam1    13.8850
## 15193  32C 4.8        32  Pecam1    13.1300
## 15194 32C 4.10        32  Pecam1    11.7650
## 15195 32C 4.11        32  Pecam1     1.8800
## 15196 32C 4.12        32  Pecam1    11.3750
## 15197 32C 4.13        32  Pecam1    10.9100
## 15198 32C 4.14        32  Pecam1     4.1600
## 15199 32C 4.15        32  Pecam1     5.9650
## 15200 32C 4.16        32  Pecam1     6.0500
## 15201 32C 4.17        32  Pecam1    13.3950
## 15202 32C 4.18        32  Pecam1    14.0200
## 15203 32C 4.19        32  Pecam1     8.4900
## 15204 32C 4.20        32  Pecam1     2.9100
## 15205 32C 4.21        32  Pecam1     4.4850
## 15206 32C 4.22        32  Pecam1     1.8800
## 15207 32C 4.23        32  Pecam1    14.7500
## 15208 32C 4.24        32  Pecam1     5.9000
## 15209  32C 5.1        32  Pecam1    12.2850
## 15210  32C 5.2        32  Pecam1    10.6000
## 15211  32C 5.3        32  Pecam1     4.8100
## 15212  32C 5.4        32  Pecam1    12.5450
## 15213  32C 5.5        32  Pecam1     6.3400
## 15214  32C 5.6        32  Pecam1    11.8950
## 15215  32C 5.7        32  Pecam1    11.2000
## 15216  32C 5.8        32  Pecam1     6.8150
## 15217  32C 5.9        32  Pecam1    13.0900
## 15218 32C 5.10        32  Pecam1     6.2550
## 15219 32C 5.11        32  Pecam1    14.8100
## 15220 32C 5.12        32  Pecam1     7.9550
## 15221 32C 5.13        32  Pecam1    12.3950
## 15222 32C 5.14        32  Pecam1    12.1750
## 15223 32C 5.15        32  Pecam1    12.4150
## 15224 32C 5.16        32  Pecam1     7.7300
## 15225 32C 5.17        32  Pecam1    13.4600
## 15226 32C 5.18        32  Pecam1    12.9150
## 15227 32C 5.19        32  Pecam1     5.8750
## 15228 32C 5.20        32  Pecam1    14.6800
## 15229 32C 5.21        32  Pecam1    13.8750
## 15230 32C 5.22        32  Pecam1    11.1850
## 15231 32C 5.23        32  Pecam1    11.5100
## 15232  32C 6.1        32  Pecam1     3.8550
## 15233  32C 6.2        32  Pecam1     6.1350
## 15234  32C 6.3        32  Pecam1    14.3100
## 15235  32C 6.4        32  Pecam1     6.6650
## 15236  32C 6.6        32  Pecam1    11.6700
## 15237  32C 6.7        32  Pecam1    13.9200
## 15238  32C 7.1        32  Pecam1    14.7300
## 15239  32C 7.2        32  Pecam1     3.7150
## 15240  32C 7.3        32  Pecam1     9.6850
## 15241  32C 7.4        32  Pecam1    11.7400
## 15242  32C 7.5        32  Pecam1     5.0250
## 15243  32C 7.6        32  Pecam1     6.7050
## 15244  32C 7.8        32  Pecam1    12.9600
## 15245  32C 8.1        32  Pecam1    10.2150
## 15246  32C 8.2        32  Pecam1    13.2600
## 15247  32C 8.4        32  Pecam1    12.7300
## 15248  32C 8.5        32  Pecam1     5.4200
## 15249  32C 8.6        32  Pecam1     7.3050
## 15250  64C 1.1        64  Pecam1     6.2650
## 15251  64C 1.2        64  Pecam1    10.9800
## 15252  64C 1.3        64  Pecam1     6.0300
## 15253  64C 1.4        64  Pecam1    13.0850
## 15254  64C 1.5        64  Pecam1     8.8350
## 15255  64C 1.6        64  Pecam1     4.9000
## 15256  64C 1.7        64  Pecam1    12.1000
## 15257  64C 1.8        64  Pecam1    11.5150
## 15258  64C 1.9        64  Pecam1     5.4050
## 15259 64C 1.10        64  Pecam1    11.5650
## 15260 64C 1.11        64  Pecam1    11.3750
## 15261 64C 1.12        64  Pecam1    13.6700
## 15262 64C 1.13        64  Pecam1     9.1450
## 15263 64C 1.14        64  Pecam1    15.2400
## 15264 64C 1.15        64  Pecam1    11.7400
## 15265 64C 1.16        64  Pecam1    12.2750
## 15266 64C 1.17        64  Pecam1    10.6750
## 15267 64C 1.18        64  Pecam1    11.5250
## 15268 64C 1.19        64  Pecam1    12.4650
## 15269 64C 1.20        64  Pecam1    13.3750
## 15270 64C 1.21        64  Pecam1     6.5000
## 15271 64C 1.22        64  Pecam1     4.9450
## 15272 64C 1.23        64  Pecam1     6.1900
## 15273 64C 1.24        64  Pecam1    11.2600
## 15274 64C 1.25        64  Pecam1    12.5750
## 15275 64C 1.26        64  Pecam1     6.7350
## 15276 64C 1.27        64  Pecam1    11.9650
## 15277 64C 1.28        64  Pecam1    10.7850
## 15278 64C 1.29        64  Pecam1    13.1800
## 15279 64C 1.30        64  Pecam1    13.6550
## 15280 64C 1.31        64  Pecam1    13.4025
## 15281 64C 1.32        64  Pecam1    12.2800
## 15282 64C 1.33        64  Pecam1    13.0100
## 15283 64C 1.34        64  Pecam1    12.2600
## 15284 64C 1.35        64  Pecam1    10.3100
## 15285 64C 1.36        64  Pecam1    11.8050
## 15286 64C 1.37        64  Pecam1    11.2000
## 15287 64C 1.38        64  Pecam1    13.3600
## 15288 64C 1.39        64  Pecam1    13.4950
## 15289 64C 1.40        64  Pecam1     4.2025
## 15290 64C 1.41        64  Pecam1    14.2450
## 15291 64C 1.42        64  Pecam1     9.8150
## 15292 64C 1.43        64  Pecam1     6.6850
## 15293 64C 1.44        64  Pecam1     9.4650
## 15294 64C 1.45        64  Pecam1    11.1450
## 15295 64C 1.46        64  Pecam1     9.7950
## 15296 64C 1.47        64  Pecam1    12.9200
## 15297 64C 1.48        64  Pecam1    13.7500
## 15298  64C 2.1        64  Pecam1    11.4600
## 15299  64C 2.2        64  Pecam1    13.8850
## 15300  64C 2.3        64  Pecam1    13.1300
## 15301  64C 2.4        64  Pecam1    11.7650
## 15302  64C 2.5        64  Pecam1     5.4100
## 15303  64C 2.6        64  Pecam1    11.3750
## 15304  64C 2.7        64  Pecam1     4.5700
## 15305  64C 2.8        64  Pecam1     6.9800
## 15306  64C 2.9        64  Pecam1    13.5550
## 15307 64C 2.10        64  Pecam1    12.1600
## 15308 64C 2.11        64  Pecam1    13.3950
## 15309 64C 2.12        64  Pecam1    14.0200
## 15310 64C 2.13        64  Pecam1    11.8600
## 15311 64C 2.14        64  Pecam1    11.6300
## 15312 64C 2.15        64  Pecam1    12.1650
## 15313 64C 2.16        64  Pecam1     4.6900
## 15314 64C 2.17        64  Pecam1    14.7500
## 15315 64C 2.18        64  Pecam1    14.1500
## 15316 64C 2.19        64  Pecam1    12.2850
## 15317 64C 2.20        64  Pecam1     9.9300
## 15318 64C 2.21        64  Pecam1    13.3200
## 15319 64C 2.22        64  Pecam1    12.5450
## 15320 64C 2.23        64  Pecam1    11.2900
## 15321 64C 2.24        64  Pecam1    11.8950
## 15322 64C 2.25        64  Pecam1     6.7400
## 15323  64C 3.1        64  Pecam1    14.7350
## 15324  64C 3.2        64  Pecam1    13.0900
## 15325  64C 3.3        64  Pecam1    13.3850
## 15326  64C 3.4        64  Pecam1    14.8100
## 15327  64C 3.5        64  Pecam1    10.3050
## 15328  64C 3.6        64  Pecam1    12.3950
## 15329  64C 3.7        64  Pecam1    12.1750
## 15330  64C 3.8        64  Pecam1    12.4150
## 15331  64C 4.1        64  Pecam1    11.6200
## 15332 64C 4.1b        64  Pecam1     5.5200
## 15333  64C 4.2        64  Pecam1     5.2650
## 15334  64C 4.3        64  Pecam1     6.0050
## 15335  64C 4.4        64  Pecam1     8.0800
## 15336  64C 4.5        64  Pecam1     6.4650
## 15337  64C 4.6        64  Pecam1     6.9950
## 15338  64C 4.7        64  Pecam1    11.5100
## 15339  64C 4.8        64  Pecam1     5.7400
## 15340  64C 4.9        64  Pecam1    11.7000
## 15341 64C 4.10        64  Pecam1     6.2600
## 15342 64C 4.11        64  Pecam1     6.7850
## 15343 64C 4.12        64  Pecam1    11.6700
## 15344 64C 4.13        64  Pecam1    13.9200
## 15345 64C 4.14        64  Pecam1    14.7300
## 15346 64C 4.15        64  Pecam1    12.0900
## 15347 64C 4.16        64  Pecam1     9.6850
## 15348 64C 4.17        64  Pecam1    11.7400
## 15349 64C 4.18        64  Pecam1    12.6600
## 15350 64C 4.19        64  Pecam1    14.2350
## 15351 64C 4.20        64  Pecam1    12.9600
## 15352 64C 4.21        64  Pecam1    14.3950
## 15353 64C 4.22        64  Pecam1     9.3100
## 15354 64C 4.23        64  Pecam1    12.7300
## 15355 64C 4.24        64  Pecam1     7.5550
## 15356 64C 4.25        64  Pecam1    11.5450
## 15357 64C 4.26        64  Pecam1     5.9550
## 15358 64C 4.27        64  Pecam1    10.9800
## 15359 64C 4.28        64  Pecam1     8.8300
## 15360 64C 4.29        64  Pecam1    13.0850
## 15361 64C 4.30        64  Pecam1    13.9450
## 15362 64C 4.31        64  Pecam1    13.1700
## 15363 64C 4.32        64  Pecam1     4.1500
## 15364 64C 4.33        64  Pecam1    11.5150
## 15365 64C 4.34        64  Pecam1     8.3950
## 15366 64C 4.35        64  Pecam1     7.3450
## 15367 64C 4.36        64  Pecam1    11.3750
## 15368 64C 4.37        64  Pecam1    13.6700
## 15369 64C 4.38        64  Pecam1     8.6050
## 15370 64C 4.39        64  Pecam1    15.2400
## 15371  64C 5.1        64  Pecam1    11.7400
## 15372  64C 5.2        64  Pecam1    12.2750
## 15373  64C 5.3        64  Pecam1     7.9950
## 15374  64C 5.4        64  Pecam1    11.5250
## 15375  64C 5.5        64  Pecam1     8.4450
## 15376  64C 5.6        64  Pecam1    13.3750
## 15377  64C 5.7        64  Pecam1    13.6300
## 15378  64C 5.8        64  Pecam1     6.3550
## 15379  64C 5.9        64  Pecam1    13.8700
## 15380 64C 5.10        64  Pecam1    11.2600
## 15381 64C 5.11        64  Pecam1    12.5750
## 15382 64C 5.12        64  Pecam1    10.4450
## 15383 64C 5.13        64  Pecam1    11.9650
## 15384 64C 5.14        64  Pecam1    10.7850
## 15385 64C 5.15        64  Pecam1    13.1800
## 15386 64C 5.16        64  Pecam1    13.6550
## 15387  64C 6.1        64  Pecam1     8.8825
## 15388  64C 6.2        64  Pecam1     5.1600
## 15389  64C 6.3        64  Pecam1     5.8500
## 15390  64C 6.4        64  Pecam1     5.2600
## 15391  64C 6.5        64  Pecam1     3.1800
## 15392  64C 6.6        64  Pecam1     4.2150
## 15393  64C 6.7        64  Pecam1     6.9400
## 15394  64C 6.8        64  Pecam1     9.5200
## 15395  64C 7.1        64  Pecam1    13.4950
## 15396  64C 7.2        64  Pecam1    12.0825
## 15397  64C 7.3        64  Pecam1     6.7450
## 15398  64C 7.4        64  Pecam1     8.0250
## 15399  64C 7.5        64  Pecam1     7.2650
## 15400  64C 7.6        64  Pecam1     9.4650
## 15401  64C 7.7        64  Pecam1     5.5850
## 15402  64C 7.8        64  Pecam1     2.4850
## 15403  64C 7.9        64  Pecam1    12.9200
## 15404 64C 7.10        64  Pecam1    13.7500
## 15405 64C 7.11        64  Pecam1    11.4600
## 15406 64C 7.12        64  Pecam1    13.8850
## 15407 64C 7.13        64  Pecam1    13.1300
## 15408 64C 7.14        64  Pecam1    11.7650
## 15409   2C 1.1         2  Pou5f1     1.9100
## 15410   2C 1.2         2  Pou5f1     2.3400
## 15411   2C 2.1         2  Pou5f1     2.0350
## 15412   2C 2.2         2  Pou5f1     4.0650
## 15413   2C 3.1         2  Pou5f1     5.9550
## 15414   2C 3.2         2  Pou5f1     3.6650
## 15415   2C 4.1         2  Pou5f1     3.3950
## 15416   2C 5.1         2  Pou5f1     5.2100
## 15417   2C 5.2         2  Pou5f1     3.4800
## 15418   2C 6.1         2  Pou5f1     3.2350
## 15419   2C 6.2         2  Pou5f1     4.2850
## 15420   2C 7.1         2  Pou5f1     1.5600
## 15421   2C 7.2         2  Pou5f1     4.4600
## 15422   2C 8.1         2  Pou5f1     4.3650
## 15423   2C 8.2         2  Pou5f1     3.4200
## 15424   2C 9.1         2  Pou5f1     6.5000
## 15425   2C 9.2         2  Pou5f1     4.5450
## 15426  2C 10.1         2  Pou5f1     4.9000
## 15427  2C 10.2         2  Pou5f1     2.9900
## 15428   4C 1.1         4  Pou5f1     4.3450
## 15429   4C 1.2         4  Pou5f1     4.9400
## 15430   4C 1.3         4  Pou5f1     5.2300
## 15431   4C 1.4         4  Pou5f1     6.2100
## 15432   4C 2.1         4  Pou5f1     5.6100
## 15433   4C 2.2         4  Pou5f1     5.8000
## 15434   4C 2.3         4  Pou5f1     6.1000
## 15435   4C 3.1         4  Pou5f1     3.4250
## 15436   4C 3.2         4  Pou5f1     3.5750
## 15437   4C 3.3         4  Pou5f1     5.1800
## 15438   4C 3.4         4  Pou5f1     4.5000
## 15439   4C 4.1         4  Pou5f1     5.8100
## 15440   4C 4.2         4  Pou5f1     6.1950
## 15441   4C 4.3         4  Pou5f1     4.7150
## 15442   4C 4.4         4  Pou5f1     5.9050
## 15443   4C 5.1         4  Pou5f1     7.7550
## 15444   4C 5.2         4  Pou5f1     5.7600
## 15445   4C 5.3         4  Pou5f1     3.9550
## 15446   4C 5.4         4  Pou5f1     5.4250
## 15447   4C 6.1         4  Pou5f1     4.2400
## 15448   4C 6.2         4  Pou5f1     6.1400
## 15449   4C 6.3         4  Pou5f1     4.6250
## 15450   4C 6.4         4  Pou5f1     4.7650
## 15451   8C 1.1         8  Pou5f1     6.6250
## 15452   8C 1.2         8  Pou5f1     5.9550
## 15453   8C 1.3         8  Pou5f1     2.4900
## 15454   8C 1.4         8  Pou5f1    -1.4050
## 15455   8C 1.5         8  Pou5f1     3.5700
## 15456   8C 2.1         8  Pou5f1     1.8850
## 15457   8C 2.2         8  Pou5f1     5.1950
## 15458   8C 2.3         8  Pou5f1     3.6200
## 15459   8C 2.4         8  Pou5f1    10.7600
## 15460   8C 2.5         8  Pou5f1     4.2000
## 15461   8C 2.6         8  Pou5f1     2.9000
## 15462   8C 2.7         8  Pou5f1     1.8750
## 15463   8C 2.8         8  Pou5f1     1.9450
## 15464   8C 3.1         8  Pou5f1     3.6100
## 15465   8C 3.2         8  Pou5f1     6.7750
## 15466   8C 3.3         8  Pou5f1     7.0650
## 15467   8C 3.4         8  Pou5f1     7.0975
## 15468   8C 3.5         8  Pou5f1    -2.0200
## 15469   8C 3.6         8  Pou5f1     0.7650
## 15470   8C 3.7         8  Pou5f1     5.3900
## 15471   8C 3.8         8  Pou5f1     2.9300
## 15472   8C 4.2         8  Pou5f1     6.2150
## 15473   8C 4.3         8  Pou5f1     3.9600
## 15474   8C 4.4         8  Pou5f1     4.0050
## 15475   8C 4.5         8  Pou5f1     6.5200
## 15476   8C 4.6         8  Pou5f1     3.3825
## 15477   8C 4.7         8  Pou5f1     5.6350
## 15478   8C 5.1         8  Pou5f1     2.9650
## 15479   8C 5.2         8  Pou5f1     4.6150
## 15480   8C 5.3         8  Pou5f1     1.8750
## 15481   8C 5.4         8  Pou5f1     3.1900
## 15482   8C 5.5         8  Pou5f1     2.7750
## 15483   8C 5.6         8  Pou5f1     3.3950
## 15484   8C 5.7         8  Pou5f1     6.3350
## 15485   8C 5.8         8  Pou5f1     5.5950
## 15486   8C 6.1         8  Pou5f1     4.7950
## 15487   8C 6.2         8  Pou5f1     4.4300
## 15488   8C 6.3         8  Pou5f1     2.0450
## 15489   8C 6.4         8  Pou5f1     1.9300
## 15490   8C 6.5         8  Pou5f1     2.7550
## 15491   8C 6.6         8  Pou5f1     0.8850
## 15492   8C 6.7         8  Pou5f1     4.7300
## 15493   8C 6.8         8  Pou5f1     6.4650
## 15494  16C 1.1        16  Pou5f1     5.1550
## 15495  16C 1.2        16  Pou5f1     3.3450
## 15496  16C 1.3        16  Pou5f1     1.2850
## 15497  16C 1.4        16  Pou5f1     0.6100
## 15498  16C 1.5        16  Pou5f1    -0.7050
## 15499  16C 1.6        16  Pou5f1    -0.2250
## 15500  16C 1.7        16  Pou5f1    -0.8550
## 15501  16C 1.8        16  Pou5f1     1.3000
## 15502  16C 1.9        16  Pou5f1     2.1850
## 15503 16C 1.10        16  Pou5f1     1.6700
## 15504 16C 1.11        16  Pou5f1     3.6000
## 15505 16C 1.12        16  Pou5f1     2.3150
## 15506 16C 1.13        16  Pou5f1     1.7650
## 15507 16C 1.14        16  Pou5f1    -1.8600
## 15508 16C 1.15        16  Pou5f1     0.2900
## 15509 16C 1.16        16  Pou5f1    -0.0550
## 15510  16C 2.1        16  Pou5f1     5.5600
## 15511  16C 2.2        16  Pou5f1     3.4250
## 15512  16C 2.3        16  Pou5f1     2.6650
## 15513  16C 2.4        16  Pou5f1     3.7050
## 15514  16C 2.5        16  Pou5f1     3.2650
## 15515  16C 2.6        16  Pou5f1    -0.8450
## 15516  16C 2.7        16  Pou5f1     0.4400
## 15517  16C 2.8        16  Pou5f1     0.5500
## 15518  16C 2.9        16  Pou5f1     0.6450
## 15519 16C 2.10        16  Pou5f1     2.3150
## 15520 16C 2.11        16  Pou5f1     4.1550
## 15521 16C 2.12        16  Pou5f1     1.6350
## 15522 16C 2.13        16  Pou5f1     1.7150
## 15523 16C 2.14        16  Pou5f1     3.0800
## 15524 16C 2.15        16  Pou5f1     1.4200
## 15525 16C 2.16        16  Pou5f1     0.7250
## 15526  16C 3.1        16  Pou5f1     2.2550
## 15527  16C 3.2        16  Pou5f1     1.2000
## 15528  16C 3.3        16  Pou5f1     4.3000
## 15529  16C 3.4        16  Pou5f1     3.2950
## 15530  16C 3.5        16  Pou5f1     2.3000
## 15531  16C 3.6        16  Pou5f1     4.0200
## 15532  16C 3.7        16  Pou5f1     2.7450
## 15533  16C 3.8        16  Pou5f1     3.6000
## 15534  16C 3.9        16  Pou5f1     3.4600
## 15535 16C 3.10        16  Pou5f1     2.4150
## 15536 16C 3.11        16  Pou5f1     2.2900
## 15537 16C 3.12        16  Pou5f1     3.7600
## 15538 16C 3.13        16  Pou5f1     4.4500
## 15539 16C 3.14        16  Pou5f1     3.4600
## 15540 16C 3.15        16  Pou5f1     2.2300
## 15541  16C 4.1        16  Pou5f1     3.3400
## 15542  16C 4.2        16  Pou5f1     1.1050
## 15543  16C 4.3        16  Pou5f1     0.5450
## 15544  16C 4.4        16  Pou5f1     1.5900
## 15545  16C 4.5        16  Pou5f1     1.0600
## 15546  16C 4.6        16  Pou5f1     2.6700
## 15547  16C 4.7        16  Pou5f1     3.1750
## 15548  16C 4.8        16  Pou5f1     2.5350
## 15549  16C 4.9        16  Pou5f1     4.5350
## 15550 16C 4.10        16  Pou5f1     3.3950
## 15551 16C 4.11        16  Pou5f1     0.8900
## 15552 16C 4.12        16  Pou5f1     0.6850
## 15553 16C 4.13        16  Pou5f1     0.9550
## 15554 16C 4.14        16  Pou5f1     0.6200
## 15555 16C 4.15        16  Pou5f1     3.4500
## 15556 16C 4.16        16  Pou5f1     2.4350
## 15557  16C 5.1        16  Pou5f1     3.4150
## 15558  16C 5.2        16  Pou5f1     2.5050
## 15559  16C 5.3        16  Pou5f1     3.9350
## 15560  16C 5.4        16  Pou5f1     1.1100
## 15561  16C 5.5        16  Pou5f1    -2.7150
## 15562  16C 5.6        16  Pou5f1     2.1600
## 15563  16C 5.7        16  Pou5f1     1.2750
## 15564  16C 5.8        16  Pou5f1     4.1950
## 15565  16C 5.9        16  Pou5f1     3.5700
## 15566 16C 5.10        16  Pou5f1     3.9200
## 15567 16C 5.11        16  Pou5f1     2.9300
## 15568 16C 5.12        16  Pou5f1     2.5500
## 15569  32C 1.1        32  Pou5f1     3.6950
## 15570  32C 1.2        32  Pou5f1     0.8550
## 15571  32C 1.3        32  Pou5f1     3.2100
## 15572  32C 1.4        32  Pou5f1     3.4050
## 15573  32C 1.5        32  Pou5f1     4.2450
## 15574  32C 1.6        32  Pou5f1     4.7175
## 15575  32C 1.7        32  Pou5f1     5.6700
## 15576  32C 1.8        32  Pou5f1     2.7050
## 15577  32C 1.9        32  Pou5f1     2.4100
## 15578 32C 1.10        32  Pou5f1     1.9900
## 15579 32C 1.11        32  Pou5f1     4.5950
## 15580 32C 1.12        32  Pou5f1     4.3000
## 15581 32C 1.13        32  Pou5f1     3.9750
## 15582 32C 1.14        32  Pou5f1     4.9000
## 15583 32C 1.15        32  Pou5f1     3.0125
## 15584 32C 1.16        32  Pou5f1     5.7350
## 15585 32C 1.17        32  Pou5f1     2.7850
## 15586 32C 1.18        32  Pou5f1     3.6350
## 15587 32C 1.19        32  Pou5f1     1.1450
## 15588 32C 1.20        32  Pou5f1     2.8200
## 15589 32C 1.21        32  Pou5f1     2.2150
## 15590  32C 2.1        32  Pou5f1     3.8050
## 15591  32C 2.2        32  Pou5f1     6.4850
## 15592  32C 2.3        32  Pou5f1     5.6750
## 15593  32C 2.4        32  Pou5f1     4.2850
## 15594  32C 2.5        32  Pou5f1     3.1800
## 15595  32C 2.6        32  Pou5f1     2.8950
## 15596  32C 2.7        32  Pou5f1     1.4800
## 15597  32C 2.8        32  Pou5f1     2.9050
## 15598  32C 2.9        32  Pou5f1     1.7550
## 15599 32C 2.10        32  Pou5f1     4.7100
## 15600 32C 2.11        32  Pou5f1     5.1750
## 15601 32C 2.12        32  Pou5f1     4.8850
## 15602 32C 2.13        32  Pou5f1     5.0450
## 15603 32C 2.14        32  Pou5f1     2.4450
## 15604 32C 2.15        32  Pou5f1     2.7500
## 15605 32C 2.16        32  Pou5f1     0.8950
## 15606  32C 3.1        32  Pou5f1     2.7250
## 15607  32C 3.2        32  Pou5f1     1.0050
## 15608  32C 3.3        32  Pou5f1     3.5100
## 15609  32C 3.4        32  Pou5f1     5.0350
## 15610  32C 3.5        32  Pou5f1     6.6000
## 15611  32C 3.6        32  Pou5f1     6.1600
## 15612  32C 3.7        32  Pou5f1     5.0450
## 15613  32C 3.8        32  Pou5f1     3.9250
## 15614  32C 4.1        32  Pou5f1    -0.4300
## 15615  32C 4.2        32  Pou5f1     2.0800
## 15616  32C 4.3        32  Pou5f1     0.8150
## 15617  32C 4.4        32  Pou5f1     4.1100
## 15618  32C 4.5        32  Pou5f1     3.9050
## 15619  32C 4.6        32  Pou5f1     2.0750
## 15620  32C 4.7        32  Pou5f1     4.8050
## 15621  32C 4.8        32  Pou5f1     5.0050
## 15622 32C 4.10        32  Pou5f1     1.3950
## 15623 32C 4.11        32  Pou5f1     0.5100
## 15624 32C 4.12        32  Pou5f1     1.8900
## 15625 32C 4.13        32  Pou5f1     3.2250
## 15626 32C 4.14        32  Pou5f1     4.0650
## 15627 32C 4.15        32  Pou5f1     4.7650
## 15628 32C 4.16        32  Pou5f1     2.5150
## 15629 32C 4.17        32  Pou5f1     4.9750
## 15630 32C 4.18        32  Pou5f1     6.5800
## 15631 32C 4.19        32  Pou5f1     2.8600
## 15632 32C 4.20        32  Pou5f1     1.8350
## 15633 32C 4.21        32  Pou5f1     2.9050
## 15634 32C 4.22        32  Pou5f1     0.3400
## 15635 32C 4.23        32  Pou5f1     6.5200
## 15636 32C 4.24        32  Pou5f1     3.6450
## 15637  32C 5.1        32  Pou5f1     3.5200
## 15638  32C 5.2        32  Pou5f1     6.0600
## 15639  32C 5.3        32  Pou5f1     3.5050
## 15640  32C 5.4        32  Pou5f1     3.8100
## 15641  32C 5.5        32  Pou5f1     2.4100
## 15642  32C 5.6        32  Pou5f1     4.5750
## 15643  32C 5.7        32  Pou5f1     3.1200
## 15644  32C 5.8        32  Pou5f1     3.8100
## 15645  32C 5.9        32  Pou5f1     6.1200
## 15646 32C 5.10        32  Pou5f1     6.9300
## 15647 32C 5.11        32  Pou5f1     5.0500
## 15648 32C 5.12        32  Pou5f1     4.4900
## 15649 32C 5.13        32  Pou5f1     3.8250
## 15650 32C 5.14        32  Pou5f1     3.1550
## 15651 32C 5.15        32  Pou5f1     4.3100
## 15652 32C 5.16        32  Pou5f1     4.6200
## 15653 32C 5.17        32  Pou5f1     6.6100
## 15654 32C 5.18        32  Pou5f1     6.7050
## 15655 32C 5.19        32  Pou5f1     4.4050
## 15656 32C 5.20        32  Pou5f1     6.7850
## 15657 32C 5.21        32  Pou5f1     6.6550
## 15658 32C 5.22        32  Pou5f1     4.4900
## 15659 32C 5.23        32  Pou5f1     3.9250
## 15660  32C 6.1        32  Pou5f1     0.7750
## 15661  32C 6.2        32  Pou5f1     0.7300
## 15662  32C 6.3        32  Pou5f1     5.3550
## 15663  32C 6.4        32  Pou5f1     4.4250
## 15664  32C 6.6        32  Pou5f1     4.4350
## 15665  32C 6.7        32  Pou5f1     4.4600
## 15666  32C 7.1        32  Pou5f1     5.4150
## 15667  32C 7.2        32  Pou5f1     2.0550
## 15668  32C 7.3        32  Pou5f1     0.2900
## 15669  32C 7.4        32  Pou5f1     4.1900
## 15670  32C 7.5        32  Pou5f1     2.5300
## 15671  32C 7.6        32  Pou5f1     5.5200
## 15672  32C 7.8        32  Pou5f1     5.1850
## 15673  32C 8.1        32  Pou5f1     6.0350
## 15674  32C 8.2        32  Pou5f1     6.1900
## 15675  32C 8.4        32  Pou5f1     3.9100
## 15676  32C 8.5        32  Pou5f1     3.9500
## 15677  32C 8.6        32  Pou5f1     2.0900
## 15678  64C 1.1        64  Pou5f1     2.8300
## 15679  64C 1.2        64  Pou5f1     7.9950
## 15680  64C 1.3        64  Pou5f1     5.1650
## 15681  64C 1.4        64  Pou5f1     6.2575
## 15682  64C 1.5        64  Pou5f1     4.3200
## 15683  64C 1.6        64  Pou5f1     3.1950
## 15684  64C 1.7        64  Pou5f1     3.5000
## 15685  64C 1.8        64  Pou5f1     7.6200
## 15686  64C 1.9        64  Pou5f1     2.0750
## 15687 64C 1.10        64  Pou5f1     8.4800
## 15688 64C 1.11        64  Pou5f1     4.5850
## 15689 64C 1.12        64  Pou5f1     7.7000
## 15690 64C 1.13        64  Pou5f1     2.7825
## 15691 64C 1.14        64  Pou5f1    14.6150
## 15692 64C 1.15        64  Pou5f1     6.7450
## 15693 64C 1.16        64  Pou5f1     9.4650
## 15694 64C 1.17        64  Pou5f1     4.3950
## 15695 64C 1.18        64  Pou5f1     5.6500
## 15696 64C 1.19        64  Pou5f1     7.8050
## 15697 64C 1.20        64  Pou5f1     6.6250
## 15698 64C 1.21        64  Pou5f1     6.0150
## 15699 64C 1.22        64  Pou5f1     5.4550
## 15700 64C 1.23        64  Pou5f1     5.0250
## 15701 64C 1.24        64  Pou5f1     7.1400
## 15702 64C 1.25        64  Pou5f1     3.7850
## 15703 64C 1.26        64  Pou5f1     2.9100
## 15704 64C 1.27        64  Pou5f1     7.1650
## 15705 64C 1.28        64  Pou5f1    10.1350
## 15706 64C 1.29        64  Pou5f1     8.4300
## 15707 64C 1.30        64  Pou5f1    13.7550
## 15708 64C 1.31        64  Pou5f1     7.5050
## 15709 64C 1.32        64  Pou5f1     9.8350
## 15710 64C 1.33        64  Pou5f1     6.9350
## 15711 64C 1.34        64  Pou5f1     8.1800
## 15712 64C 1.35        64  Pou5f1     5.5250
## 15713 64C 1.36        64  Pou5f1     5.5150
## 15714 64C 1.37        64  Pou5f1     6.3950
## 15715 64C 1.38        64  Pou5f1     9.8400
## 15716 64C 1.39        64  Pou5f1     8.5150
## 15717 64C 1.40        64  Pou5f1     4.7600
## 15718 64C 1.41        64  Pou5f1     7.3700
## 15719 64C 1.42        64  Pou5f1     5.7850
## 15720 64C 1.43        64  Pou5f1     4.7150
## 15721 64C 1.44        64  Pou5f1     4.4700
## 15722 64C 1.45        64  Pou5f1     5.2500
## 15723 64C 1.46        64  Pou5f1     7.2150
## 15724 64C 1.47        64  Pou5f1     8.1500
## 15725 64C 1.48        64  Pou5f1    10.4550
## 15726  64C 2.1        64  Pou5f1    10.0650
## 15727  64C 2.2        64  Pou5f1     8.4050
## 15728  64C 2.3        64  Pou5f1     9.5150
## 15729  64C 2.4        64  Pou5f1     3.9650
## 15730  64C 2.5        64  Pou5f1     2.7200
## 15731  64C 2.6        64  Pou5f1     4.4300
## 15732  64C 2.7        64  Pou5f1     3.4650
## 15733  64C 2.8        64  Pou5f1     4.4950
## 15734  64C 2.9        64  Pou5f1     9.4950
## 15735 64C 2.10        64  Pou5f1     7.5250
## 15736 64C 2.11        64  Pou5f1     7.9350
## 15737 64C 2.12        64  Pou5f1    10.5000
## 15738 64C 2.13        64  Pou5f1     8.8700
## 15739 64C 2.14        64  Pou5f1     5.2750
## 15740 64C 2.15        64  Pou5f1     9.7950
## 15741 64C 2.16        64  Pou5f1     3.6400
## 15742 64C 2.17        64  Pou5f1    11.8900
## 15743 64C 2.18        64  Pou5f1     8.5250
## 15744 64C 2.19        64  Pou5f1     9.3200
## 15745 64C 2.20        64  Pou5f1     9.7000
## 15746 64C 2.21        64  Pou5f1    13.0350
## 15747 64C 2.22        64  Pou5f1     6.6800
## 15748 64C 2.23        64  Pou5f1     9.4300
## 15749 64C 2.24        64  Pou5f1     8.6350
## 15750 64C 2.25        64  Pou5f1     3.5300
## 15751  64C 3.1        64  Pou5f1    10.7900
## 15752  64C 3.2        64  Pou5f1     8.1000
## 15753  64C 3.3        64  Pou5f1     8.8800
## 15754  64C 3.4        64  Pou5f1     7.0700
## 15755  64C 3.5        64  Pou5f1     3.4300
## 15756  64C 3.6        64  Pou5f1     5.6350
## 15757  64C 3.7        64  Pou5f1     6.8850
## 15758  64C 3.8        64  Pou5f1     8.7000
## 15759  64C 4.1        64  Pou5f1     1.7300
## 15760 64C 4.1b        64  Pou5f1     4.0200
## 15761  64C 4.2        64  Pou5f1     4.4250
## 15762  64C 4.3        64  Pou5f1     3.8050
## 15763  64C 4.4        64  Pou5f1     5.0950
## 15764  64C 4.5        64  Pou5f1     4.2550
## 15765  64C 4.6        64  Pou5f1     4.2500
## 15766  64C 4.7        64  Pou5f1     4.8150
## 15767  64C 4.8        64  Pou5f1     2.0150
## 15768  64C 4.9        64  Pou5f1     4.1400
## 15769 64C 4.10        64  Pou5f1     4.8400
## 15770 64C 4.11        64  Pou5f1     3.6250
## 15771 64C 4.12        64  Pou5f1     7.3850
## 15772 64C 4.13        64  Pou5f1     7.4150
## 15773 64C 4.14        64  Pou5f1     7.4150
## 15774 64C 4.15        64  Pou5f1     4.9500
## 15775 64C 4.16        64  Pou5f1    -0.5850
## 15776 64C 4.17        64  Pou5f1     5.4600
## 15777 64C 4.18        64  Pou5f1     3.9350
## 15778 64C 4.19        64  Pou5f1     7.8550
## 15779 64C 4.20        64  Pou5f1     6.9100
## 15780 64C 4.21        64  Pou5f1     6.8400
## 15781 64C 4.22        64  Pou5f1     5.4700
## 15782 64C 4.23        64  Pou5f1     6.2600
## 15783 64C 4.24        64  Pou5f1     5.7050
## 15784 64C 4.25        64  Pou5f1     3.1950
## 15785 64C 4.26        64  Pou5f1     1.6500
## 15786 64C 4.27        64  Pou5f1     5.7350
## 15787 64C 4.28        64  Pou5f1     5.6350
## 15788 64C 4.29        64  Pou5f1     8.1375
## 15789 64C 4.30        64  Pou5f1     4.7400
## 15790 64C 4.31        64  Pou5f1     5.1250
## 15791 64C 4.32        64  Pou5f1     2.7800
## 15792 64C 4.33        64  Pou5f1     5.0300
## 15793 64C 4.34        64  Pou5f1     4.0650
## 15794 64C 4.35        64  Pou5f1     4.3200
## 15795 64C 4.36        64  Pou5f1     6.7350
## 15796 64C 4.37        64  Pou5f1     7.0500
## 15797 64C 4.38        64  Pou5f1     4.5725
## 15798 64C 4.39        64  Pou5f1     9.5750
## 15799  64C 5.1        64  Pou5f1     6.1650
## 15800  64C 5.2        64  Pou5f1     2.8550
## 15801  64C 5.3        64  Pou5f1    -0.1150
## 15802  64C 5.4        64  Pou5f1     5.1500
## 15803  64C 5.5        64  Pou5f1     2.2950
## 15804  64C 5.6        64  Pou5f1     3.3450
## 15805  64C 5.7        64  Pou5f1     4.5050
## 15806  64C 5.8        64  Pou5f1     4.4150
## 15807  64C 5.9        64  Pou5f1     3.5150
## 15808 64C 5.10        64  Pou5f1     1.7500
## 15809 64C 5.11        64  Pou5f1     3.3550
## 15810 64C 5.12        64  Pou5f1     2.9900
## 15811 64C 5.13        64  Pou5f1     3.5750
## 15812 64C 5.14        64  Pou5f1     3.2850
## 15813 64C 5.15        64  Pou5f1     6.1100
## 15814 64C 5.16        64  Pou5f1     7.0150
## 15815  64C 6.1        64  Pou5f1     3.2450
## 15816  64C 6.2        64  Pou5f1     3.3550
## 15817  64C 6.3        64  Pou5f1     1.6250
## 15818  64C 6.4        64  Pou5f1     1.7100
## 15819  64C 6.5        64  Pou5f1     0.2450
## 15820  64C 6.6        64  Pou5f1     0.7950
## 15821  64C 6.7        64  Pou5f1     1.1550
## 15822  64C 6.8        64  Pou5f1     3.4600
## 15823  64C 7.1        64  Pou5f1     7.2550
## 15824  64C 7.2        64  Pou5f1     3.0300
## 15825  64C 7.3        64  Pou5f1     5.3800
## 15826  64C 7.4        64  Pou5f1     4.0550
## 15827  64C 7.5        64  Pou5f1     3.0850
## 15828  64C 7.6        64  Pou5f1     0.3500
## 15829  64C 7.7        64  Pou5f1     1.3700
## 15830  64C 7.8        64  Pou5f1     1.4650
## 15831  64C 7.9        64  Pou5f1     4.6000
## 15832 64C 7.10        64  Pou5f1     7.2750
## 15833 64C 7.11        64  Pou5f1     4.6650
## 15834 64C 7.12        64  Pou5f1     6.5950
## 15835 64C 7.13        64  Pou5f1     8.6550
## 15836 64C 7.14        64  Pou5f1     4.5950
## 15837   2C 1.1         2   Runx1    11.0450
## 15838   2C 1.2         2   Runx1     9.8950
## 15839   2C 2.1         2   Runx1    11.5850
## 15840   2C 2.2         2   Runx1    15.2850
## 15841   2C 3.1         2   Runx1    13.8650
## 15842   2C 3.2         2   Runx1     7.7350
## 15843   2C 4.1         2   Runx1     9.9400
## 15844   2C 5.1         2   Runx1    13.5150
## 15845   2C 5.2         2   Runx1     6.9050
## 15846   2C 6.1         2   Runx1     5.8050
## 15847   2C 6.2         2   Runx1     8.5600
## 15848   2C 7.1         2   Runx1    12.4750
## 15849   2C 7.2         2   Runx1     9.9300
## 15850   2C 8.1         2   Runx1    13.4100
## 15851   2C 8.2         2   Runx1    11.5100
## 15852   2C 9.1         2   Runx1     8.7500
## 15853   2C 9.2         2   Runx1     8.5400
## 15854  2C 10.1         2   Runx1     8.5050
## 15855  2C 10.2         2   Runx1     6.1550
## 15856   4C 1.1         4   Runx1     7.1650
## 15857   4C 1.2         4   Runx1     7.5850
## 15858   4C 1.3         4   Runx1    10.1400
## 15859   4C 1.4         4   Runx1     8.5250
## 15860   4C 2.1         4   Runx1     8.5750
## 15861   4C 2.2         4   Runx1     6.4200
## 15862   4C 2.3         4   Runx1     8.6300
## 15863   4C 3.1         4   Runx1    11.5150
## 15864   4C 3.2         4   Runx1     6.1250
## 15865   4C 3.3         4   Runx1    12.6600
## 15866   4C 3.4         4   Runx1     5.5400
## 15867   4C 4.1         4   Runx1     8.1350
## 15868   4C 4.2         4   Runx1    10.3350
## 15869   4C 4.3         4   Runx1     7.3950
## 15870   4C 4.4         4   Runx1     7.7100
## 15871   4C 5.1         4   Runx1     9.4450
## 15872   4C 5.2         4   Runx1    11.6550
## 15873   4C 5.3         4   Runx1     5.6000
## 15874   4C 5.4         4   Runx1     6.0200
## 15875   4C 6.1         4   Runx1     5.5250
## 15876   4C 6.2         4   Runx1    10.7750
## 15877   4C 6.3         4   Runx1    10.0100
## 15878   4C 6.4         4   Runx1     7.2500
## 15879   8C 1.1         8   Runx1     9.5000
## 15880   8C 1.2         8   Runx1    13.1900
## 15881   8C 1.3         8   Runx1     7.1650
## 15882   8C 1.4         8   Runx1     4.5150
## 15883   8C 1.5         8   Runx1     8.5250
## 15884   8C 2.1         8   Runx1     5.6550
## 15885   8C 2.2         8   Runx1     8.6850
## 15886   8C 2.3         8   Runx1     8.7650
## 15887   8C 2.4         8   Runx1    10.5800
## 15888   8C 2.5         8   Runx1     9.2050
## 15889   8C 2.6         8   Runx1     6.9900
## 15890   8C 2.7         8   Runx1     4.5700
## 15891   8C 2.8         8   Runx1     6.1550
## 15892   8C 3.1         8   Runx1     6.3000
## 15893   8C 3.2         8   Runx1     9.2300
## 15894   8C 3.3         8   Runx1    14.4400
## 15895   8C 3.4         8   Runx1     8.4550
## 15896   8C 3.5         8   Runx1     8.5600
## 15897   8C 3.6         8   Runx1     7.2400
## 15898   8C 3.7         8   Runx1     6.2700
## 15899   8C 3.8         8   Runx1    10.9850
## 15900   8C 4.2         8   Runx1     9.6150
## 15901   8C 4.3         8   Runx1     6.5600
## 15902   8C 4.4         8   Runx1    12.3000
## 15903   8C 4.5         8   Runx1    13.1150
## 15904   8C 4.6         8   Runx1     7.7825
## 15905   8C 4.7         8   Runx1    10.5800
## 15906   8C 5.1         8   Runx1     6.0400
## 15907   8C 5.2         8   Runx1     9.5450
## 15908   8C 5.3         8   Runx1     7.1450
## 15909   8C 5.4         8   Runx1     5.6650
## 15910   8C 5.5         8   Runx1     5.3800
## 15911   8C 5.6         8   Runx1     6.6100
## 15912   8C 5.7         8   Runx1    14.1050
## 15913   8C 5.8         8   Runx1     6.5300
## 15914   8C 6.1         8   Runx1     6.9700
## 15915   8C 6.2         8   Runx1     8.6450
## 15916   8C 6.3         8   Runx1     6.9750
## 15917   8C 6.4         8   Runx1     5.5350
## 15918   8C 6.5         8   Runx1     8.4950
## 15919   8C 6.6         8   Runx1     4.8100
## 15920   8C 6.7         8   Runx1     8.2100
## 15921   8C 6.8         8   Runx1     8.2300
## 15922  16C 1.1        16   Runx1     7.0300
## 15923  16C 1.2        16   Runx1    13.5000
## 15924  16C 1.3        16   Runx1     5.8250
## 15925  16C 1.4        16   Runx1     4.5700
## 15926  16C 1.5        16   Runx1     3.1750
## 15927  16C 1.6        16   Runx1     4.5750
## 15928  16C 1.7        16   Runx1     2.1200
## 15929  16C 1.8        16   Runx1     7.2150
## 15930  16C 1.9        16   Runx1     6.6700
## 15931 16C 1.10        16   Runx1     6.8100
## 15932 16C 1.11        16   Runx1     8.3300
## 15933 16C 1.12        16   Runx1     5.6250
## 15934 16C 1.13        16   Runx1     4.9500
## 15935 16C 1.14        16   Runx1     1.9200
## 15936 16C 1.15        16   Runx1    11.3150
## 15937 16C 1.16        16   Runx1     4.0750
## 15938  16C 2.1        16   Runx1     7.8600
## 15939  16C 2.2        16   Runx1     6.5450
## 15940  16C 2.3        16   Runx1     5.9600
## 15941  16C 2.4        16   Runx1     5.5950
## 15942  16C 2.5        16   Runx1     9.8300
## 15943  16C 2.6        16   Runx1     4.9950
## 15944  16C 2.7        16   Runx1    11.0450
## 15945  16C 2.8        16   Runx1     3.5250
## 15946  16C 2.9        16   Runx1     4.7150
## 15947 16C 2.10        16   Runx1     9.0550
## 15948 16C 2.11        16   Runx1     8.5050
## 15949 16C 2.12        16   Runx1     6.1350
## 15950 16C 2.13        16   Runx1     8.1900
## 15951 16C 2.14        16   Runx1     6.2750
## 15952 16C 2.15        16   Runx1     4.4550
## 15953 16C 2.16        16   Runx1     7.1350
## 15954  16C 3.1        16   Runx1     5.4000
## 15955  16C 3.2        16   Runx1     5.3750
## 15956  16C 3.3        16   Runx1     6.8300
## 15957  16C 3.4        16   Runx1     8.2400
## 15958  16C 3.5        16   Runx1     4.8900
## 15959  16C 3.6        16   Runx1     7.5400
## 15960  16C 3.7        16   Runx1     6.3300
## 15961  16C 3.8        16   Runx1     8.3750
## 15962  16C 3.9        16   Runx1     5.0050
## 15963 16C 3.10        16   Runx1     6.2350
## 15964 16C 3.11        16   Runx1     4.3150
## 15965 16C 3.12        16   Runx1    12.5200
## 15966 16C 3.13        16   Runx1    12.6150
## 15967 16C 3.14        16   Runx1     8.6050
## 15968 16C 3.15        16   Runx1     4.2000
## 15969  16C 4.1        16   Runx1    10.3200
## 15970  16C 4.2        16   Runx1     5.3650
## 15971  16C 4.3        16   Runx1    11.6750
## 15972  16C 4.4        16   Runx1     7.8100
## 15973  16C 4.5        16   Runx1     5.8900
## 15974  16C 4.6        16   Runx1     8.7050
## 15975  16C 4.7        16   Runx1     7.2150
## 15976  16C 4.8        16   Runx1     5.7550
## 15977  16C 4.9        16   Runx1     6.3100
## 15978 16C 4.10        16   Runx1     7.7550
## 15979 16C 4.11        16   Runx1     4.7150
## 15980 16C 4.12        16   Runx1     3.8900
## 15981 16C 4.13        16   Runx1     4.9700
## 15982 16C 4.14        16   Runx1     6.4850
## 15983 16C 4.15        16   Runx1     7.7650
## 15984 16C 4.16        16   Runx1     8.6600
## 15985  16C 5.1        16   Runx1    13.3900
## 15986  16C 5.2        16   Runx1     8.3900
## 15987  16C 5.3        16   Runx1     6.3900
## 15988  16C 5.4        16   Runx1     4.9450
## 15989  16C 5.5        16   Runx1    10.4750
## 15990  16C 5.6        16   Runx1     9.0350
## 15991  16C 5.7        16   Runx1     7.9450
## 15992  16C 5.8        16   Runx1     7.4950
## 15993  16C 5.9        16   Runx1     7.5450
## 15994 16C 5.10        16   Runx1     8.1900
## 15995 16C 5.11        16   Runx1     9.8550
## 15996 16C 5.12        16   Runx1    12.7900
## 15997  32C 1.1        32   Runx1     4.6800
## 15998  32C 1.2        32   Runx1     6.7650
## 15999  32C 1.3        32   Runx1     4.1700
## 16000  32C 1.4        32   Runx1     7.3200
## 16001  32C 1.5        32   Runx1    14.4400
## 16002  32C 1.6        32   Runx1     7.4250
## 16003  32C 1.7        32   Runx1     9.3000
## 16004  32C 1.8        32   Runx1    10.2500
## 16005  32C 1.9        32   Runx1    11.9000
## 16006 32C 1.10        32   Runx1     2.4550
## 16007 32C 1.11        32   Runx1     4.2250
## 16008 32C 1.12        32   Runx1     6.2500
## 16009 32C 1.13        32   Runx1     4.4900
## 16010 32C 1.14        32   Runx1     6.4450
## 16011 32C 1.15        32   Runx1    13.6125
## 16012 32C 1.16        32   Runx1    10.1500
## 16013 32C 1.17        32   Runx1     5.2800
## 16014 32C 1.18        32   Runx1    12.8450
## 16015 32C 1.19        32   Runx1    10.6250
## 16016 32C 1.20        32   Runx1     7.5250
## 16017 32C 1.21        32   Runx1    10.4200
## 16018  32C 2.1        32   Runx1     7.6800
## 16019  32C 2.2        32   Runx1     8.2850
## 16020  32C 2.3        32   Runx1     7.7100
## 16021  32C 2.4        32   Runx1    12.9800
## 16022  32C 2.5        32   Runx1    13.5250
## 16023  32C 2.6        32   Runx1     9.2550
## 16024  32C 2.7        32   Runx1     7.8850
## 16025  32C 2.8        32   Runx1    12.6350
## 16026  32C 2.9        32   Runx1     2.8500
## 16027 32C 2.10        32   Runx1     6.9600
## 16028 32C 2.11        32   Runx1    13.7200
## 16029 32C 2.12        32   Runx1     8.8600
## 16030 32C 2.13        32   Runx1    13.5000
## 16031 32C 2.14        32   Runx1    11.9650
## 16032 32C 2.15        32   Runx1     5.8800
## 16033 32C 2.16        32   Runx1     3.6950
## 16034  32C 3.1        32   Runx1     3.5250
## 16035  32C 3.2        32   Runx1     3.1600
## 16036  32C 3.3        32   Runx1     7.6050
## 16037  32C 3.4        32   Runx1     7.0200
## 16038  32C 3.5        32   Runx1     8.4300
## 16039  32C 3.6        32   Runx1    14.8300
## 16040  32C 3.7        32   Runx1    12.7150
## 16041  32C 3.8        32   Runx1    11.5100
## 16042  32C 4.1        32   Runx1     0.8300
## 16043  32C 4.2        32   Runx1     5.1950
## 16044  32C 4.3        32   Runx1    11.0750
## 16045  32C 4.4        32   Runx1     6.2100
## 16046  32C 4.5        32   Runx1     7.6650
## 16047  32C 4.6        32   Runx1    12.7800
## 16048  32C 4.7        32   Runx1     8.2950
## 16049  32C 4.8        32   Runx1     7.0500
## 16050 32C 4.10        32   Runx1     3.8750
## 16051 32C 4.11        32   Runx1    11.0450
## 16052 32C 4.12        32   Runx1     4.7950
## 16053 32C 4.13        32   Runx1     5.4450
## 16054 32C 4.14        32   Runx1    15.2850
## 16055 32C 4.15        32   Runx1    13.8650
## 16056 32C 4.16        32   Runx1     7.6950
## 16057 32C 4.17        32   Runx1     7.6900
## 16058 32C 4.18        32   Runx1    13.5150
## 16059 32C 4.19        32   Runx1     6.5550
## 16060 32C 4.20        32   Runx1    12.0850
## 16061 32C 4.21        32   Runx1    12.4100
## 16062 32C 4.22        32   Runx1    12.4750
## 16063 32C 4.23        32   Runx1     7.8600
## 16064 32C 4.24        32   Runx1    13.4100
## 16065  32C 5.1        32   Runx1     3.2600
## 16066  32C 5.2        32   Runx1     6.8500
## 16067  32C 5.3        32   Runx1     9.7100
## 16068  32C 5.4        32   Runx1    13.2950
## 16069  32C 5.5        32   Runx1    11.4450
## 16070  32C 5.6        32   Runx1     5.5750
## 16071  32C 5.7        32   Runx1     5.6750
## 16072  32C 5.8        32   Runx1    14.2400
## 16073  32C 5.9        32   Runx1     4.2850
## 16074 32C 5.10        32   Runx1    13.4350
## 16075 32C 5.11        32   Runx1     5.6000
## 16076 32C 5.12        32   Runx1    13.8600
## 16077 32C 5.13        32   Runx1     6.0650
## 16078 32C 5.14        32   Runx1     7.8250
## 16079 32C 5.15        32   Runx1    12.6600
## 16080 32C 5.16        32   Runx1     5.0200
## 16081 32C 5.17        32   Runx1     5.6750
## 16082 32C 5.18        32   Runx1    13.8250
## 16083 32C 5.19        32   Runx1    12.7650
## 16084 32C 5.20        32   Runx1     8.3700
## 16085 32C 5.21        32   Runx1     7.3250
## 16086 32C 5.22        32   Runx1     5.6250
## 16087 32C 5.23        32   Runx1     3.9200
## 16088  32C 6.1        32   Runx1     8.0250
## 16089  32C 6.2        32   Runx1     4.8700
## 16090  32C 6.3        32   Runx1     8.4850
## 16091  32C 6.4        32   Runx1    14.1800
## 16092  32C 6.6        32   Runx1     7.0050
## 16093  32C 6.7        32   Runx1    10.5400
## 16094  32C 7.1        32   Runx1     6.0750
## 16095  32C 7.2        32   Runx1    11.6950
## 16096  32C 7.3        32   Runx1    10.4750
## 16097  32C 7.4        32   Runx1     5.2400
## 16098  32C 7.5        32   Runx1    10.5250
## 16099  32C 7.6        32   Runx1    13.5550
## 16100  32C 7.8        32   Runx1     6.8600
## 16101  32C 8.1        32   Runx1     8.1250
## 16102  32C 8.2        32   Runx1     8.4150
## 16103  32C 8.4        32   Runx1    12.7900
## 16104  32C 8.5        32   Runx1    11.2700
## 16105  32C 8.6        32   Runx1    10.7750
## 16106  64C 1.1        64   Runx1     4.0700
## 16107  64C 1.2        64   Runx1    11.8100
## 16108  64C 1.3        64   Runx1    14.4400
## 16109  64C 1.4        64   Runx1     5.3350
## 16110  64C 1.5        64   Runx1     4.7100
## 16111  64C 1.6        64   Runx1    13.2600
## 16112  64C 1.7        64   Runx1     2.9600
## 16113  64C 1.8        64   Runx1     5.1450
## 16114  64C 1.9        64   Runx1     0.8350
## 16115 64C 1.10        64   Runx1     8.2500
## 16116 64C 1.11        64   Runx1     4.0500
## 16117 64C 1.12        64   Runx1     7.7450
## 16118 64C 1.13        64   Runx1     6.0825
## 16119 64C 1.14        64   Runx1     8.1400
## 16120 64C 1.15        64   Runx1     5.0700
## 16121 64C 1.16        64   Runx1    12.8450
## 16122 64C 1.17        64   Runx1     3.8750
## 16123 64C 1.18        64   Runx1     6.3750
## 16124 64C 1.19        64   Runx1     4.4100
## 16125 64C 1.20        64   Runx1    13.2600
## 16126 64C 1.21        64   Runx1     9.4250
## 16127 64C 1.22        64   Runx1    12.3100
## 16128 64C 1.23        64   Runx1    12.9800
## 16129 64C 1.24        64   Runx1     7.4650
## 16130 64C 1.25        64   Runx1     2.7450
## 16131 64C 1.26        64   Runx1     2.7950
## 16132 64C 1.27        64   Runx1     7.5050
## 16133 64C 1.28        64   Runx1     4.9300
## 16134 64C 1.29        64   Runx1     5.7900
## 16135 64C 1.30        64   Runx1     9.9100
## 16136 64C 1.31        64   Runx1    10.0100
## 16137 64C 1.32        64   Runx1     9.7100
## 16138 64C 1.33        64   Runx1     6.5450
## 16139 64C 1.34        64   Runx1    11.8900
## 16140 64C 1.35        64   Runx1     3.0550
## 16141 64C 1.36        64   Runx1     4.4050
## 16142 64C 1.37        64   Runx1     4.1400
## 16143 64C 1.38        64   Runx1     7.1650
## 16144 64C 1.39        64   Runx1     7.9200
## 16145 64C 1.40        64   Runx1    12.9700
## 16146 64C 1.41        64   Runx1     7.2800
## 16147 64C 1.42        64   Runx1     4.1250
## 16148 64C 1.43        64   Runx1     4.4300
## 16149 64C 1.44        64   Runx1     4.4200
## 16150 64C 1.45        64   Runx1     6.2550
## 16151 64C 1.46        64   Runx1     6.7950
## 16152 64C 1.47        64   Runx1     7.9200
## 16153 64C 1.48        64   Runx1     7.3950
## 16154  64C 2.1        64   Runx1     5.5800
## 16155  64C 2.2        64   Runx1     4.1550
## 16156  64C 2.3        64   Runx1     7.2500
## 16157  64C 2.4        64   Runx1     4.1250
## 16158  64C 2.5        64   Runx1     2.9750
## 16159  64C 2.6        64   Runx1     2.8350
## 16160  64C 2.7        64   Runx1     4.0050
## 16161  64C 2.8        64   Runx1     7.6550
## 16162  64C 2.9        64   Runx1     6.4550
## 16163 64C 2.10        64   Runx1     8.1350
## 16164 64C 2.11        64   Runx1     7.4300
## 16165 64C 2.12        64   Runx1     6.6550
## 16166 64C 2.13        64   Runx1     4.7050
## 16167 64C 2.14        64   Runx1     4.9550
## 16168 64C 2.15        64   Runx1     5.7600
## 16169 64C 2.16        64   Runx1     3.8450
## 16170 64C 2.17        64   Runx1     5.9800
## 16171 64C 2.18        64   Runx1    10.7000
## 16172 64C 2.19        64   Runx1     5.0200
## 16173 64C 2.20        64   Runx1     8.2900
## 16174 64C 2.21        64   Runx1     7.5800
## 16175 64C 2.22        64   Runx1     8.2950
## 16176 64C 2.23        64   Runx1     5.7150
## 16177 64C 2.24        64   Runx1     5.2950
## 16178 64C 2.25        64   Runx1    11.3550
## 16179  64C 3.1        64   Runx1     9.9100
## 16180  64C 3.2        64   Runx1     5.3450
## 16181  64C 3.3        64   Runx1     8.5550
## 16182  64C 3.4        64   Runx1     3.9300
## 16183  64C 3.5        64   Runx1     4.4300
## 16184  64C 3.6        64   Runx1     8.7450
## 16185  64C 3.7        64   Runx1    10.7650
## 16186  64C 3.8        64   Runx1     6.9600
## 16187  64C 4.1        64   Runx1     3.0100
## 16188 64C 4.1b        64   Runx1    13.2150
## 16189  64C 4.2        64   Runx1    13.8250
## 16190  64C 4.3        64   Runx1     4.7350
## 16191  64C 4.4        64   Runx1     9.5300
## 16192  64C 4.5        64   Runx1     7.7450
## 16193  64C 4.6        64   Runx1     8.1850
## 16194  64C 4.7        64   Runx1     5.4100
## 16195  64C 4.8        64   Runx1     4.1100
## 16196  64C 4.9        64   Runx1     6.4550
## 16197 64C 4.10        64   Runx1    14.8150
## 16198 64C 4.11        64   Runx1    11.6000
## 16199 64C 4.12        64   Runx1    13.3900
## 16200 64C 4.13        64   Runx1     8.9100
## 16201 64C 4.14        64   Runx1    13.1900
## 16202 64C 4.15        64   Runx1     7.8350
## 16203 64C 4.16        64   Runx1     5.3450
## 16204 64C 4.17        64   Runx1     8.0250
## 16205 64C 4.18        64   Runx1     2.3650
## 16206 64C 4.19        64   Runx1    13.5550
## 16207 64C 4.20        64   Runx1     8.6550
## 16208 64C 4.21        64   Runx1     7.5300
## 16209 64C 4.22        64   Runx1     6.5550
## 16210 64C 4.23        64   Runx1     6.7400
## 16211 64C 4.24        64   Runx1     7.2600
## 16212 64C 4.25        64   Runx1     4.6050
## 16213 64C 4.26        64   Runx1     2.3700
## 16214 64C 4.27        64   Runx1     7.9100
## 16215 64C 4.28        64   Runx1     7.0100
## 16216 64C 4.29        64   Runx1     9.4950
## 16217 64C 4.30        64   Runx1     4.6000
## 16218 64C 4.31        64   Runx1     9.2600
## 16219 64C 4.32        64   Runx1    11.9000
## 16220 64C 4.33        64   Runx1     6.2950
## 16221 64C 4.34        64   Runx1     3.3150
## 16222 64C 4.35        64   Runx1     3.9200
## 16223 64C 4.36        64   Runx1     7.2400
## 16224 64C 4.37        64   Runx1    13.1150
## 16225 64C 4.38        64   Runx1     6.1725
## 16226 64C 4.39        64   Runx1     9.7900
## 16227  64C 5.1        64   Runx1     7.3000
## 16228  64C 5.2        64   Runx1     3.6650
## 16229  64C 5.3        64   Runx1     1.1650
## 16230  64C 5.4        64   Runx1     4.8550
## 16231  64C 5.5        64   Runx1     2.0100
## 16232  64C 5.6        64   Runx1     4.6800
## 16233  64C 5.7        64   Runx1     4.7650
## 16234  64C 5.8        64   Runx1    12.3100
## 16235  64C 5.9        64   Runx1     4.6900
## 16236 64C 5.10        64   Runx1     3.7850
## 16237 64C 5.11        64   Runx1     9.2550
## 16238 64C 5.12        64   Runx1     6.1350
## 16239 64C 5.13        64   Runx1     6.4850
## 16240 64C 5.14        64   Runx1    10.8400
## 16241 64C 5.15        64   Runx1     7.8100
## 16242 64C 5.16        64   Runx1    13.7200
## 16243  64C 6.1        64   Runx1     3.4100
## 16244  64C 6.2        64   Runx1    13.5000
## 16245  64C 6.3        64   Runx1    11.9650
## 16246  64C 6.4        64   Runx1    11.8900
## 16247  64C 6.5        64   Runx1     9.5050
## 16248  64C 6.6        64   Runx1    11.3150
## 16249  64C 6.7        64   Runx1    -0.0600
## 16250  64C 6.8        64   Runx1    14.7350
## 16251  64C 7.1        64   Runx1     7.4900
## 16252  64C 7.2        64   Runx1     4.5000
## 16253  64C 7.3        64   Runx1    14.8300
## 16254  64C 7.4        64   Runx1     5.0650
## 16255  64C 7.5        64   Runx1     2.3900
## 16256  64C 7.6        64   Runx1     0.7000
## 16257  64C 7.7        64   Runx1     2.8750
## 16258  64C 7.8        64   Runx1     4.6350
## 16259  64C 7.9        64   Runx1     5.3900
## 16260 64C 7.10        64   Runx1    10.0350
## 16261 64C 7.11        64   Runx1     6.1400
## 16262 64C 7.12        64   Runx1     7.9950
## 16263 64C 7.13        64   Runx1    10.5000
## 16264 64C 7.14        64   Runx1     8.1050
## 16265   2C 1.1         2    Sox2     5.2100
## 16266   2C 1.2         2    Sox2     6.1950
## 16267   2C 2.1         2    Sox2    -0.8800
## 16268   2C 2.2         2    Sox2     5.1200
## 16269   2C 3.1         2    Sox2     7.0950
## 16270   2C 3.2         2    Sox2     5.0250
## 16271   2C 4.1         2    Sox2    10.2400
## 16272   2C 5.1         2    Sox2     7.7250
## 16273   2C 5.2         2    Sox2     4.5900
## 16274   2C 6.1         2    Sox2     2.5100
## 16275   2C 6.2         2    Sox2     2.5750
## 16276   2C 7.1         2    Sox2     2.2900
## 16277   2C 7.2         2    Sox2     3.8450
## 16278   2C 8.1         2    Sox2     6.6900
## 16279   2C 8.2         2    Sox2     6.1200
## 16280   2C 9.1         2    Sox2     6.9000
## 16281   2C 9.2         2    Sox2     5.4900
## 16282  2C 10.1         2    Sox2     3.5300
## 16283  2C 10.2         2    Sox2     2.6050
## 16284   4C 1.1         4    Sox2     7.0400
## 16285   4C 1.2         4    Sox2    11.6750
## 16286   4C 1.3         4    Sox2    12.5750
## 16287   4C 1.4         4    Sox2     9.3450
## 16288   4C 2.1         4    Sox2     8.5250
## 16289   4C 2.2         4    Sox2    13.0900
## 16290   4C 2.3         4    Sox2     7.3350
## 16291   4C 3.1         4    Sox2     6.9150
## 16292   4C 3.2         4    Sox2     4.5350
## 16293   4C 3.3         4    Sox2     9.3700
## 16294   4C 3.4         4    Sox2     6.3300
## 16295   4C 4.1         4    Sox2    10.0250
## 16296   4C 4.2         4    Sox2    10.4550
## 16297   4C 4.3         4    Sox2     6.2900
## 16298   4C 4.4         4    Sox2     9.0300
## 16299   4C 5.1         4    Sox2     8.5750
## 16300   4C 5.2         4    Sox2     6.3000
## 16301   4C 5.3         4    Sox2    11.3000
## 16302   4C 5.4         4    Sox2    12.3250
## 16303   4C 6.1         4    Sox2    11.6700
## 16304   4C 6.2         4    Sox2     8.9450
## 16305   4C 6.3         4    Sox2     9.8750
## 16306   4C 6.4         4    Sox2     8.5950
## 16307   8C 1.1         8    Sox2    13.8350
## 16308   8C 1.2         8    Sox2    12.9500
## 16309   8C 1.3         8    Sox2    12.4350
## 16310   8C 1.4         8    Sox2     5.6950
## 16311   8C 1.5         8    Sox2     8.5600
## 16312   8C 2.1         8    Sox2     7.9750
## 16313   8C 2.2         8    Sox2     8.2550
## 16314   8C 2.3         8    Sox2    10.0600
## 16315   8C 2.4         8    Sox2     9.9500
## 16316   8C 2.5         8    Sox2    13.0850
## 16317   8C 2.6         8    Sox2     9.6550
## 16318   8C 2.7         8    Sox2    11.7900
## 16319   8C 2.8         8    Sox2     9.1400
## 16320   8C 3.1         8    Sox2    11.6000
## 16321   8C 3.2         8    Sox2     9.1300
## 16322   8C 3.3         8    Sox2     7.1700
## 16323   8C 3.4         8    Sox2     7.9875
## 16324   8C 3.5         8    Sox2     5.7050
## 16325   8C 3.6         8    Sox2     7.2900
## 16326   8C 3.7         8    Sox2     8.9100
## 16327   8C 3.8         8    Sox2    11.2750
## 16328   8C 4.2         8    Sox2     5.3050
## 16329   8C 4.3         8    Sox2     6.3150
## 16330   8C 4.4         8    Sox2     8.6750
## 16331   8C 4.5         8    Sox2     8.4350
## 16332   8C 4.6         8    Sox2     9.1475
## 16333   8C 4.7         8    Sox2     8.2550
## 16334   8C 5.1         8    Sox2     5.1300
## 16335   8C 5.2         8    Sox2    12.7000
## 16336   8C 5.3         8    Sox2     6.2850
## 16337   8C 5.4         8    Sox2     6.3700
## 16338   8C 5.5         8    Sox2     5.1850
## 16339   8C 5.6         8    Sox2     7.9750
## 16340   8C 5.7         8    Sox2    10.0300
## 16341   8C 5.8         8    Sox2    12.7325
## 16342   8C 6.1         8    Sox2     8.4950
## 16343   8C 6.2         8    Sox2     8.6750
## 16344   8C 6.3         8    Sox2     9.7100
## 16345   8C 6.4         8    Sox2    10.4750
## 16346   8C 6.5         8    Sox2     9.7250
## 16347   8C 6.6         8    Sox2     8.4650
## 16348   8C 6.7         8    Sox2    10.7450
## 16349   8C 6.8         8    Sox2    10.8650
## 16350  16C 1.1        16    Sox2    12.5000
## 16351  16C 1.2        16    Sox2     9.9450
## 16352  16C 1.3        16    Sox2     8.0350
## 16353  16C 1.4        16    Sox2     8.0800
## 16354  16C 1.5        16    Sox2     4.7050
## 16355  16C 1.6        16    Sox2    10.6800
## 16356  16C 1.7        16    Sox2     4.4350
## 16357  16C 1.8        16    Sox2     7.5950
## 16358  16C 1.9        16    Sox2    13.4150
## 16359 16C 1.10        16    Sox2    12.8700
## 16360 16C 1.11        16    Sox2     9.9000
## 16361 16C 1.12        16    Sox2    11.6050
## 16362 16C 1.13        16    Sox2     9.1850
## 16363 16C 1.14        16    Sox2    10.5950
## 16364 16C 1.15        16    Sox2     4.2050
## 16365 16C 1.16        16    Sox2    10.8700
## 16366  16C 2.1        16    Sox2    12.5350
## 16367  16C 2.2        16    Sox2     9.0150
## 16368  16C 2.3        16    Sox2    12.1200
## 16369  16C 2.4        16    Sox2    13.1350
## 16370  16C 2.5        16    Sox2    13.9900
## 16371  16C 2.6        16    Sox2     9.2300
## 16372  16C 2.7        16    Sox2     6.5800
## 16373  16C 2.8        16    Sox2    12.4350
## 16374  16C 2.9        16    Sox2     4.9100
## 16375 16C 2.10        16    Sox2     9.7200
## 16376 16C 2.11        16    Sox2     8.1950
## 16377 16C 2.12        16    Sox2     7.3650
## 16378 16C 2.13        16    Sox2     9.5400
## 16379 16C 2.14        16    Sox2     8.6550
## 16380 16C 2.15        16    Sox2    11.9400
## 16381 16C 2.16        16    Sox2     8.6700
## 16382  16C 3.1        16    Sox2     7.0250
## 16383  16C 3.2        16    Sox2    12.2600
## 16384  16C 3.3        16    Sox2     8.5950
## 16385  16C 3.4        16    Sox2    12.5000
## 16386  16C 3.5        16    Sox2     9.4900
## 16387  16C 3.6        16    Sox2    14.0200
## 16388  16C 3.7        16    Sox2     9.6200
## 16389  16C 3.8        16    Sox2     8.8100
## 16390  16C 3.9        16    Sox2    11.5150
## 16391 16C 3.10        16    Sox2    12.3600
## 16392 16C 3.11        16    Sox2     9.4950
## 16393 16C 3.12        16    Sox2    15.0050
## 16394 16C 3.13        16    Sox2    13.3050
## 16395 16C 3.14        16    Sox2    10.9750
## 16396 16C 3.15        16    Sox2    15.9200
## 16397  16C 4.1        16    Sox2     8.0850
## 16398  16C 4.2        16    Sox2    11.7950
## 16399  16C 4.3        16    Sox2     4.4750
## 16400  16C 4.4        16    Sox2    11.1000
## 16401  16C 4.5        16    Sox2    11.3100
## 16402  16C 4.6        16    Sox2    14.0950
## 16403  16C 4.7        16    Sox2    14.0350
## 16404  16C 4.8        16    Sox2    11.7500
## 16405  16C 4.9        16    Sox2    10.4200
## 16406 16C 4.10        16    Sox2    14.7950
## 16407 16C 4.11        16    Sox2    11.7000
## 16408 16C 4.12        16    Sox2     7.2500
## 16409 16C 4.13        16    Sox2     6.8850
## 16410 16C 4.14        16    Sox2    11.6700
## 16411 16C 4.15        16    Sox2    10.2450
## 16412 16C 4.16        16    Sox2    13.7550
## 16413  16C 5.1        16    Sox2     8.9850
## 16414  16C 5.2        16    Sox2     9.7950
## 16415  16C 5.3        16    Sox2     6.1000
## 16416  16C 5.4        16    Sox2     7.3150
## 16417  16C 5.5        16    Sox2     7.3350
## 16418  16C 5.6        16    Sox2     5.1700
## 16419  16C 5.7        16    Sox2    12.4050
## 16420  16C 5.8        16    Sox2    14.1050
## 16421  16C 5.9        16    Sox2     8.5100
## 16422 16C 5.10        16    Sox2     9.3200
## 16423 16C 5.11        16    Sox2    13.0850
## 16424 16C 5.12        16    Sox2     2.9250
## 16425  32C 1.1        32    Sox2    11.7900
## 16426  32C 1.2        32    Sox2     0.9600
## 16427  32C 1.3        32    Sox2    11.6000
## 16428  32C 1.4        32    Sox2     7.5800
## 16429  32C 1.5        32    Sox2     2.8500
## 16430  32C 1.6        32    Sox2     1.4375
## 16431  32C 1.7        32    Sox2    12.7250
## 16432  32C 1.8        32    Sox2     2.7500
## 16433  32C 1.9        32    Sox2     1.7900
## 16434 32C 1.10        32    Sox2     5.1750
## 16435 32C 1.11        32    Sox2     4.7050
## 16436 32C 1.12        32    Sox2     8.7450
## 16437 32C 1.13        32    Sox2     5.7650
## 16438 32C 1.14        32    Sox2    10.4750
## 16439 32C 1.15        32    Sox2     2.0575
## 16440 32C 1.16        32    Sox2     5.1950
## 16441 32C 1.17        32    Sox2     3.4600
## 16442 32C 1.18        32    Sox2     1.7100
## 16443 32C 1.19        32    Sox2     0.8950
## 16444 32C 1.20        32    Sox2     3.5100
## 16445 32C 1.21        32    Sox2     0.4550
## 16446  32C 2.1        32    Sox2    10.1250
## 16447  32C 2.2        32    Sox2     8.9300
## 16448  32C 2.3        32    Sox2    12.7325
## 16449  32C 2.4        32    Sox2     3.1950
## 16450  32C 2.5        32    Sox2     2.1250
## 16451  32C 2.6        32    Sox2     8.3700
## 16452  32C 2.7        32    Sox2     2.1150
## 16453  32C 2.8        32    Sox2     2.6750
## 16454  32C 2.9        32    Sox2    11.6550
## 16455 32C 2.10        32    Sox2     9.1950
## 16456 32C 2.11        32    Sox2     4.7450
## 16457 32C 2.12        32    Sox2     9.4200
## 16458 32C 2.13        32    Sox2     6.2350
## 16459 32C 2.14        32    Sox2     2.7850
## 16460 32C 2.15        32    Sox2     1.2500
## 16461 32C 2.16        32    Sox2     1.5350
## 16462  32C 3.1        32    Sox2    10.6800
## 16463  32C 3.2        32    Sox2     9.2250
## 16464  32C 3.3        32    Sox2    11.6350
## 16465  32C 3.4        32    Sox2    11.5450
## 16466  32C 3.5        32    Sox2    11.2100
## 16467  32C 3.6        32    Sox2     4.4900
## 16468  32C 3.7        32    Sox2     4.4150
## 16469  32C 3.8        32    Sox2    -1.6850
## 16470  32C 4.1        32    Sox2    10.5950
## 16471  32C 4.2        32    Sox2     7.7150
## 16472  32C 4.3        32    Sox2     0.3300
## 16473  32C 4.4        32    Sox2    12.5350
## 16474  32C 4.5        32    Sox2     6.8650
## 16475  32C 4.6        32    Sox2     1.2700
## 16476  32C 4.7        32    Sox2    13.1350
## 16477  32C 4.8        32    Sox2     9.9600
## 16478 32C 4.10        32    Sox2     6.9500
## 16479 32C 4.11        32    Sox2     1.7400
## 16480 32C 4.12        32    Sox2     8.1250
## 16481 32C 4.13        32    Sox2     6.8100
## 16482 32C 4.14        32    Sox2     8.9300
## 16483 32C 4.15        32    Sox2     2.3450
## 16484 32C 4.16        32    Sox2     4.6950
## 16485 32C 4.17        32    Sox2    12.4400
## 16486 32C 4.18        32    Sox2    13.4450
## 16487 32C 4.19        32    Sox2     7.7000
## 16488 32C 4.20        32    Sox2     0.8400
## 16489 32C 4.21        32    Sox2     6.3650
## 16490 32C 4.22        32    Sox2     0.5800
## 16491 32C 4.23        32    Sox2    10.0650
## 16492 32C 4.24        32    Sox2     2.2600
## 16493  32C 5.1        32    Sox2     8.9400
## 16494  32C 5.2        32    Sox2    10.1300
## 16495  32C 5.3        32    Sox2     3.3500
## 16496  32C 5.4        32    Sox2     8.7600
## 16497  32C 5.5        32    Sox2     3.5650
## 16498  32C 5.6        32    Sox2     7.7500
## 16499  32C 5.7        32    Sox2    11.6750
## 16500  32C 5.8        32    Sox2    10.1950
## 16501  32C 5.9        32    Sox2    13.3050
## 16502 32C 5.10        32    Sox2     8.6950
## 16503 32C 5.11        32    Sox2    12.7600
## 16504 32C 5.12        32    Sox2     1.5450
## 16505 32C 5.13        32    Sox2     5.1750
## 16506 32C 5.14        32    Sox2     9.5250
## 16507 32C 5.15        32    Sox2     6.7300
## 16508 32C 5.16        32    Sox2     7.4500
## 16509 32C 5.17        32    Sox2    14.0950
## 16510 32C 5.18        32    Sox2     9.1150
## 16511 32C 5.19        32    Sox2     1.5900
## 16512 32C 5.20        32    Sox2     9.5800
## 16513 32C 5.21        32    Sox2    14.7950
## 16514 32C 5.22        32    Sox2     7.8300
## 16515 32C 5.23        32    Sox2    11.3000
## 16516  32C 6.1        32    Sox2     1.1850
## 16517  32C 6.2        32    Sox2     8.4050
## 16518  32C 6.3        32    Sox2    12.0700
## 16519  32C 6.4        32    Sox2     3.7750
## 16520  32C 6.6        32    Sox2    12.5350
## 16521  32C 6.7        32    Sox2    13.8350
## 16522  32C 7.1        32    Sox2    12.9500
## 16523  32C 7.2        32    Sox2     3.8400
## 16524  32C 7.3        32    Sox2    11.5450
## 16525  32C 7.4        32    Sox2    11.8200
## 16526  32C 7.5        32    Sox2     2.8950
## 16527  32C 7.6        32    Sox2     5.9350
## 16528  32C 7.8        32    Sox2    10.0850
## 16529  32C 8.1        32    Sox2    10.2400
## 16530  32C 8.2        32    Sox2    12.2000
## 16531  32C 8.4        32    Sox2     4.1400
## 16532  32C 8.5        32    Sox2     2.4100
## 16533  32C 8.6        32    Sox2    11.5800
## 16534  64C 1.1        64    Sox2    10.6300
## 16535  64C 1.2        64    Sox2    10.8800
## 16536  64C 1.3        64    Sox2     2.6700
## 16537  64C 1.4        64    Sox2    10.7875
## 16538  64C 1.5        64    Sox2     7.9150
## 16539  64C 1.6        64    Sox2     1.2300
## 16540  64C 1.7        64    Sox2     6.8800
## 16541  64C 1.8        64    Sox2    10.8350
## 16542  64C 1.9        64    Sox2     3.7950
## 16543 64C 1.10        64    Sox2    12.1350
## 16544 64C 1.11        64    Sox2    13.2950
## 16545 64C 1.12        64    Sox2    13.6250
## 16546 64C 1.13        64    Sox2     8.0575
## 16547 64C 1.14        64    Sox2    14.2550
## 16548 64C 1.15        64    Sox2    12.2000
## 16549 64C 1.16        64    Sox2     9.2600
## 16550 64C 1.17        64    Sox2     6.5950
## 16551 64C 1.18        64    Sox2    12.1400
## 16552 64C 1.19        64    Sox2    10.7950
## 16553 64C 1.20        64    Sox2    11.7350
## 16554 64C 1.21        64    Sox2    11.4200
## 16555 64C 1.22        64    Sox2     1.8925
## 16556 64C 1.23        64    Sox2     3.1350
## 16557 64C 1.24        64    Sox2    11.6150
## 16558 64C 1.25        64    Sox2    11.5200
## 16559 64C 1.26        64    Sox2     3.4950
## 16560 64C 1.27        64    Sox2    12.3650
## 16561 64C 1.28        64    Sox2     8.9750
## 16562 64C 1.29        64    Sox2    12.8950
## 16563 64C 1.30        64    Sox2    13.8650
## 16564 64C 1.31        64    Sox2    12.5000
## 16565 64C 1.32        64    Sox2    11.1250
## 16566 64C 1.33        64    Sox2    13.1550
## 16567 64C 1.34        64    Sox2    11.4100
## 16568 64C 1.35        64    Sox2     8.1950
## 16569 64C 1.36        64    Sox2    10.1100
## 16570 64C 1.37        64    Sox2    10.3450
## 16571 64C 1.38        64    Sox2    12.1650
## 16572 64C 1.39        64    Sox2    10.6850
## 16573 64C 1.40        64    Sox2     1.8500
## 16574 64C 1.41        64    Sox2     7.5600
## 16575 64C 1.42        64    Sox2     7.4650
## 16576 64C 1.43        64    Sox2     1.9750
## 16577 64C 1.44        64    Sox2    10.5950
## 16578 64C 1.45        64    Sox2     6.7850
## 16579 64C 1.46        64    Sox2     7.3000
## 16580 64C 1.47        64    Sox2    12.5350
## 16581 64C 1.48        64    Sox2    13.9250
## 16582  64C 2.1        64    Sox2    12.1200
## 16583  64C 2.2        64    Sox2    10.5250
## 16584  64C 2.3        64    Sox2    13.9900
## 16585  64C 2.4        64    Sox2     8.5500
## 16586  64C 2.5        64    Sox2     5.9300
## 16587  64C 2.6        64    Sox2    12.4350
## 16588  64C 2.7        64    Sox2     5.4500
## 16589  64C 2.8        64    Sox2     8.4700
## 16590  64C 2.9        64    Sox2     8.8650
## 16591 64C 2.10        64    Sox2    10.9950
## 16592 64C 2.11        64    Sox2    14.4300
## 16593 64C 2.12        64    Sox2    13.4450
## 16594 64C 2.13        64    Sox2    11.9400
## 16595 64C 2.14        64    Sox2    11.1700
## 16596 64C 2.15        64    Sox2     8.1850
## 16597 64C 2.16        64    Sox2     5.7700
## 16598 64C 2.17        64    Sox2     8.9350
## 16599 64C 2.18        64    Sox2     8.0000
## 16600 64C 2.19        64    Sox2     8.3900
## 16601 64C 2.20        64    Sox2    13.5700
## 16602 64C 2.21        64    Sox2    13.0200
## 16603 64C 2.22        64    Sox2    12.1900
## 16604 64C 2.23        64    Sox2    10.9150
## 16605 64C 2.24        64    Sox2     8.6500
## 16606 64C 2.25        64    Sox2     5.0950
## 16607  64C 3.1        64    Sox2    10.9850
## 16608  64C 3.2        64    Sox2     8.4550
## 16609  64C 3.3        64    Sox2    13.6650
## 16610  64C 3.4        64    Sox2    11.3400
## 16611  64C 3.5        64    Sox2     7.5850
## 16612  64C 3.6        64    Sox2    11.7950
## 16613  64C 3.7        64    Sox2     9.5250
## 16614  64C 3.8        64    Sox2     9.8100
## 16615  64C 4.1        64    Sox2     6.9400
## 16616 64C 4.1b        64    Sox2     2.5850
## 16617  64C 4.2        64    Sox2     2.8050
## 16618  64C 4.3        64    Sox2     4.5100
## 16619  64C 4.4        64    Sox2     3.7800
## 16620  64C 4.5        64    Sox2     8.0050
## 16621  64C 4.6        64    Sox2     6.5200
## 16622  64C 4.7        64    Sox2     7.8600
## 16623  64C 4.8        64    Sox2     6.1950
## 16624  64C 4.9        64    Sox2     7.8300
## 16625 64C 4.10        64    Sox2     4.6750
## 16626 64C 4.11        64    Sox2     3.4650
## 16627 64C 4.12        64    Sox2    11.9050
## 16628 64C 4.13        64    Sox2    11.7050
## 16629 64C 4.14        64    Sox2    12.9500
## 16630 64C 4.15        64    Sox2    12.4350
## 16631 64C 4.16        64    Sox2    11.5450
## 16632 64C 4.17        64    Sox2    10.2900
## 16633 64C 4.18        64    Sox2     9.5150
## 16634 64C 4.19        64    Sox2     9.5650
## 16635 64C 4.20        64    Sox2    13.9300
## 16636 64C 4.21        64    Sox2     8.8800
## 16637 64C 4.22        64    Sox2     9.7050
## 16638 64C 4.23        64    Sox2     9.7350
## 16639 64C 4.24        64    Sox2    11.7900
## 16640 64C 4.25        64    Sox2    11.5800
## 16641 64C 4.26        64    Sox2     4.9900
## 16642 64C 4.27        64    Sox2     8.9300
## 16643 64C 4.28        64    Sox2    13.2800
## 16644 64C 4.29        64    Sox2     8.2975
## 16645 64C 4.30        64    Sox2     6.6050
## 16646 64C 4.31        64    Sox2    10.2900
## 16647 64C 4.32        64    Sox2     0.8200
## 16648 64C 4.33        64    Sox2    11.2750
## 16649 64C 4.34        64    Sox2     9.0650
## 16650 64C 4.35        64    Sox2     6.0850
## 16651 64C 4.36        64    Sox2     8.3450
## 16652 64C 4.37        64    Sox2     9.3050
## 16653 64C 4.38        64    Sox2     2.1975
## 16654 64C 4.39        64    Sox2    14.2550
## 16655  64C 5.1        64    Sox2     8.9100
## 16656  64C 5.2        64    Sox2     9.1000
## 16657  64C 5.3        64    Sox2     7.6350
## 16658  64C 5.4        64    Sox2     8.4300
## 16659  64C 5.5        64    Sox2     6.1450
## 16660  64C 5.6        64    Sox2     7.7050
## 16661  64C 5.7        64    Sox2     8.0900
## 16662  64C 5.8        64    Sox2     2.1825
## 16663  64C 5.9        64    Sox2    10.2450
## 16664 64C 5.10        64    Sox2     5.2450
## 16665 64C 5.11        64    Sox2     9.0300
## 16666 64C 5.12        64    Sox2    10.4750
## 16667 64C 5.13        64    Sox2     7.6550
## 16668 64C 5.14        64    Sox2     6.8950
## 16669 64C 5.15        64    Sox2    12.8950
## 16670 64C 5.16        64    Sox2     8.6250
## 16671  64C 6.1        64    Sox2     7.9100
## 16672  64C 6.2        64    Sox2     2.9250
## 16673  64C 6.3        64    Sox2     1.5750
## 16674  64C 6.4        64    Sox2    -0.7700
## 16675  64C 6.5        64    Sox2    -1.9850
## 16676  64C 6.6        64    Sox2    -1.4100
## 16677  64C 6.7        64    Sox2     5.6950
## 16678  64C 6.8        64    Sox2     2.3150
## 16679  64C 7.1        64    Sox2    14.0950
## 16680  64C 7.2        64    Sox2     8.8400
## 16681  64C 7.3        64    Sox2     4.7000
## 16682  64C 7.4        64    Sox2    11.1650
## 16683  64C 7.5        64    Sox2     4.8350
## 16684  64C 7.6        64    Sox2    10.5950
## 16685  64C 7.7        64    Sox2     7.7950
## 16686  64C 7.8        64    Sox2     1.2400
## 16687  64C 7.9        64    Sox2     6.3850
## 16688 64C 7.10        64    Sox2    13.9250
## 16689 64C 7.11        64    Sox2     8.8400
## 16690 64C 7.12        64    Sox2     8.8450
## 16691 64C 7.13        64    Sox2    13.5800
## 16692 64C 7.14        64    Sox2     9.1500
## 16693   2C 1.1         2   Sall4    -0.6800
## 16694   2C 1.2         2   Sall4     0.2750
## 16695   2C 2.1         2   Sall4    -0.4400
## 16696   2C 2.2         2   Sall4     3.6500
## 16697   2C 3.1         2   Sall4     2.9500
## 16698   2C 3.2         2   Sall4     0.6050
## 16699   2C 4.1         2   Sall4     3.4500
## 16700   2C 5.1         2   Sall4     1.4700
## 16701   2C 5.2         2   Sall4     1.2150
## 16702   2C 6.1         2   Sall4    -0.0900
## 16703   2C 6.2         2   Sall4     1.1650
## 16704   2C 7.1         2   Sall4    -0.6000
## 16705   2C 7.2         2   Sall4     3.9350
## 16706   2C 8.1         2   Sall4     1.8400
## 16707   2C 8.2         2   Sall4     1.9750
## 16708   2C 9.1         2   Sall4     3.2600
## 16709   2C 9.2         2   Sall4     3.1550
## 16710  2C 10.1         2   Sall4     1.0650
## 16711  2C 10.2         2   Sall4     0.9250
## 16712   4C 1.1         4   Sall4     2.0150
## 16713   4C 1.2         4   Sall4     1.5000
## 16714   4C 1.3         4   Sall4     2.9600
## 16715   4C 1.4         4   Sall4     2.4650
## 16716   4C 2.1         4   Sall4     2.3250
## 16717   4C 2.2         4   Sall4     4.6200
## 16718   4C 2.3         4   Sall4     3.3550
## 16719   4C 3.1         4   Sall4     0.3850
## 16720   4C 3.2         4   Sall4     1.3800
## 16721   4C 3.3         4   Sall4     2.2600
## 16722   4C 3.4         4   Sall4     1.6800
## 16723   4C 4.1         4   Sall4     4.3600
## 16724   4C 4.2         4   Sall4     3.6050
## 16725   4C 4.3         4   Sall4     1.8300
## 16726   4C 4.4         4   Sall4     3.0400
## 16727   4C 5.1         4   Sall4     4.4900
## 16728   4C 5.2         4   Sall4     1.9400
## 16729   4C 5.3         4   Sall4    -1.1050
## 16730   4C 5.4         4   Sall4     1.2900
## 16731   4C 6.1         4   Sall4     1.3300
## 16732   4C 6.2         4   Sall4     2.6150
## 16733   4C 6.3         4   Sall4     2.1900
## 16734   4C 6.4         4   Sall4     3.0850
## 16735   8C 1.1         8   Sall4     4.3300
## 16736   8C 1.2         8   Sall4     2.0500
## 16737   8C 1.3         8   Sall4     2.9550
## 16738   8C 1.4         8   Sall4     1.2350
## 16739   8C 1.5         8   Sall4     0.5850
## 16740   8C 2.1         8   Sall4     0.2500
## 16741   8C 2.2         8   Sall4     3.4100
## 16742   8C 2.3         8   Sall4     1.5650
## 16743   8C 2.4         8   Sall4     6.9750
## 16744   8C 2.5         8   Sall4     2.7500
## 16745   8C 2.6         8   Sall4     1.3300
## 16746   8C 2.7         8   Sall4     0.6550
## 16747   8C 2.8         8   Sall4    -2.2350
## 16748   8C 3.1         8   Sall4     1.3950
## 16749   8C 3.2         8   Sall4     2.8050
## 16750   8C 3.3         8   Sall4     2.9900
## 16751   8C 3.4         8   Sall4     2.8650
## 16752   8C 3.5         8   Sall4     4.0300
## 16753   8C 3.6         8   Sall4     0.5300
## 16754   8C 3.7         8   Sall4     1.2050
## 16755   8C 3.8         8   Sall4    -0.4150
## 16756   8C 4.2         8   Sall4     4.6850
## 16757   8C 4.3         8   Sall4     1.3350
## 16758   8C 4.4         8   Sall4     4.0550
## 16759   8C 4.5         8   Sall4     4.5300
## 16760   8C 4.6         8   Sall4     1.6450
## 16761   8C 4.7         8   Sall4     2.4300
## 16762   8C 5.1         8   Sall4    -0.1100
## 16763   8C 5.2         8   Sall4     1.4450
## 16764   8C 5.3         8   Sall4    -0.7950
## 16765   8C 5.4         8   Sall4     0.7950
## 16766   8C 5.5         8   Sall4    -0.5050
## 16767   8C 5.6         8   Sall4     2.4800
## 16768   8C 5.7         8   Sall4     2.7050
## 16769   8C 5.8         8   Sall4     2.5125
## 16770   8C 6.1         8   Sall4     1.1100
## 16771   8C 6.2         8   Sall4     2.6500
## 16772   8C 6.3         8   Sall4     0.6200
## 16773   8C 6.4         8   Sall4    -1.0200
## 16774   8C 6.5         8   Sall4     0.6450
## 16775   8C 6.6         8   Sall4    -0.4500
## 16776   8C 6.7         8   Sall4     2.6100
## 16777   8C 6.8         8   Sall4     2.6650
## 16778  16C 1.1        16   Sall4     3.5425
## 16779  16C 1.2        16   Sall4     3.4550
## 16780  16C 1.3        16   Sall4     3.1850
## 16781  16C 1.4        16   Sall4     0.7450
## 16782  16C 1.5        16   Sall4    -1.9450
## 16783  16C 1.6        16   Sall4     0.1550
## 16784  16C 1.7        16   Sall4    -1.6550
## 16785  16C 1.8        16   Sall4     1.5600
## 16786  16C 1.9        16   Sall4     1.6600
## 16787 16C 1.10        16   Sall4    -0.4600
## 16788 16C 1.11        16   Sall4     2.3850
## 16789 16C 1.12        16   Sall4     1.2800
## 16790 16C 1.13        16   Sall4     0.2250
## 16791 16C 1.14        16   Sall4    -0.4400
## 16792 16C 1.15        16   Sall4     0.2150
## 16793 16C 1.16        16   Sall4    -0.3700
## 16794  16C 2.1        16   Sall4     3.3600
## 16795  16C 2.2        16   Sall4     2.3950
## 16796  16C 2.3        16   Sall4     2.1600
## 16797  16C 2.4        16   Sall4     2.3150
## 16798  16C 2.5        16   Sall4     2.1000
## 16799  16C 2.6        16   Sall4     0.4500
## 16800  16C 2.7        16   Sall4     0.7700
## 16801  16C 2.8        16   Sall4     1.0950
## 16802  16C 2.9        16   Sall4     1.1000
## 16803 16C 2.10        16   Sall4     3.0500
## 16804 16C 2.11        16   Sall4     2.4800
## 16805 16C 2.12        16   Sall4     0.8850
## 16806 16C 2.13        16   Sall4     3.5800
## 16807 16C 2.14        16   Sall4     1.8900
## 16808 16C 2.15        16   Sall4     1.7150
## 16809 16C 2.16        16   Sall4    -0.2100
## 16810  16C 3.1        16   Sall4     0.4350
## 16811  16C 3.2        16   Sall4     0.9500
## 16812  16C 3.3        16   Sall4     4.0150
## 16813  16C 3.4        16   Sall4     2.6300
## 16814  16C 3.5        16   Sall4     2.0650
## 16815  16C 3.6        16   Sall4     3.5700
## 16816  16C 3.7        16   Sall4     3.5650
## 16817  16C 3.8        16   Sall4     1.7350
## 16818  16C 3.9        16   Sall4     2.7150
## 16819 16C 3.10        16   Sall4     1.1250
## 16820 16C 3.11        16   Sall4     1.4900
## 16821 16C 3.12        16   Sall4     3.2200
## 16822 16C 3.13        16   Sall4     2.2950
## 16823 16C 3.14        16   Sall4     1.9650
## 16824 16C 3.15        16   Sall4     3.4500
## 16825  16C 4.1        16   Sall4     2.7850
## 16826  16C 4.2        16   Sall4     0.4350
## 16827  16C 4.3        16   Sall4    -0.0300
## 16828  16C 4.4        16   Sall4     1.0100
## 16829  16C 4.5        16   Sall4     0.8000
## 16830  16C 4.6        16   Sall4     3.0800
## 16831  16C 4.7        16   Sall4     2.7450
## 16832  16C 4.8        16   Sall4     1.1400
## 16833  16C 4.9        16   Sall4     3.9500
## 16834 16C 4.10        16   Sall4     4.3800
## 16835 16C 4.11        16   Sall4     1.4600
## 16836 16C 4.12        16   Sall4    -1.3750
## 16837 16C 4.13        16   Sall4     0.9300
## 16838 16C 4.14        16   Sall4     1.7200
## 16839 16C 4.15        16   Sall4     3.9550
## 16840 16C 4.16        16   Sall4     1.8200
## 16841  16C 5.1        16   Sall4     4.2050
## 16842  16C 5.2        16   Sall4     2.7100
## 16843  16C 5.3        16   Sall4     3.1300
## 16844  16C 5.4        16   Sall4     1.3350
## 16845  16C 5.5        16   Sall4     0.1550
## 16846  16C 5.6        16   Sall4     1.2350
## 16847  16C 5.7        16   Sall4     0.1000
## 16848  16C 5.8        16   Sall4     3.9400
## 16849  16C 5.9        16   Sall4     2.1150
## 16850 16C 5.10        16   Sall4     3.2150
## 16851 16C 5.11        16   Sall4     2.2800
## 16852 16C 5.12        16   Sall4     1.5700
## 16853  32C 1.1        32   Sall4     1.4750
## 16854  32C 1.2        32   Sall4    -0.9450
## 16855  32C 1.3        32   Sall4     2.5050
## 16856  32C 1.4        32   Sall4     1.8150
## 16857  32C 1.5        32   Sall4     4.1400
## 16858  32C 1.6        32   Sall4     4.5150
## 16859  32C 1.7        32   Sall4     6.1600
## 16860  32C 1.8        32   Sall4     1.5300
## 16861  32C 1.9        32   Sall4     3.2950
## 16862 32C 1.10        32   Sall4     0.1650
## 16863 32C 1.11        32   Sall4     2.7750
## 16864 32C 1.12        32   Sall4     2.7350
## 16865 32C 1.13        32   Sall4     4.3150
## 16866 32C 1.14        32   Sall4     3.4500
## 16867 32C 1.15        32   Sall4     2.9950
## 16868 32C 1.16        32   Sall4     5.0100
## 16869 32C 1.17        32   Sall4     0.7500
## 16870 32C 1.18        32   Sall4     3.2250
## 16871 32C 1.19        32   Sall4     1.7950
## 16872 32C 1.20        32   Sall4     1.5850
## 16873 32C 1.21        32   Sall4     1.7650
## 16874  32C 2.1        32   Sall4     3.3600
## 16875  32C 2.2        32   Sall4     3.7450
## 16876  32C 2.3        32   Sall4     3.4925
## 16877  32C 2.4        32   Sall4     1.9300
## 16878  32C 2.5        32   Sall4     4.4400
## 16879  32C 2.6        32   Sall4     3.2300
## 16880  32C 2.7        32   Sall4     0.9900
## 16881  32C 2.8        32   Sall4     2.3150
## 16882  32C 2.9        32   Sall4     2.6000
## 16883 32C 2.10        32   Sall4     4.2800
## 16884 32C 2.11        32   Sall4     4.0450
## 16885 32C 2.12        32   Sall4     2.7725
## 16886 32C 2.13        32   Sall4     6.1450
## 16887 32C 2.14        32   Sall4     3.7250
## 16888 32C 2.15        32   Sall4     1.6550
## 16889 32C 2.16        32   Sall4    -0.3450
## 16890  32C 3.1        32   Sall4     1.5950
## 16891  32C 3.2        32   Sall4     1.5750
## 16892  32C 3.3        32   Sall4     3.2700
## 16893  32C 3.4        32   Sall4     4.0000
## 16894  32C 3.5        32   Sall4     2.1600
## 16895  32C 3.6        32   Sall4     4.2550
## 16896  32C 3.7        32   Sall4     3.2100
## 16897  32C 3.8        32   Sall4     2.1050
## 16898  32C 4.1        32   Sall4     0.7200
## 16899  32C 4.2        32   Sall4     2.3150
## 16900  32C 4.3        32   Sall4     1.5300
## 16901  32C 4.4        32   Sall4     3.0700
## 16902  32C 4.5        32   Sall4     3.5950
## 16903  32C 4.6        32   Sall4     3.8000
## 16904  32C 4.7        32   Sall4     5.6250
## 16905  32C 4.8        32   Sall4     3.2300
## 16906 32C 4.10        32   Sall4     2.1200
## 16907 32C 4.11        32   Sall4     3.4100
## 16908 32C 4.12        32   Sall4     2.6850
## 16909 32C 4.13        32   Sall4     2.8400
## 16910 32C 4.14        32   Sall4     5.4400
## 16911 32C 4.15        32   Sall4     4.6200
## 16912 32C 4.16        32   Sall4     1.6050
## 16913 32C 4.17        32   Sall4     6.8200
## 16914 32C 4.18        32   Sall4     3.2400
## 16915 32C 4.19        32   Sall4     2.1450
## 16916 32C 4.20        32   Sall4     2.5300
## 16917 32C 4.21        32   Sall4     2.5750
## 16918 32C 4.22        32   Sall4     1.3900
## 16919 32C 4.23        32   Sall4     5.7950
## 16920 32C 4.24        32   Sall4     4.5600
## 16921  32C 5.1        32   Sall4     5.1350
## 16922  32C 5.2        32   Sall4     7.3800
## 16923  32C 5.3        32   Sall4     5.8850
## 16924  32C 5.4        32   Sall4     2.3950
## 16925  32C 5.5        32   Sall4     5.5350
## 16926  32C 5.6        32   Sall4     5.4050
## 16927  32C 5.7        32   Sall4     3.5600
## 16928  32C 5.8        32   Sall4     4.9400
## 16929  32C 5.9        32   Sall4     3.0250
## 16930 32C 5.10        32   Sall4     5.3350
## 16931 32C 5.11        32   Sall4     6.1000
## 16932 32C 5.12        32   Sall4     6.6550
## 16933 32C 5.13        32   Sall4     1.7550
## 16934 32C 5.14        32   Sall4     1.5200
## 16935 32C 5.15        32   Sall4     3.3900
## 16936 32C 5.16        32   Sall4     2.1400
## 16937 32C 5.17        32   Sall4     4.8000
## 16938 32C 5.18        32   Sall4     5.5250
## 16939 32C 5.19        32   Sall4     1.9600
## 16940 32C 5.20        32   Sall4     7.3200
## 16941 32C 5.21        32   Sall4     7.9300
## 16942 32C 5.22        32   Sall4     3.7500
## 16943 32C 5.23        32   Sall4     0.9250
## 16944  32C 6.1        32   Sall4     1.6650
## 16945  32C 6.2        32   Sall4     1.5800
## 16946  32C 6.3        32   Sall4     4.8600
## 16947  32C 6.4        32   Sall4     4.8400
## 16948  32C 6.6        32   Sall4     4.4000
## 16949  32C 6.7        32   Sall4     4.5850
## 16950  32C 7.1        32   Sall4     3.3600
## 16951  32C 7.2        32   Sall4     5.2550
## 16952  32C 7.3        32   Sall4     2.6650
## 16953  32C 7.4        32   Sall4     2.6650
## 16954  32C 7.5        32   Sall4     3.8700
## 16955  32C 7.6        32   Sall4     6.2150
## 16956  32C 7.8        32   Sall4     4.4600
## 16957  32C 8.1        32   Sall4     6.3000
## 16958  32C 8.2        32   Sall4     5.9150
## 16959  32C 8.4        32   Sall4     3.6250
## 16960  32C 8.5        32   Sall4     3.9450
## 16961  32C 8.6        32   Sall4     2.0600
## 16962  64C 1.1        64   Sall4     1.5550
## 16963  64C 1.2        64   Sall4     3.1550
## 16964  64C 1.3        64   Sall4     4.2900
## 16965  64C 1.4        64   Sall4     4.3050
## 16966  64C 1.5        64   Sall4     5.3300
## 16967  64C 1.6        64   Sall4     1.9400
## 16968  64C 1.7        64   Sall4     2.4950
## 16969  64C 1.8        64   Sall4     1.7450
## 16970  64C 1.9        64   Sall4     1.7450
## 16971 64C 1.10        64   Sall4     4.0750
## 16972 64C 1.11        64   Sall4     3.8650
## 16973 64C 1.12        64   Sall4     5.1400
## 16974 64C 1.13        64   Sall4     2.1250
## 16975 64C 1.14        64   Sall4     5.2600
## 16976 64C 1.15        64   Sall4     2.4300
## 16977 64C 1.16        64   Sall4     3.2850
## 16978 64C 1.17        64   Sall4     1.2550
## 16979 64C 1.18        64   Sall4     3.5150
## 16980 64C 1.19        64   Sall4     2.7850
## 16981 64C 1.20        64   Sall4     6.0300
## 16982 64C 1.21        64   Sall4     4.0950
## 16983 64C 1.22        64   Sall4     4.0725
## 16984 64C 1.23        64   Sall4     3.2000
## 16985 64C 1.24        64   Sall4     4.1400
## 16986 64C 1.25        64   Sall4     5.3400
## 16987 64C 1.26        64   Sall4     0.7000
## 16988 64C 1.27        64   Sall4     2.8050
## 16989 64C 1.28        64   Sall4     2.2800
## 16990 64C 1.29        64   Sall4     3.0200
## 16991 64C 1.30        64   Sall4     5.7350
## 16992 64C 1.31        64   Sall4     4.5325
## 16993 64C 1.32        64   Sall4     5.8550
## 16994 64C 1.33        64   Sall4     5.1250
## 16995 64C 1.34        64   Sall4    12.0950
## 16996 64C 1.35        64   Sall4    -0.0250
## 16997 64C 1.36        64   Sall4     1.2950
## 16998 64C 1.37        64   Sall4     0.8650
## 16999 64C 1.38        64   Sall4     3.5200
## 17000 64C 1.39        64   Sall4     5.4600
## 17001 64C 1.40        64   Sall4     1.5500
## 17002 64C 1.41        64   Sall4     4.6050
## 17003 64C 1.42        64   Sall4     3.1700
## 17004 64C 1.43        64   Sall4     2.5750
## 17005 64C 1.44        64   Sall4     4.2500
## 17006 64C 1.45        64   Sall4     2.8350
## 17007 64C 1.46        64   Sall4     2.8500
## 17008 64C 1.47        64   Sall4     4.4700
## 17009 64C 1.48        64   Sall4     4.6150
## 17010  64C 2.1        64   Sall4     2.6700
## 17011  64C 2.2        64   Sall4     3.1850
## 17012  64C 2.3        64   Sall4     4.4700
## 17013  64C 2.4        64   Sall4     1.8500
## 17014  64C 2.5        64   Sall4     0.6600
## 17015  64C 2.6        64   Sall4     2.8150
## 17016  64C 2.7        64   Sall4     1.5400
## 17017  64C 2.8        64   Sall4     5.1900
## 17018  64C 2.9        64   Sall4     4.3400
## 17019 64C 2.10        64   Sall4     2.2350
## 17020 64C 2.11        64   Sall4     4.4200
## 17021 64C 2.12        64   Sall4     3.9600
## 17022 64C 2.13        64   Sall4     2.8350
## 17023 64C 2.14        64   Sall4     1.5900
## 17024 64C 2.15        64   Sall4     3.9850
## 17025 64C 2.16        64   Sall4     0.9500
## 17026 64C 2.17        64   Sall4     6.5450
## 17027 64C 2.18        64   Sall4     5.7100
## 17028 64C 2.19        64   Sall4     4.2150
## 17029 64C 2.20        64   Sall4     6.1600
## 17030 64C 2.21        64   Sall4     6.1750
## 17031 64C 2.22        64   Sall4     5.3050
## 17032 64C 2.23        64   Sall4     3.0750
## 17033 64C 2.24        64   Sall4     3.5650
## 17034 64C 2.25        64   Sall4     2.2100
## 17035  64C 3.1        64   Sall4     4.1600
## 17036  64C 3.2        64   Sall4     3.7550
## 17037  64C 3.3        64   Sall4     5.1350
## 17038  64C 3.4        64   Sall4     5.2500
## 17039  64C 3.5        64   Sall4     3.5150
## 17040  64C 3.6        64   Sall4     2.9150
## 17041  64C 3.7        64   Sall4     3.0600
## 17042  64C 3.8        64   Sall4     2.8600
## 17043  64C 4.1        64   Sall4     2.0700
## 17044 64C 4.1b        64   Sall4     5.5500
## 17045  64C 4.2        64   Sall4     5.3850
## 17046  64C 4.3        64   Sall4     3.0700
## 17047  64C 4.4        64   Sall4     5.4300
## 17048  64C 4.5        64   Sall4     5.8900
## 17049  64C 4.6        64   Sall4     2.9300
## 17050  64C 4.7        64   Sall4     0.9550
## 17051  64C 4.8        64   Sall4     2.6100
## 17052  64C 4.9        64   Sall4     4.3700
## 17053 64C 4.10        64   Sall4     6.3950
## 17054 64C 4.11        64   Sall4     3.9900
## 17055 64C 4.12        64   Sall4     6.3350
## 17056 64C 4.13        64   Sall4     4.9300
## 17057 64C 4.14        64   Sall4     4.2400
## 17058 64C 4.15        64   Sall4     4.5650
## 17059 64C 4.16        64   Sall4     4.4950
## 17060 64C 4.17        64   Sall4     2.5850
## 17061 64C 4.18        64   Sall4     1.4200
## 17062 64C 4.19        64   Sall4     5.4000
## 17063 64C 4.20        64   Sall4     4.0250
## 17064 64C 4.21        64   Sall4     4.9250
## 17065 64C 4.22        64   Sall4     3.6100
## 17066 64C 4.23        64   Sall4     2.9800
## 17067 64C 4.24        64   Sall4     3.5450
## 17068 64C 4.25        64   Sall4    -0.0650
## 17069 64C 4.26        64   Sall4     1.5650
## 17070 64C 4.27        64   Sall4     3.4050
## 17071 64C 4.28        64   Sall4     3.4200
## 17072 64C 4.29        64   Sall4     5.1050
## 17073 64C 4.30        64   Sall4     5.0200
## 17074 64C 4.31        64   Sall4     3.6600
## 17075 64C 4.32        64   Sall4     3.5250
## 17076 64C 4.33        64   Sall4     2.1750
## 17077 64C 4.34        64   Sall4     2.5950
## 17078 64C 4.35        64   Sall4     1.4450
## 17079 64C 4.36        64   Sall4     4.6550
## 17080 64C 4.37        64   Sall4     5.1300
## 17081 64C 4.38        64   Sall4     3.5750
## 17082 64C 4.39        64   Sall4     7.0600
## 17083  64C 5.1        64   Sall4     2.0800
## 17084  64C 5.2        64   Sall4     2.2750
## 17085  64C 5.3        64   Sall4     0.5250
## 17086  64C 5.4        64   Sall4     3.1150
## 17087  64C 5.5        64   Sall4     0.9150
## 17088  64C 5.6        64   Sall4     3.8200
## 17089  64C 5.7        64   Sall4     3.6550
## 17090  64C 5.8        64   Sall4     4.4325
## 17091  64C 5.9        64   Sall4     2.1200
## 17092 64C 5.10        64   Sall4     2.8800
## 17093 64C 5.11        64   Sall4     3.4600
## 17094 64C 5.12        64   Sall4     1.8400
## 17095 64C 5.13        64   Sall4     3.1650
## 17096 64C 5.14        64   Sall4     1.9800
## 17097 64C 5.15        64   Sall4     5.8700
## 17098 64C 5.16        64   Sall4     7.7650
## 17099  64C 6.1        64   Sall4     1.9425
## 17100  64C 6.2        64   Sall4     3.6650
## 17101  64C 6.3        64   Sall4     4.6650
## 17102  64C 6.4        64   Sall4     2.3750
## 17103  64C 6.5        64   Sall4    -0.1850
## 17104  64C 6.6        64   Sall4     0.7950
## 17105  64C 6.7        64   Sall4     0.2850
## 17106  64C 6.8        64   Sall4     4.5900
## 17107  64C 7.1        64   Sall4     5.7500
## 17108  64C 7.2        64   Sall4     1.4000
## 17109  64C 7.3        64   Sall4     4.2750
## 17110  64C 7.4        64   Sall4     3.1500
## 17111  64C 7.5        64   Sall4     1.1550
## 17112  64C 7.6        64   Sall4     0.9200
## 17113  64C 7.7        64   Sall4     1.2150
## 17114  64C 7.8        64   Sall4     2.3600
## 17115  64C 7.9        64   Sall4     3.6400
## 17116 64C 7.10        64   Sall4     5.1750
## 17117 64C 7.11        64   Sall4     4.2700
## 17118 64C 7.12        64   Sall4     4.4150
## 17119 64C 7.13        64   Sall4     7.3400
## 17120 64C 7.14        64   Sall4     4.8300
## 17121   2C 1.1         2   Sox17     6.3550
## 17122   2C 1.2         2   Sox17     8.5850
## 17123   2C 2.1         2   Sox17    11.0900
## 17124   2C 2.2         2   Sox17     8.8800
## 17125   2C 3.1         2   Sox17     8.0850
## 17126   2C 3.2         2   Sox17     7.8400
## 17127   2C 4.1         2   Sox17     9.2600
## 17128   2C 5.1         2   Sox17     9.8850
## 17129   2C 5.2         2   Sox17     8.0000
## 17130   2C 6.1         2   Sox17     6.9700
## 17131   2C 6.2         2   Sox17     6.8650
## 17132   2C 7.1         2   Sox17     6.9800
## 17133   2C 7.2         2   Sox17     8.5200
## 17134   2C 8.1         2   Sox17     8.7600
## 17135   2C 8.2         2   Sox17     9.4800
## 17136   2C 9.1         2   Sox17     6.8300
## 17137   2C 9.2         2   Sox17     9.5200
## 17138  2C 10.1         2   Sox17     6.5150
## 17139  2C 10.2         2   Sox17     6.5950
## 17140   4C 1.1         4   Sox17     7.6800
## 17141   4C 1.2         4   Sox17    11.5700
## 17142   4C 1.3         4   Sox17     8.4800
## 17143   4C 1.4         4   Sox17     9.4550
## 17144   4C 2.1         4   Sox17     7.9650
## 17145   4C 2.2         4   Sox17     9.4650
## 17146   4C 2.3         4   Sox17     9.3850
## 17147   4C 3.1         4   Sox17     6.0100
## 17148   4C 3.2         4   Sox17     8.4750
## 17149   4C 3.3         4   Sox17     9.0150
## 17150   4C 3.4         4   Sox17     7.6100
## 17151   4C 4.1         4   Sox17    10.0900
## 17152   4C 4.2         4   Sox17     7.6850
## 17153   4C 4.3         4   Sox17     8.9250
## 17154   4C 4.4         4   Sox17     8.7550
## 17155   4C 5.1         4   Sox17    14.5650
## 17156   4C 5.2         4   Sox17     5.4100
## 17157   4C 5.3         4   Sox17     4.5650
## 17158   4C 5.4         4   Sox17     6.2500
## 17159   4C 6.1         4   Sox17     6.1650
## 17160   4C 6.2         4   Sox17     9.0050
## 17161   4C 6.3         4   Sox17     9.0800
## 17162   4C 6.4         4   Sox17    11.8100
## 17163   8C 1.1         8   Sox17     8.0600
## 17164   8C 1.2         8   Sox17     8.6000
## 17165   8C 1.3         8   Sox17     7.2950
## 17166   8C 1.4         8   Sox17     5.2350
## 17167   8C 1.5         8   Sox17     5.4100
## 17168   8C 2.1         8   Sox17     5.3650
## 17169   8C 2.2         8   Sox17     8.2750
## 17170   8C 2.3         8   Sox17    11.3575
## 17171   8C 2.4         8   Sox17     9.3800
## 17172   8C 2.5         8   Sox17     6.3950
## 17173   8C 2.6         8   Sox17     7.6600
## 17174   8C 2.7         8   Sox17     5.1100
## 17175   8C 2.8         8   Sox17     5.1350
## 17176   8C 3.1         8   Sox17     7.7100
## 17177   8C 3.2         8   Sox17     7.3450
## 17178   8C 3.3         8   Sox17     8.3500
## 17179   8C 3.4         8   Sox17     7.6425
## 17180   8C 3.5         8   Sox17    10.6050
## 17181   8C 3.6         8   Sox17     6.1150
## 17182   8C 3.7         8   Sox17     6.7750
## 17183   8C 3.8         8   Sox17     5.3150
## 17184   8C 4.2         8   Sox17     6.3700
## 17185   8C 4.3         8   Sox17     6.7250
## 17186   8C 4.4         8   Sox17     8.7250
## 17187   8C 4.5         8   Sox17     8.0750
## 17188   8C 4.6         8   Sox17     8.0850
## 17189   8C 4.7         8   Sox17     8.7750
## 17190   8C 5.1         8   Sox17     5.7000
## 17191   8C 5.2         8   Sox17     5.5350
## 17192   8C 5.3         8   Sox17    10.5100
## 17193   8C 5.4         8   Sox17     6.2150
## 17194   8C 5.5         8   Sox17    10.1350
## 17195   8C 5.6         8   Sox17     7.8800
## 17196   8C 5.7         8   Sox17    13.7550
## 17197   8C 5.8         8   Sox17     7.4650
## 17198   8C 6.1         8   Sox17     8.8350
## 17199   8C 6.2         8   Sox17     8.1050
## 17200   8C 6.3         8   Sox17     6.9100
## 17201   8C 6.4         8   Sox17     5.5150
## 17202   8C 6.5         8   Sox17     3.8750
## 17203   8C 6.6         8   Sox17     4.4650
## 17204   8C 6.7         8   Sox17     8.8800
## 17205   8C 6.8         8   Sox17     9.3150
## 17206  16C 1.1        16   Sox17     7.0800
## 17207  16C 1.2        16   Sox17    11.0700
## 17208  16C 1.3        16   Sox17     8.2450
## 17209  16C 1.4        16   Sox17     8.6150
## 17210  16C 1.5        16   Sox17     4.6100
## 17211  16C 1.6        16   Sox17     5.9500
## 17212  16C 1.7        16   Sox17     5.5050
## 17213  16C 1.8        16   Sox17     8.7400
## 17214  16C 1.9        16   Sox17     9.6250
## 17215 16C 1.10        16   Sox17     6.0750
## 17216 16C 1.11        16   Sox17     8.4650
## 17217 16C 1.12        16   Sox17     7.9950
## 17218 16C 1.13        16   Sox17     4.7350
## 17219 16C 1.14        16   Sox17     5.2100
## 17220 16C 1.15        16   Sox17     8.2600
## 17221 16C 1.16        16   Sox17     6.4850
## 17222  16C 2.1        16   Sox17     7.0450
## 17223  16C 2.2        16   Sox17     9.6650
## 17224  16C 2.3        16   Sox17     7.6050
## 17225  16C 2.4        16   Sox17     8.1450
## 17226  16C 2.5        16   Sox17    10.2800
## 17227  16C 2.6        16   Sox17     4.6400
## 17228  16C 2.7        16   Sox17     4.8250
## 17229  16C 2.8        16   Sox17     5.9050
## 17230  16C 2.9        16   Sox17     7.1400
## 17231 16C 2.10        16   Sox17     8.8400
## 17232 16C 2.11        16   Sox17     7.2050
## 17233 16C 2.12        16   Sox17     6.5100
## 17234 16C 2.13        16   Sox17    10.3500
## 17235 16C 2.14        16   Sox17     9.4950
## 17236 16C 2.15        16   Sox17     7.1500
## 17237 16C 2.16        16   Sox17     6.0800
## 17238  16C 3.1        16   Sox17     7.4350
## 17239  16C 3.2        16   Sox17     8.3800
## 17240  16C 3.3        16   Sox17     7.3000
## 17241  16C 3.4        16   Sox17    11.3700
## 17242  16C 3.5        16   Sox17    10.3500
## 17243  16C 3.6        16   Sox17     7.0900
## 17244  16C 3.7        16   Sox17     9.0000
## 17245  16C 3.8        16   Sox17     5.4350
## 17246  16C 3.9        16   Sox17     5.1250
## 17247 16C 3.10        16   Sox17     6.2400
## 17248 16C 3.11        16   Sox17     6.6400
## 17249 16C 3.12        16   Sox17    10.1500
## 17250 16C 3.13        16   Sox17    10.5950
## 17251 16C 3.14        16   Sox17     7.7350
## 17252 16C 3.15        16   Sox17     8.3450
## 17253  16C 4.1        16   Sox17     7.8150
## 17254  16C 4.2        16   Sox17     5.9500
## 17255  16C 4.3        16   Sox17     5.4750
## 17256  16C 4.4        16   Sox17     6.1450
## 17257  16C 4.5        16   Sox17     4.7100
## 17258  16C 4.6        16   Sox17     7.4700
## 17259  16C 4.7        16   Sox17     8.5050
## 17260  16C 4.8        16   Sox17     8.9050
## 17261  16C 4.9        16   Sox17     8.3250
## 17262 16C 4.10        16   Sox17     8.1350
## 17263 16C 4.11        16   Sox17     6.8500
## 17264 16C 4.12        16   Sox17     8.0150
## 17265 16C 4.13        16   Sox17     6.9700
## 17266 16C 4.14        16   Sox17     6.2850
## 17267 16C 4.15        16   Sox17     8.9750
## 17268 16C 4.16        16   Sox17     7.2900
## 17269  16C 5.1        16   Sox17     8.6700
## 17270  16C 5.2        16   Sox17     8.3200
## 17271  16C 5.3        16   Sox17     6.8500
## 17272  16C 5.4        16   Sox17     8.6250
## 17273  16C 5.5        16   Sox17     4.0450
## 17274  16C 5.6        16   Sox17     4.5200
## 17275  16C 5.7        16   Sox17     4.6950
## 17276  16C 5.8        16   Sox17     8.5050
## 17277  16C 5.9        16   Sox17    10.7975
## 17278 16C 5.10        16   Sox17     8.8000
## 17279 16C 5.11        16   Sox17     7.9650
## 17280 16C 5.12        16   Sox17     6.8100
## 17281  32C 1.1        32   Sox17     7.3000
## 17282  32C 1.2        32   Sox17     4.8050
## 17283  32C 1.3        32   Sox17     7.1100
## 17284  32C 1.4        32   Sox17     8.5050
## 17285  32C 1.5        32   Sox17     9.6200
## 17286  32C 1.6        32   Sox17     4.2825
## 17287  32C 1.7        32   Sox17     8.1650
## 17288  32C 1.8        32   Sox17     9.0150
## 17289  32C 1.9        32   Sox17     6.1150
## 17290 32C 1.10        32   Sox17     0.3050
## 17291 32C 1.11        32   Sox17     6.2000
## 17292 32C 1.12        32   Sox17     6.2250
## 17293 32C 1.13        32   Sox17     5.8350
## 17294 32C 1.14        32   Sox17     7.7950
## 17295 32C 1.15        32   Sox17     5.7850
## 17296 32C 1.16        32   Sox17     5.2250
## 17297 32C 1.17        32   Sox17     1.1500
## 17298 32C 1.18        32   Sox17     6.4450
## 17299 32C 1.19        32   Sox17     3.4300
## 17300 32C 1.20        32   Sox17     4.0750
## 17301 32C 1.21        32   Sox17     3.6850
## 17302  32C 2.1        32   Sox17     7.7000
## 17303  32C 2.2        32   Sox17     7.7050
## 17304  32C 2.3        32   Sox17     7.3850
## 17305  32C 2.4        32   Sox17     8.4050
## 17306  32C 2.5        32   Sox17     7.0150
## 17307  32C 2.6        32   Sox17     6.7600
## 17308  32C 2.7        32   Sox17     4.4950
## 17309  32C 2.8        32   Sox17     2.5150
## 17310  32C 2.9        32   Sox17     4.9350
## 17311 32C 2.10        32   Sox17     6.2800
## 17312 32C 2.11        32   Sox17     9.0950
## 17313 32C 2.12        32   Sox17     7.4000
## 17314 32C 2.13        32   Sox17     7.5300
## 17315 32C 2.14        32   Sox17     8.7950
## 17316 32C 2.15        32   Sox17     6.3750
## 17317 32C 2.16        32   Sox17     1.4200
## 17318  32C 3.1        32   Sox17     5.1100
## 17319  32C 3.2        32   Sox17     4.7950
## 17320  32C 3.3        32   Sox17     7.8600
## 17321  32C 3.4        32   Sox17     8.2950
## 17322  32C 3.5        32   Sox17     6.4950
## 17323  32C 3.6        32   Sox17     9.8050
## 17324  32C 3.7        32   Sox17    10.4150
## 17325  32C 3.8        32   Sox17     3.2750
## 17326  32C 4.1        32   Sox17     7.4500
## 17327  32C 4.2        32   Sox17     5.9700
## 17328  32C 4.3        32   Sox17     4.5750
## 17329  32C 4.4        32   Sox17     4.5350
## 17330  32C 4.5        32   Sox17     5.3250
## 17331  32C 4.6        32   Sox17     7.5450
## 17332  32C 4.7        32   Sox17     6.8750
## 17333  32C 4.8        32   Sox17     9.3400
## 17334 32C 4.10        32   Sox17     6.6700
## 17335 32C 4.11        32   Sox17     6.5550
## 17336 32C 4.12        32   Sox17     7.0050
## 17337 32C 4.13        32   Sox17     6.3300
## 17338 32C 4.14        32   Sox17     7.7200
## 17339 32C 4.15        32   Sox17     7.3450
## 17340 32C 4.16        32   Sox17     3.3200
## 17341 32C 4.17        32   Sox17     7.6500
## 17342 32C 4.18        32   Sox17     6.9850
## 17343 32C 4.19        32   Sox17     6.9700
## 17344 32C 4.20        32   Sox17     7.1100
## 17345 32C 4.21        32   Sox17     6.6350
## 17346 32C 4.22        32   Sox17     5.7700
## 17347 32C 4.23        32   Sox17     9.6400
## 17348 32C 4.24        32   Sox17     8.2000
## 17349  32C 5.1        32   Sox17     7.7900
## 17350  32C 5.2        32   Sox17     8.5900
## 17351  32C 5.3        32   Sox17     7.3500
## 17352  32C 5.4        32   Sox17     5.6850
## 17353  32C 5.5        32   Sox17     5.8750
## 17354  32C 5.6        32   Sox17    12.6200
## 17355  32C 5.7        32   Sox17     5.1800
## 17356  32C 5.8        32   Sox17     7.5300
## 17357  32C 5.9        32   Sox17     8.1550
## 17358 32C 5.10        32   Sox17     4.8650
## 17359 32C 5.11        32   Sox17    13.9050
## 17360 32C 5.12        32   Sox17     8.4950
## 17361 32C 5.13        32   Sox17     6.8000
## 17362 32C 5.14        32   Sox17     7.3050
## 17363 32C 5.15        32   Sox17     5.4850
## 17364 32C 5.16        32   Sox17     7.0900
## 17365 32C 5.17        32   Sox17    10.2700
## 17366 32C 5.18        32   Sox17     8.7750
## 17367 32C 5.19        32   Sox17     7.0350
## 17368 32C 5.20        32   Sox17     6.5350
## 17369 32C 5.21        32   Sox17    10.4150
## 17370 32C 5.22        32   Sox17     5.4500
## 17371 32C 5.23        32   Sox17     2.5050
## 17372  32C 6.1        32   Sox17     7.8000
## 17373  32C 6.2        32   Sox17     7.1150
## 17374  32C 6.3        32   Sox17     8.6300
## 17375  32C 6.4        32   Sox17     8.4100
## 17376  32C 6.6        32   Sox17     8.2000
## 17377  32C 6.7        32   Sox17     7.5200
## 17378  32C 7.1        32   Sox17     7.0350
## 17379  32C 7.2        32   Sox17     9.1150
## 17380  32C 7.3        32   Sox17     4.8150
## 17381  32C 7.4        32   Sox17     4.8250
## 17382  32C 7.5        32   Sox17     6.3300
## 17383  32C 7.6        32   Sox17     8.1950
## 17384  32C 7.8        32   Sox17    10.0025
## 17385  32C 8.1        32   Sox17     7.8800
## 17386  32C 8.2        32   Sox17     6.7950
## 17387  32C 8.4        32   Sox17     7.1500
## 17388  32C 8.5        32   Sox17     7.2150
## 17389  32C 8.6        32   Sox17     6.0200
## 17390  64C 1.1        64   Sox17     5.4500
## 17391  64C 1.2        64   Sox17     8.1950
## 17392  64C 1.3        64   Sox17     9.0400
## 17393  64C 1.4        64   Sox17     4.9925
## 17394  64C 1.5        64   Sox17     5.7550
## 17395  64C 1.6        64   Sox17     8.6550
## 17396  64C 1.7        64   Sox17     4.6450
## 17397  64C 1.8        64   Sox17     5.9150
## 17398  64C 1.9        64   Sox17     3.7500
## 17399 64C 1.10        64   Sox17     5.1850
## 17400 64C 1.11        64   Sox17     6.6750
## 17401 64C 1.12        64   Sox17    11.2750
## 17402 64C 1.13        64   Sox17     5.8650
## 17403 64C 1.14        64   Sox17     7.5050
## 17404 64C 1.15        64   Sox17     5.2300
## 17405 64C 1.16        64   Sox17     5.1750
## 17406 64C 1.17        64   Sox17     5.4500
## 17407 64C 1.18        64   Sox17     5.8650
## 17408 64C 1.19        64   Sox17     5.0650
## 17409 64C 1.20        64   Sox17     9.0900
## 17410 64C 1.21        64   Sox17     6.8350
## 17411 64C 1.22        64   Sox17     7.6150
## 17412 64C 1.23        64   Sox17     8.2850
## 17413 64C 1.24        64   Sox17     6.6050
## 17414 64C 1.25        64   Sox17     7.3800
## 17415 64C 1.26        64   Sox17     3.3350
## 17416 64C 1.27        64   Sox17     6.2850
## 17417 64C 1.28        64   Sox17     4.4250
## 17418 64C 1.29        64   Sox17     7.2500
## 17419 64C 1.30        64   Sox17     7.6050
## 17420 64C 1.31        64   Sox17     7.3400
## 17421 64C 1.32        64   Sox17     7.8500
## 17422 64C 1.33        64   Sox17     6.9550
## 17423 64C 1.34        64   Sox17     7.5450
## 17424 64C 1.35        64   Sox17     4.3800
## 17425 64C 1.36        64   Sox17    11.1900
## 17426 64C 1.37        64   Sox17     6.3950
## 17427 64C 1.38        64   Sox17     7.4200
## 17428 64C 1.39        64   Sox17     8.5850
## 17429 64C 1.40        64   Sox17     5.7750
## 17430 64C 1.41        64   Sox17     7.9550
## 17431 64C 1.42        64   Sox17     9.7950
## 17432 64C 1.43        64   Sox17     3.9450
## 17433 64C 1.44        64   Sox17     6.1700
## 17434 64C 1.45        64   Sox17     4.5200
## 17435 64C 1.46        64   Sox17     7.2950
## 17436 64C 1.47        64   Sox17     7.2150
## 17437 64C 1.48        64   Sox17    11.5450
## 17438  64C 2.1        64   Sox17     8.1450
## 17439  64C 2.2        64   Sox17     7.2950
## 17440  64C 2.3        64   Sox17     8.1900
## 17441  64C 2.4        64   Sox17     5.4300
## 17442  64C 2.5        64   Sox17     2.4950
## 17443  64C 2.6        64   Sox17     5.5450
## 17444  64C 2.7        64   Sox17     2.0300
## 17445  64C 2.8        64   Sox17     6.3500
## 17446  64C 2.9        64   Sox17     8.2250
## 17447 64C 2.10        64   Sox17     5.6400
## 17448 64C 2.11        64   Sox17     7.6500
## 17449 64C 2.12        64   Sox17     6.4150
## 17450 64C 2.13        64   Sox17     7.2400
## 17451 64C 2.14        64   Sox17     5.7000
## 17452 64C 2.15        64   Sox17     8.0250
## 17453 64C 2.16        64   Sox17     3.3500
## 17454 64C 2.17        64   Sox17     6.7600
## 17455 64C 2.18        64   Sox17     7.6700
## 17456 64C 2.19        64   Sox17    10.4800
## 17457 64C 2.20        64   Sox17     7.2000
## 17458 64C 2.21        64   Sox17     8.3600
## 17459 64C 2.22        64   Sox17     6.0950
## 17460 64C 2.23        64   Sox17     4.4250
## 17461 64C 2.24        64   Sox17     8.8500
## 17462 64C 2.25        64   Sox17     6.2200
## 17463  64C 3.1        64   Sox17     9.0500
## 17464  64C 3.2        64   Sox17     8.6350
## 17465  64C 3.3        64   Sox17     7.8550
## 17466  64C 3.4        64   Sox17     8.8450
## 17467  64C 3.5        64   Sox17     5.6650
## 17468  64C 3.6        64   Sox17     5.6500
## 17469  64C 3.7        64   Sox17     5.2250
## 17470  64C 3.8        64   Sox17     5.6950
## 17471  64C 4.1        64   Sox17     5.4500
## 17472 64C 4.1b        64   Sox17     8.7000
## 17473  64C 4.2        64   Sox17     7.8250
## 17474  64C 4.3        64   Sox17     5.4450
## 17475  64C 4.4        64   Sox17     5.4650
## 17476  64C 4.5        64   Sox17     7.7550
## 17477  64C 4.6        64   Sox17     3.4600
## 17478  64C 4.7        64   Sox17     3.1750
## 17479  64C 4.8        64   Sox17     4.1900
## 17480  64C 4.9        64   Sox17     7.3750
## 17481 64C 4.10        64   Sox17     8.7250
## 17482 64C 4.11        64   Sox17     7.6100
## 17483 64C 4.12        64   Sox17    10.1700
## 17484 64C 4.13        64   Sox17     9.1500
## 17485 64C 4.14        64   Sox17     8.6400
## 17486 64C 4.15        64   Sox17     5.8250
## 17487 64C 4.16        64   Sox17     5.4250
## 17488 64C 4.17        64   Sox17     3.9300
## 17489 64C 4.18        64   Sox17     5.8850
## 17490 64C 4.19        64   Sox17     8.8650
## 17491 64C 4.20        64   Sox17     8.2375
## 17492 64C 4.21        64   Sox17     7.3300
## 17493 64C 4.22        64   Sox17     4.9750
## 17494 64C 4.23        64   Sox17     5.6900
## 17495 64C 4.24        64   Sox17     8.6900
## 17496 64C 4.25        64   Sox17     5.7850
## 17497 64C 4.26        64   Sox17     3.8800
## 17498 64C 4.27        64   Sox17     8.3650
## 17499 64C 4.28        64   Sox17     6.0300
## 17500 64C 4.29        64   Sox17    12.5725
## 17501 64C 4.30        64   Sox17     4.7350
## 17502 64C 4.31        64   Sox17     6.0050
## 17503 64C 4.32        64   Sox17     1.7150
## 17504 64C 4.33        64   Sox17     3.8250
## 17505 64C 4.34        64   Sox17     5.3500
## 17506 64C 4.35        64   Sox17     2.5450
## 17507 64C 4.36        64   Sox17     5.9750
## 17508 64C 4.37        64   Sox17     4.5850
## 17509 64C 4.38        64   Sox17     7.3950
## 17510 64C 4.39        64   Sox17     8.3950
## 17511  64C 5.1        64   Sox17     5.9400
## 17512  64C 5.2        64   Sox17     2.3150
## 17513  64C 5.3        64   Sox17     2.7700
## 17514  64C 5.4        64   Sox17     5.9950
## 17515  64C 5.5        64   Sox17     1.7150
## 17516  64C 5.6        64   Sox17     5.6900
## 17517  64C 5.7        64   Sox17     6.7850
## 17518  64C 5.8        64   Sox17    12.7250
## 17519  64C 5.9        64   Sox17     4.9550
## 17520 64C 5.10        64   Sox17     3.9450
## 17521 64C 5.11        64   Sox17     8.4100
## 17522 64C 5.12        64   Sox17     5.4350
## 17523 64C 5.13        64   Sox17     5.0750
## 17524 64C 5.14        64   Sox17     5.2050
## 17525 64C 5.15        64   Sox17     3.4000
## 17526 64C 5.16        64   Sox17     7.1250
## 17527  64C 6.1        64   Sox17     4.3400
## 17528  64C 6.2        64   Sox17     9.7400
## 17529  64C 6.3        64   Sox17     8.3950
## 17530  64C 6.4        64   Sox17     6.7450
## 17531  64C 6.5        64   Sox17     1.7400
## 17532  64C 6.6        64   Sox17    11.1900
## 17533  64C 6.7        64   Sox17     3.6750
## 17534  64C 6.8        64   Sox17     3.0700
## 17535  64C 7.1        64   Sox17     7.4550
## 17536  64C 7.2        64   Sox17     5.5050
## 17537  64C 7.3        64   Sox17     8.2550
## 17538  64C 7.4        64   Sox17     5.6550
## 17539  64C 7.5        64   Sox17     1.8850
## 17540  64C 7.6        64   Sox17     3.2500
## 17541  64C 7.7        64   Sox17     3.4200
## 17542  64C 7.8        64   Sox17     4.8150
## 17543  64C 7.9        64   Sox17     7.8550
## 17544 64C 7.10        64   Sox17     8.6450
## 17545 64C 7.11        64   Sox17     8.9650
## 17546 64C 7.12        64   Sox17     6.6250
## 17547 64C 7.13        64   Sox17    11.3400
## 17548 64C 7.14        64   Sox17     5.6100
## 17549   2C 1.1         2   Snail    -0.6150
## 17550   2C 1.2         2   Snail    -0.1400
## 17551   2C 2.1         2   Snail     1.0350
## 17552   2C 2.2         2   Snail     2.1800
## 17553   2C 3.1         2   Snail     1.1000
## 17554   2C 3.2         2   Snail    -0.9600
## 17555   2C 4.1         2   Snail     1.8800
## 17556   2C 5.1         2   Snail     0.9700
## 17557   2C 5.2         2   Snail     0.7850
## 17558   2C 6.1         2   Snail    -0.7850
## 17559   2C 6.2         2   Snail    -0.7950
## 17560   2C 7.1         2   Snail    -1.5050
## 17561   2C 7.2         2   Snail     1.3900
## 17562   2C 8.1         2   Snail    -0.1050
## 17563   2C 8.2         2   Snail     0.7450
## 17564   2C 9.1         2   Snail    -2.2600
## 17565   2C 9.2         2   Snail     2.0300
## 17566  2C 10.1         2   Snail    -0.4850
## 17567  2C 10.2         2   Snail    -0.0750
## 17568   4C 1.1         4   Snail     3.1600
## 17569   4C 1.2         4   Snail     3.7900
## 17570   4C 1.3         4   Snail     4.0950
## 17571   4C 1.4         4   Snail     3.3050
## 17572   4C 2.1         4   Snail     1.6350
## 17573   4C 2.2         4   Snail     3.4400
## 17574   4C 2.3         4   Snail     3.0450
## 17575   4C 3.1         4   Snail     2.9150
## 17576   4C 3.2         4   Snail     2.6500
## 17577   4C 3.3         4   Snail     1.8700
## 17578   4C 3.4         4   Snail     2.0150
## 17579   4C 4.1         4   Snail     6.1450
## 17580   4C 4.2         4   Snail     3.5700
## 17581   4C 4.3         4   Snail     3.6000
## 17582   4C 4.4         4   Snail     3.7000
## 17583   4C 5.1         4   Snail     3.5400
## 17584   4C 5.2         4   Snail     2.6150
## 17585   4C 5.3         4   Snail     0.6250
## 17586   4C 5.4         4   Snail     3.1150
## 17587   4C 6.1         4   Snail     0.4150
## 17588   4C 6.2         4   Snail     3.8550
## 17589   4C 6.3         4   Snail     5.9150
## 17590   4C 6.4         4   Snail     5.5800
## 17591   8C 1.1         8   Snail    13.2550
## 17592   8C 1.2         8   Snail     5.6000
## 17593   8C 1.3         8   Snail     4.3600
## 17594   8C 1.4         8   Snail     1.6650
## 17595   8C 1.5         8   Snail     5.1800
## 17596   8C 2.1         8   Snail     3.2100
## 17597   8C 2.2         8   Snail     8.4100
## 17598   8C 2.3         8   Snail     5.7350
## 17599   8C 2.4         8   Snail     6.1400
## 17600   8C 2.5         8   Snail     6.1100
## 17601   8C 2.6         8   Snail     5.9200
## 17602   8C 2.7         8   Snail    10.9850
## 17603   8C 2.8         8   Snail     3.3550
## 17604   8C 3.1         8   Snail     4.6300
## 17605   8C 3.2         8   Snail     6.1900
## 17606   8C 3.3         8   Snail     4.6750
## 17607   8C 3.4         8   Snail     4.7825
## 17608   8C 3.5         8   Snail     5.3900
## 17609   8C 3.6         8   Snail     2.1600
## 17610   8C 3.7         8   Snail     3.0350
## 17611   8C 3.8         8   Snail     1.1450
## 17612   8C 4.2         8   Snail     9.5550
## 17613   8C 4.3         8   Snail     1.3300
## 17614   8C 4.4         8   Snail     5.9100
## 17615   8C 4.5         8   Snail    10.5650
## 17616   8C 4.6         8   Snail     3.5200
## 17617   8C 4.7         8   Snail     2.7400
## 17618   8C 5.1         8   Snail     4.3150
## 17619   8C 5.2         8   Snail     1.0750
## 17620   8C 5.3         8   Snail    -0.4750
## 17621   8C 5.4         8   Snail     3.8350
## 17622   8C 5.5         8   Snail     2.5900
## 17623   8C 5.6         8   Snail     2.6900
## 17624   8C 5.7         8   Snail     3.2000
## 17625   8C 5.8         8   Snail     5.0500
## 17626   8C 6.1         8   Snail     4.5600
## 17627   8C 6.2         8   Snail     4.7250
## 17628   8C 6.3         8   Snail     3.2500
## 17629   8C 6.4         8   Snail     3.9950
## 17630   8C 6.5         8   Snail     5.4250
## 17631   8C 6.6         8   Snail     6.1200
## 17632   8C 6.7         8   Snail     6.0250
## 17633   8C 6.8         8   Snail     5.7300
## 17634  16C 1.1        16   Snail     8.7900
## 17635  16C 1.2        16   Snail     5.4900
## 17636  16C 1.3        16   Snail     5.5850
## 17637  16C 1.4        16   Snail     5.5300
## 17638  16C 1.5        16   Snail     1.8100
## 17639  16C 1.6        16   Snail     5.2850
## 17640  16C 1.7        16   Snail     5.5050
## 17641  16C 1.8        16   Snail     9.5400
## 17642  16C 1.9        16   Snail     7.0050
## 17643 16C 1.10        16   Snail     5.0800
## 17644 16C 1.11        16   Snail     9.9450
## 17645 16C 1.12        16   Snail     6.4900
## 17646 16C 1.13        16   Snail     4.1650
## 17647 16C 1.14        16   Snail     2.5250
## 17648 16C 1.15        16   Snail     2.8850
## 17649 16C 1.16        16   Snail     6.1450
## 17650  16C 2.1        16   Snail    15.2850
## 17651  16C 2.2        16   Snail     9.5650
## 17652  16C 2.3        16   Snail    12.3750
## 17653  16C 2.4        16   Snail    14.8800
## 17654  16C 2.5        16   Snail     6.8450
## 17655  16C 2.6        16   Snail     4.7750
## 17656  16C 2.7        16   Snail     6.2350
## 17657  16C 2.8        16   Snail     6.6300
## 17658  16C 2.9        16   Snail     7.7550
## 17659 16C 2.10        16   Snail     4.7600
## 17660 16C 2.11        16   Snail     6.8800
## 17661 16C 2.12        16   Snail     6.2300
## 17662 16C 2.13        16   Snail     9.8800
## 17663 16C 2.14        16   Snail    10.1600
## 17664 16C 2.15        16   Snail     9.4650
## 17665 16C 2.16        16   Snail     5.1250
## 17666  16C 3.1        16   Snail     9.3750
## 17667  16C 3.2        16   Snail     7.1150
## 17668  16C 3.3        16   Snail     8.4900
## 17669  16C 3.4        16   Snail     8.5850
## 17670  16C 3.5        16   Snail     6.9350
## 17671  16C 3.6        16   Snail     3.1400
## 17672  16C 3.7        16   Snail    13.8600
## 17673  16C 3.8        16   Snail     6.9950
## 17674  16C 3.9        16   Snail     8.8150
## 17675 16C 3.10        16   Snail     8.1000
## 17676 16C 3.11        16   Snail    11.7300
## 17677 16C 3.12        16   Snail    13.2150
## 17678 16C 3.13        16   Snail     9.2450
## 17679 16C 3.14        16   Snail    12.7650
## 17680 16C 3.15        16   Snail     7.2200
## 17681  16C 4.1        16   Snail     8.8350
## 17682  16C 4.2        16   Snail     3.2650
## 17683  16C 4.3        16   Snail     2.1600
## 17684  16C 4.4        16   Snail     3.9500
## 17685  16C 4.5        16   Snail     5.3150
## 17686  16C 4.6        16   Snail     9.3050
## 17687  16C 4.7        16   Snail     9.1200
## 17688  16C 4.8        16   Snail    13.3900
## 17689  16C 4.9        16   Snail     7.4600
## 17690 16C 4.10        16   Snail     9.0800
## 17691 16C 4.11        16   Snail     6.5250
## 17692 16C 4.12        16   Snail     6.7650
## 17693 16C 4.13        16   Snail     6.2350
## 17694 16C 4.14        16   Snail     5.2850
## 17695 16C 4.15        16   Snail     6.3950
## 17696 16C 4.16        16   Snail     8.3950
## 17697  16C 5.1        16   Snail     8.2300
## 17698  16C 5.2        16   Snail     6.1150
## 17699  16C 5.3        16   Snail     8.1500
## 17700  16C 5.4        16   Snail     3.9300
## 17701  16C 5.5        16   Snail     2.3250
## 17702  16C 5.6        16   Snail     4.2000
## 17703  16C 5.7        16   Snail     3.6300
## 17704  16C 5.8        16   Snail    10.1200
## 17705  16C 5.9        16   Snail     6.0950
## 17706 16C 5.10        16   Snail     5.8600
## 17707 16C 5.11        16   Snail     6.9700
## 17708 16C 5.12        16   Snail     1.9000
## 17709  32C 1.1        32   Snail     5.3650
## 17710  32C 1.2        32   Snail     1.6950
## 17711  32C 1.3        32   Snail    12.5800
## 17712  32C 1.4        32   Snail    12.3000
## 17713  32C 1.5        32   Snail    13.1150
## 17714  32C 1.6        32   Snail     5.9725
## 17715  32C 1.7        32   Snail    13.8100
## 17716  32C 1.8        32   Snail     2.7000
## 17717  32C 1.9        32   Snail     4.2650
## 17718 32C 1.10        32   Snail     1.2250
## 17719 32C 1.11        32   Snail    12.3050
## 17720 32C 1.12        32   Snail    10.4200
## 17721 32C 1.13        32   Snail     6.4100
## 17722 32C 1.14        32   Snail    14.1050
## 17723 32C 1.15        32   Snail     3.3500
## 17724 32C 1.16        32   Snail     4.7800
## 17725 32C 1.17        32   Snail     3.4650
## 17726 32C 1.18        32   Snail     4.2850
## 17727 32C 1.19        32   Snail     2.6250
## 17728 32C 1.20        32   Snail     3.4550
## 17729 32C 1.21        32   Snail     3.4000
## 17730  32C 2.1        32   Snail     7.7800
## 17731  32C 2.2        32   Snail     8.5200
## 17732  32C 2.3        32   Snail    12.7400
## 17733  32C 2.4        32   Snail     5.5000
## 17734  32C 2.5        32   Snail     3.4750
## 17735  32C 2.6        32   Snail    11.8900
## 17736  32C 2.7        32   Snail     5.0450
## 17737  32C 2.8        32   Snail     1.8150
## 17738  32C 2.9        32   Snail     3.7100
## 17739 32C 2.10        32   Snail    14.7350
## 17740 32C 2.11        32   Snail     5.6100
## 17741 32C 2.12        32   Snail    12.9700
## 17742 32C 2.13        32   Snail     8.8600
## 17743 32C 2.14        32   Snail     4.6250
## 17744 32C 2.15        32   Snail     2.5400
## 17745 32C 2.16        32   Snail     0.9700
## 17746  32C 3.1        32   Snail    11.3150
## 17747  32C 3.2        32   Snail     8.3650
## 17748  32C 3.3        32   Snail    13.3600
## 17749  32C 3.4        32   Snail    11.0750
## 17750  32C 3.5        32   Snail    12.7800
## 17751  32C 3.6        32   Snail     6.0850
## 17752  32C 3.7        32   Snail     7.6100
## 17753  32C 3.8        32   Snail     3.7950
## 17754  32C 4.1        32   Snail    11.0450
## 17755  32C 4.2        32   Snail     9.8950
## 17756  32C 4.3        32   Snail    11.5850
## 17757  32C 4.4        32   Snail     6.9150
## 17758  32C 4.5        32   Snail     9.4350
## 17759  32C 4.6        32   Snail    12.3750
## 17760  32C 4.7        32   Snail    14.8800
## 17761  32C 4.8        32   Snail    11.0650
## 17762 32C 4.10        32   Snail     5.5750
## 17763 32C 4.11        32   Snail     6.4050
## 17764 32C 4.12        32   Snail    12.4100
## 17765 32C 4.13        32   Snail    12.4750
## 17766 32C 4.14        32   Snail     8.6700
## 17767 32C 4.15        32   Snail     5.0000
## 17768 32C 4.16        32   Snail     3.2500
## 17769 32C 4.17        32   Snail    13.9100
## 17770 32C 4.18        32   Snail    13.7500
## 17771 32C 4.19        32   Snail     8.2250
## 17772 32C 4.20        32   Snail     6.8350
## 17773 32C 4.21        32   Snail     7.4750
## 17774 32C 4.22        32   Snail     2.6650
## 17775 32C 4.23        32   Snail    14.2400
## 17776 32C 4.24        32   Snail    12.6150
## 17777  32C 5.1        32   Snail    13.4350
## 17778  32C 5.2        32   Snail     6.1700
## 17779  32C 5.3        32   Snail     6.4200
## 17780  32C 5.4        32   Snail    11.5150
## 17781  32C 5.5        32   Snail    11.6750
## 17782  32C 5.6        32   Snail    12.6600
## 17783  32C 5.7        32   Snail    11.7300
## 17784  32C 5.8        32   Snail     5.2250
## 17785  32C 5.9        32   Snail    13.8250
## 17786 32C 5.10        32   Snail     3.8750
## 17787 32C 5.11        32   Snail    13.1700
## 17788 32C 5.12        32   Snail    13.7550
## 17789 32C 5.13        32   Snail     7.3250
## 17790 32C 5.14        32   Snail    11.2700
## 17791 32C 5.15        32   Snail    11.3700
## 17792 32C 5.16        32   Snail    11.2450
## 17793 32C 5.17        32   Snail    14.8150
## 17794 32C 5.18        32   Snail    14.1800
## 17795 32C 5.19        32   Snail     5.5100
## 17796 32C 5.20        32   Snail    13.9800
## 17797 32C 5.21        32   Snail    13.1900
## 17798 32C 5.22        32   Snail    11.6950
## 17799 32C 5.23        32   Snail    10.4750
## 17800  32C 6.1        32   Snail     6.5350
## 17801  32C 6.2        32   Snail    10.5250
## 17802  32C 6.3        32   Snail    13.5550
## 17803  32C 6.4        32   Snail     7.5950
## 17804  32C 6.6        32   Snail    10.2300
## 17805  32C 6.7        32   Snail     8.2300
## 17806  32C 7.1        32   Snail    12.7900
## 17807  32C 7.2        32   Snail     7.0050
## 17808  32C 7.3        32   Snail    10.7750
## 17809  32C 7.4        32   Snail    11.6800
## 17810  32C 7.5        32   Snail     7.6200
## 17811  32C 7.6        32   Snail    14.4400
## 17812  32C 7.8        32   Snail    13.7850
## 17813  32C 8.1        32   Snail    13.4000
## 17814  32C 8.2        32   Snail    13.2600
## 17815  32C 8.4        32   Snail     7.9600
## 17816  32C 8.5        32   Snail     8.9850
## 17817  32C 8.6        32   Snail     9.6150
## 17818  64C 1.1        64   Snail     4.8700
## 17819  64C 1.2        64   Snail    12.3000
## 17820  64C 1.3        64   Snail     9.9650
## 17821  64C 1.4        64   Snail     5.7225
## 17822  64C 1.5        64   Snail     6.1900
## 17823  64C 1.6        64   Snail    11.9800
## 17824  64C 1.7        64   Snail     6.2850
## 17825  64C 1.8        64   Snail    10.6250
## 17826  64C 1.9        64   Snail     5.1350
## 17827 64C 1.10        64   Snail    10.4200
## 17828 64C 1.11        64   Snail     6.5100
## 17829 64C 1.12        64   Snail    14.1050
## 17830 64C 1.13        64   Snail     7.6200
## 17831 64C 1.14        64   Snail     9.1300
## 17832 64C 1.15        64   Snail    13.5250
## 17833 64C 1.16        64   Snail     9.2550
## 17834 64C 1.17        64   Snail    10.2250
## 17835 64C 1.18        64   Snail    12.6350
## 17836 64C 1.19        64   Snail    10.8400
## 17837 64C 1.20        64   Snail    13.0100
## 17838 64C 1.21        64   Snail     5.9700
## 17839 64C 1.22        64   Snail     7.7200
## 17840 64C 1.23        64   Snail     9.8300
## 17841 64C 1.24        64   Snail    11.9650
## 17842 64C 1.25        64   Snail    11.8900
## 17843 64C 1.26        64   Snail     2.9350
## 17844 64C 1.27        64   Snail    11.3150
## 17845 64C 1.28        64   Snail     9.3900
## 17846 64C 1.29        64   Snail    14.7350
## 17847 64C 1.30        64   Snail    13.8200
## 17848 64C 1.31        64   Snail    12.9700
## 17849 64C 1.32        64   Snail    14.8300
## 17850 64C 1.33        64   Snail    12.7150
## 17851 64C 1.34        64   Snail    11.5100
## 17852 64C 1.35        64   Snail     9.2200
## 17853 64C 1.36        64   Snail    11.3150
## 17854 64C 1.37        64   Snail    11.0750
## 17855 64C 1.38        64   Snail    13.3600
## 17856 64C 1.39        64   Snail    14.2750
## 17857 64C 1.40        64   Snail     6.4800
## 17858 64C 1.41        64   Snail     6.9350
## 17859 64C 1.42        64   Snail     9.7600
## 17860 64C 1.43        64   Snail     3.3450
## 17861 64C 1.44        64   Snail    11.0450
## 17862 64C 1.45        64   Snail     9.8950
## 17863 64C 1.46        64   Snail    11.5850
## 17864 64C 1.47        64   Snail    15.2850
## 17865 64C 1.48        64   Snail    13.8650
## 17866  64C 2.1        64   Snail     9.2250
## 17867  64C 2.2        64   Snail    14.8800
## 17868  64C 2.3        64   Snail    13.5150
## 17869  64C 2.4        64   Snail    11.9550
## 17870  64C 2.5        64   Snail     5.9650
## 17871  64C 2.6        64   Snail    12.4100
## 17872  64C 2.7        64   Snail     3.7250
## 17873  64C 2.8        64   Snail     8.1900
## 17874  64C 2.9        64   Snail    13.4100
## 17875 64C 2.10        64   Snail    11.5100
## 17876 64C 2.11        64   Snail    13.9100
## 17877 64C 2.12        64   Snail    13.7500
## 17878 64C 2.13        64   Snail    13.2950
## 17879 64C 2.14        64   Snail    11.4450
## 17880 64C 2.15        64   Snail    12.3950
## 17881 64C 2.16        64   Snail     6.3950
## 17882 64C 2.17        64   Snail    12.7900
## 17883 64C 2.18        64   Snail    12.6150
## 17884 64C 2.19        64   Snail    13.4350
## 17885 64C 2.20        64   Snail     9.9600
## 17886 64C 2.21        64   Snail    13.8600
## 17887 64C 2.22        64   Snail    11.5150
## 17888 64C 2.23        64   Snail    11.6750
## 17889 64C 2.24        64   Snail    12.6600
## 17890 64C 2.25        64   Snail    11.7300
## 17891  64C 3.1        64   Snail    13.2150
## 17892  64C 3.2        64   Snail    13.8250
## 17893  64C 3.3        64   Snail    12.7650
## 17894  64C 3.4        64   Snail    13.1700
## 17895  64C 3.5        64   Snail     5.8350
## 17896  64C 3.6        64   Snail    11.6550
## 17897  64C 3.7        64   Snail    11.2700
## 17898  64C 3.8        64   Snail    11.3700
## 17899  64C 4.1        64   Snail     4.0950
## 17900 64C 4.1b        64   Snail    10.1850
## 17901  64C 4.2        64   Snail    14.1800
## 17902  64C 4.3        64   Snail     6.9500
## 17903  64C 4.4        64   Snail     8.2400
## 17904  64C 4.5        64   Snail    13.1900
## 17905  64C 4.6        64   Snail     6.4750
## 17906  64C 4.7        64   Snail    10.4750
## 17907  64C 4.8        64   Snail     5.0250
## 17908  64C 4.9        64   Snail    10.5250
## 17909 64C 4.10        64   Snail     7.0850
## 17910 64C 4.11        64   Snail    14.2150
## 17911 64C 4.12        64   Snail    14.1500
## 17912 64C 4.13        64   Snail    13.2550
## 17913 64C 4.14        64   Snail    12.7900
## 17914 64C 4.15        64   Snail    11.2700
## 17915 64C 4.16        64   Snail    10.7750
## 17916 64C 4.17        64   Snail    11.6800
## 17917 64C 4.18        64   Snail     7.8800
## 17918 64C 4.19        64   Snail    14.4400
## 17919 64C 4.20        64   Snail    13.7850
## 17920 64C 4.21        64   Snail    13.4000
## 17921 64C 4.22        64   Snail    13.2600
## 17922 64C 4.23        64   Snail    11.9000
## 17923 64C 4.24        64   Snail    10.9850
## 17924 64C 4.25        64   Snail     9.6150
## 17925 64C 4.26        64   Snail     7.8700
## 17926 64C 4.27        64   Snail    12.3000
## 17927 64C 4.28        64   Snail     4.0450
## 17928 64C 4.29        64   Snail    13.6125
## 17929 64C 4.30        64   Snail     6.6100
## 17930 64C 4.31        64   Snail    11.9800
## 17931 64C 4.32        64   Snail     8.1150
## 17932 64C 4.33        64   Snail    10.6250
## 17933 64C 4.34        64   Snail    12.3050
## 17934 64C 4.35        64   Snail     2.2500
## 17935 64C 4.36        64   Snail    13.2600
## 17936 64C 4.37        64   Snail    14.1050
## 17937 64C 4.38        64   Snail     9.7900
## 17938 64C 4.39        64   Snail    12.9800
## 17939  64C 5.1        64   Snail    13.5250
## 17940  64C 5.2        64   Snail     2.0050
## 17941  64C 5.3        64   Snail     1.9450
## 17942  64C 5.4        64   Snail    12.6350
## 17943  64C 5.5        64   Snail     4.0600
## 17944  64C 5.6        64   Snail     5.8300
## 17945  64C 5.7        64   Snail     5.8300
## 17946  64C 5.8        64   Snail    12.7400
## 17947  64C 5.9        64   Snail     6.5600
## 17948 64C 5.10        64   Snail     6.6950
## 17949 64C 5.11        64   Snail    11.8900
## 17950 64C 5.12        64   Snail     9.5050
## 17951 64C 5.13        64   Snail    11.3150
## 17952 64C 5.14        64   Snail     9.3900
## 17953 64C 5.15        64   Snail    14.7350
## 17954 64C 5.16        64   Snail    13.8200
## 17955  64C 6.1        64   Snail     6.4700
## 17956  64C 6.2        64   Snail    14.8300
## 17957  64C 6.3        64   Snail    12.7150
## 17958  64C 6.4        64   Snail     7.3400
## 17959  64C 6.5        64   Snail     4.0800
## 17960  64C 6.6        64   Snail    11.3150
## 17961  64C 6.7        64   Snail     4.5250
## 17962  64C 6.8        64   Snail     8.7700
## 17963  64C 7.1        64   Snail     9.9650
## 17964  64C 7.2        64   Snail     4.6500
## 17965  64C 7.3        64   Snail    13.2150
## 17966  64C 7.4        64   Snail     6.5900
## 17967  64C 7.5        64   Snail     8.1150
## 17968  64C 7.6        64   Snail     4.3150
## 17969  64C 7.7        64   Snail     3.8450
## 17970  64C 7.8        64   Snail     6.2050
## 17971  64C 7.9        64   Snail     9.4650
## 17972 64C 7.10        64   Snail    13.8650
## 17973 64C 7.11        64   Snail    12.3750
## 17974 64C 7.12        64   Snail    14.8800
## 17975 64C 7.13        64   Snail    13.5150
## 17976 64C 7.14        64   Snail    11.9550
## 17977   2C 1.1         2   Sox13     2.0900
## 17978   2C 1.2         2   Sox13     2.8050
## 17979   2C 2.1         2   Sox13     6.2500
## 17980   2C 2.2         2   Sox13     5.3250
## 17981   2C 3.1         2   Sox13     4.8000
## 17982   2C 3.2         2   Sox13     4.1800
## 17983   2C 4.1         2   Sox13     9.9200
## 17984   2C 5.1         2   Sox13     3.7400
## 17985   2C 5.2         2   Sox13     4.1700
## 17986   2C 6.1         2   Sox13     2.6050
## 17987   2C 6.2         2   Sox13     3.9800
## 17988   2C 7.1         2   Sox13     2.6550
## 17989   2C 7.2         2   Sox13     6.0850
## 17990   2C 8.1         2   Sox13     4.4050
## 17991   2C 8.2         2   Sox13     4.6250
## 17992   2C 9.1         2   Sox13     7.7900
## 17993   2C 9.2         2   Sox13     4.9950
## 17994  2C 10.1         2   Sox13     3.6050
## 17995  2C 10.2         2   Sox13     2.3050
## 17996   4C 1.1         4   Sox13     9.1400
## 17997   4C 1.2         4   Sox13     5.6800
## 17998   4C 1.3         4   Sox13     6.4050
## 17999   4C 1.4         4   Sox13     7.2850
## 18000   4C 2.1         4   Sox13     4.2200
## 18001   4C 2.2         4   Sox13     8.6900
## 18002   4C 2.3         4   Sox13     9.3350
## 18003   4C 3.1         4   Sox13     5.8300
## 18004   4C 3.2         4   Sox13     5.8600
## 18005   4C 3.3         4   Sox13     6.6350
## 18006   4C 3.4         4   Sox13     4.5300
## 18007   4C 4.1         4   Sox13     8.1350
## 18008   4C 4.2         4   Sox13     7.4650
## 18009   4C 4.3         4   Sox13     5.7750
## 18010   4C 4.4         4   Sox13     5.8450
## 18011   4C 5.1         4   Sox13     4.7800
## 18012   4C 5.2         4   Sox13     5.6150
## 18013   4C 5.3         4   Sox13     3.5350
## 18014   4C 5.4         4   Sox13     6.6200
## 18015   4C 6.1         4   Sox13     4.8250
## 18016   4C 6.2         4   Sox13     8.4250
## 18017   4C 6.3         4   Sox13     7.5100
## 18018   4C 6.4         4   Sox13     7.6100
## 18019   8C 1.1         8   Sox13     8.0550
## 18020   8C 1.2         8   Sox13    12.2750
## 18021   8C 1.3         8   Sox13     7.1300
## 18022   8C 1.4         8   Sox13     3.6300
## 18023   8C 1.5         8   Sox13     6.5600
## 18024   8C 2.1         8   Sox13     4.7600
## 18025   8C 2.2         8   Sox13     7.1100
## 18026   8C 2.3         8   Sox13     5.0375
## 18027   8C 2.4         8   Sox13     7.0150
## 18028   8C 2.5         8   Sox13     5.6600
## 18029   8C 2.6         8   Sox13     5.4700
## 18030   8C 2.7         8   Sox13     5.9450
## 18031   8C 2.8         8   Sox13     0.8050
## 18032   8C 3.1         8   Sox13     4.6950
## 18033   8C 3.2         8   Sox13    13.2950
## 18034   8C 3.3         8   Sox13     6.1550
## 18035   8C 3.4         8   Sox13     4.4175
## 18036   8C 3.5         8   Sox13     6.7250
## 18037   8C 3.6         8   Sox13     4.1200
## 18038   8C 3.7         8   Sox13     4.0200
## 18039   8C 3.8         8   Sox13     3.8650
## 18040   8C 4.2         8   Sox13    12.1400
## 18041   8C 4.3         8   Sox13     5.3750
## 18042   8C 4.4         8   Sox13    12.8150
## 18043   8C 4.5         8   Sox13     8.3200
## 18044   8C 4.6         8   Sox13     5.6125
## 18045   8C 4.7         8   Sox13     5.9950
## 18046   8C 5.1         8   Sox13     5.0550
## 18047   8C 5.2         8   Sox13     5.8400
## 18048   8C 5.3         8   Sox13     4.5050
## 18049   8C 5.4         8   Sox13     5.9650
## 18050   8C 5.5         8   Sox13     5.2250
## 18051   8C 5.6         8   Sox13     5.0450
## 18052   8C 5.7         8   Sox13     6.4050
## 18053   8C 5.8         8   Sox13     4.9100
## 18054   8C 6.1         8   Sox13     5.5350
## 18055   8C 6.2         8   Sox13     7.1350
## 18056   8C 6.3         8   Sox13     3.8500
## 18057   8C 6.4         8   Sox13     0.7850
## 18058   8C 6.5         8   Sox13     3.3500
## 18059   8C 6.6         8   Sox13     2.2950
## 18060   8C 6.7         8   Sox13     5.8150
## 18061   8C 6.8         8   Sox13     5.8050
## 18062  16C 1.1        16   Sox13     7.7700
## 18063  16C 1.2        16   Sox13     8.3600
## 18064  16C 1.3        16   Sox13     6.6550
## 18065  16C 1.4        16   Sox13     3.7150
## 18066  16C 1.5        16   Sox13     3.5650
## 18067  16C 1.6        16   Sox13     4.6150
## 18068  16C 1.7        16   Sox13     3.5500
## 18069  16C 1.8        16   Sox13    12.5350
## 18070  16C 1.9        16   Sox13     6.6750
## 18071 16C 1.10        16   Sox13     6.6500
## 18072 16C 1.11        16   Sox13     5.3350
## 18073 16C 1.12        16   Sox13     5.8700
## 18074 16C 1.13        16   Sox13     3.9800
## 18075 16C 1.14        16   Sox13     5.1100
## 18076 16C 1.15        16   Sox13     5.6650
## 18077 16C 1.16        16   Sox13     3.9300
## 18078  16C 2.1        16   Sox13    14.3400
## 18079  16C 2.2        16   Sox13     7.4450
## 18080  16C 2.3        16   Sox13     7.1850
## 18081  16C 2.4        16   Sox13     9.0200
## 18082  16C 2.5        16   Sox13     7.0450
## 18083  16C 2.6        16   Sox13     3.4700
## 18084  16C 2.7        16   Sox13     4.2200
## 18085  16C 2.8        16   Sox13     4.5550
## 18086  16C 2.9        16   Sox13     6.2100
## 18087 16C 2.10        16   Sox13     7.2250
## 18088 16C 2.11        16   Sox13     5.7800
## 18089 16C 2.12        16   Sox13     8.0000
## 18090 16C 2.13        16   Sox13     7.0600
## 18091 16C 2.14        16   Sox13     6.9600
## 18092 16C 2.15        16   Sox13     6.0600
## 18093 16C 2.16        16   Sox13     5.4250
## 18094  16C 3.1        16   Sox13     4.9400
## 18095  16C 3.2        16   Sox13     4.6250
## 18096  16C 3.3        16   Sox13     8.4950
## 18097  16C 3.4        16   Sox13     6.9550
## 18098  16C 3.5        16   Sox13     5.8450
## 18099  16C 3.6        16   Sox13     9.8500
## 18100  16C 3.7        16   Sox13    12.7750
## 18101  16C 3.8        16   Sox13     5.9250
## 18102  16C 3.9        16   Sox13     4.6550
## 18103 16C 3.10        16   Sox13     6.3400
## 18104 16C 3.11        16   Sox13     9.3100
## 18105 16C 3.12        16   Sox13     6.4550
## 18106 16C 3.13        16   Sox13     7.5750
## 18107 16C 3.14        16   Sox13     7.3200
## 18108 16C 3.15        16   Sox13     8.3200
## 18109  16C 4.1        16   Sox13     8.0550
## 18110  16C 4.2        16   Sox13     4.7700
## 18111  16C 4.3        16   Sox13    11.3000
## 18112  16C 4.4        16   Sox13     5.5950
## 18113  16C 4.5        16   Sox13     5.0200
## 18114  16C 4.6        16   Sox13     9.8750
## 18115  16C 4.7        16   Sox13     8.2750
## 18116  16C 4.8        16   Sox13     6.6950
## 18117  16C 4.9        16   Sox13     7.9450
## 18118 16C 4.10        16   Sox13    11.8800
## 18119 16C 4.11        16   Sox13     7.2150
## 18120 16C 4.12        16   Sox13    11.5450
## 18121 16C 4.13        16   Sox13     6.7100
## 18122 16C 4.14        16   Sox13     6.0650
## 18123 16C 4.15        16   Sox13     8.7050
## 18124 16C 4.16        16   Sox13    13.9300
## 18125  16C 5.1        16   Sox13     6.0400
## 18126  16C 5.2        16   Sox13     4.3950
## 18127  16C 5.3        16   Sox13     5.0450
## 18128  16C 5.4        16   Sox13    11.7900
## 18129  16C 5.5        16   Sox13     2.7500
## 18130  16C 5.6        16   Sox13     6.3500
## 18131  16C 5.7        16   Sox13     6.0300
## 18132  16C 5.8        16   Sox13     6.4400
## 18133  16C 5.9        16   Sox13    12.2975
## 18134 16C 5.10        16   Sox13     5.1950
## 18135 16C 5.11        16   Sox13     4.6300
## 18136 16C 5.12        16   Sox13     5.5400
## 18137  32C 1.1        32   Sox13     4.2450
## 18138  32C 1.2        32   Sox13     3.2550
## 18139  32C 1.3        32   Sox13     5.8750
## 18140  32C 1.4        32   Sox13     7.0650
## 18141  32C 1.5        32   Sox13    13.6250
## 18142  32C 1.6        32   Sox13    12.0575
## 18143  32C 1.7        32   Sox13     7.7050
## 18144  32C 1.8        32   Sox13     6.4600
## 18145  32C 1.9        32   Sox13     4.9000
## 18146 32C 1.10        32   Sox13     3.9050
## 18147 32C 1.11        32   Sox13     6.6400
## 18148 32C 1.12        32   Sox13     2.9550
## 18149 32C 1.13        32   Sox13    12.8150
## 18150 32C 1.14        32   Sox13     6.9200
## 18151 32C 1.15        32   Sox13    12.7325
## 18152 32C 1.16        32   Sox13     6.1450
## 18153 32C 1.17        32   Sox13     4.0050
## 18154 32C 1.18        32   Sox13     5.6300
## 18155 32C 1.19        32   Sox13    10.4750
## 18156 32C 1.20        32   Sox13    12.3650
## 18157 32C 1.21        32   Sox13     6.6450
## 18158  32C 2.1        32   Sox13     4.9350
## 18159  32C 2.2        32   Sox13     8.2150
## 18160  32C 2.3        32   Sox13     5.3900
## 18161  32C 2.4        32   Sox13     5.8150
## 18162  32C 2.5        32   Sox13     7.8150
## 18163  32C 2.6        32   Sox13     4.3300
## 18164  32C 2.7        32   Sox13     2.4550
## 18165  32C 2.8        32   Sox13     4.9500
## 18166  32C 2.9        32   Sox13     6.6250
## 18167 32C 2.10        32   Sox13     5.0250
## 18168 32C 2.11        32   Sox13     8.2050
## 18169 32C 2.12        32   Sox13     6.1200
## 18170 32C 2.13        32   Sox13     9.7300
## 18171 32C 2.14        32   Sox13     7.8250
## 18172 32C 2.15        32   Sox13     1.9450
## 18173 32C 2.16        32   Sox13     5.2750
## 18174  32C 3.1        32   Sox13     4.4450
## 18175  32C 3.2        32   Sox13     2.5600
## 18176  32C 3.3        32   Sox13     4.1750
## 18177  32C 3.4        32   Sox13     5.3950
## 18178  32C 3.5        32   Sox13     6.6000
## 18179  32C 3.6        32   Sox13     8.3250
## 18180  32C 3.7        32   Sox13     6.9200
## 18181  32C 3.8        32   Sox13    11.9200
## 18182  32C 4.1        32   Sox13     3.4100
## 18183  32C 4.2        32   Sox13     6.1550
## 18184  32C 4.3        32   Sox13    10.6400
## 18185  32C 4.4        32   Sox13    10.8800
## 18186  32C 4.5        32   Sox13    13.3150
## 18187  32C 4.6        32   Sox13     6.5250
## 18188  32C 4.7        32   Sox13    10.8400
## 18189  32C 4.8        32   Sox13     8.8350
## 18190 32C 4.10        32   Sox13     4.1500
## 18191 32C 4.11        32   Sox13    11.1700
## 18192 32C 4.12        32   Sox13     6.0350
## 18193 32C 4.13        32   Sox13     6.8800
## 18194 32C 4.14        32   Sox13     7.4250
## 18195 32C 4.15        32   Sox13    13.5000
## 18196 32C 4.16        32   Sox13     8.4400
## 18197 32C 4.17        32   Sox13     8.8100
## 18198 32C 4.18        32   Sox13     6.5100
## 18199 32C 4.19        32   Sox13     6.7400
## 18200 32C 4.20        32   Sox13    11.5150
## 18201 32C 4.21        32   Sox13    12.3600
## 18202 32C 4.22        32   Sox13     6.3650
## 18203 32C 4.23        32   Sox13    11.3850
## 18204 32C 4.24        32   Sox13    13.3050
## 18205  32C 5.1        32   Sox13     8.8750
## 18206  32C 5.2        32   Sox13     8.9500
## 18207  32C 5.3        32   Sox13     8.3150
## 18208  32C 5.4        32   Sox13     5.2750
## 18209  32C 5.5        32   Sox13     9.5250
## 18210  32C 5.6        32   Sox13     7.4000
## 18211  32C 5.7        32   Sox13     5.0200
## 18212  32C 5.8        32   Sox13     9.2850
## 18213  32C 5.9        32   Sox13    12.2650
## 18214 32C 5.10        32   Sox13    11.7500
## 18215 32C 5.11        32   Sox13     7.9300
## 18216 32C 5.12        32   Sox13    14.7950
## 18217 32C 5.13        32   Sox13     5.6200
## 18218 32C 5.14        32   Sox13     3.7700
## 18219 32C 5.15        32   Sox13     5.8650
## 18220 32C 5.16        32   Sox13     5.9400
## 18221 32C 5.17        32   Sox13     8.3350
## 18222 32C 5.18        32   Sox13     7.6350
## 18223 32C 5.19        32   Sox13     7.9550
## 18224 32C 5.20        32   Sox13    13.8350
## 18225 32C 5.21        32   Sox13     5.9100
## 18226 32C 5.22        32   Sox13     6.6150
## 18227 32C 5.23        32   Sox13     6.4350
## 18228  32C 6.1        32   Sox13     6.9400
## 18229  32C 6.2        32   Sox13     3.7750
## 18230  32C 6.3        32   Sox13     7.2800
## 18231  32C 6.4        32   Sox13    13.9300
## 18232  32C 6.6        32   Sox13     5.8950
## 18233  32C 6.7        32   Sox13     5.1900
## 18234  32C 7.1        32   Sox13     4.7750
## 18235  32C 7.2        32   Sox13    11.7900
## 18236  32C 7.3        32   Sox13     6.1150
## 18237  32C 7.4        32   Sox13     5.6300
## 18238  32C 7.5        32   Sox13    12.6300
## 18239  32C 7.6        32   Sox13    13.2800
## 18240  32C 7.8        32   Sox13     4.9125
## 18241  32C 8.1        32   Sox13     5.2750
## 18242  32C 8.2        32   Sox13    12.0700
## 18243  32C 8.4        32   Sox13     6.7450
## 18244  32C 8.5        32   Sox13    11.2750
## 18245  32C 8.6        32   Sox13     2.8600
## 18246  64C 1.1        64   Sox13     7.7150
## 18247  64C 1.2        64   Sox13    13.2950
## 18248  64C 1.3        64   Sox13     6.7150
## 18249  64C 1.4        64   Sox13     8.2575
## 18250  64C 1.5        64   Sox13     9.8150
## 18251  64C 1.6        64   Sox13     6.9400
## 18252  64C 1.7        64   Sox13     8.4100
## 18253  64C 1.8        64   Sox13     5.7950
## 18254  64C 1.9        64   Sox13    12.1400
## 18255 64C 1.10        64   Sox13    10.7950
## 18256 64C 1.11        64   Sox13     8.4350
## 18257 64C 1.12        64   Sox13     9.2600
## 18258 64C 1.13        64   Sox13     7.9725
## 18259 64C 1.14        64   Sox13     6.2950
## 18260 64C 1.15        64   Sox13     6.2350
## 18261 64C 1.16        64   Sox13    12.4200
## 18262 64C 1.17        64   Sox13     4.6350
## 18263 64C 1.18        64   Sox13     5.6650
## 18264 64C 1.19        64   Sox13     4.4750
## 18265 64C 1.20        64   Sox13     8.1950
## 18266 64C 1.21        64   Sox13    13.8650
## 18267 64C 1.22        64   Sox13    12.5000
## 18268 64C 1.23        64   Sox13    14.3950
## 18269 64C 1.24        64   Sox13     8.8850
## 18270 64C 1.25        64   Sox13    11.4100
## 18271 64C 1.26        64   Sox13     6.5550
## 18272 64C 1.27        64   Sox13    10.6800
## 18273 64C 1.28        64   Sox13     4.3850
## 18274 64C 1.29        64   Sox13     7.6150
## 18275 64C 1.30        64   Sox13    14.0950
## 18276 64C 1.31        64   Sox13     8.7900
## 18277 64C 1.32        64   Sox13    12.3000
## 18278 64C 1.33        64   Sox13    10.5550
## 18279 64C 1.34        64   Sox13     6.3050
## 18280 64C 1.35        64   Sox13     6.5150
## 18281 64C 1.36        64   Sox13     6.8150
## 18282 64C 1.37        64   Sox13     5.2400
## 18283 64C 1.38        64   Sox13     5.3150
## 18284 64C 1.39        64   Sox13     7.5750
## 18285 64C 1.40        64   Sox13    10.9000
## 18286 64C 1.41        64   Sox13    13.1350
## 18287 64C 1.42        64   Sox13    13.9900
## 18288 64C 1.43        64   Sox13    11.9200
## 18289 64C 1.44        64   Sox13     5.1200
## 18290 64C 1.45        64   Sox13     6.8050
## 18291 64C 1.46        64   Sox13    10.6400
## 18292 64C 1.47        64   Sox13    14.3400
## 18293 64C 1.48        64   Sox13     7.9450
## 18294  64C 2.1        64   Sox13     6.6550
## 18295  64C 2.2        64   Sox13     7.1500
## 18296  64C 2.3        64   Sox13     5.6950
## 18297  64C 2.4        64   Sox13     4.8700
## 18298  64C 2.5        64   Sox13     5.7900
## 18299  64C 2.6        64   Sox13     4.8350
## 18300  64C 2.7        64   Sox13    12.2600
## 18301  64C 2.8        64   Sox13     9.4850
## 18302  64C 2.9        64   Sox13     8.7300
## 18303 64C 2.10        64   Sox13     6.2200
## 18304 64C 2.11        64   Sox13     6.7200
## 18305 64C 2.12        64   Sox13     6.8200
## 18306 64C 2.13        64   Sox13     5.0100
## 18307 64C 2.14        64   Sox13     4.2750
## 18308 64C 2.15        64   Sox13     5.7600
## 18309 64C 2.16        64   Sox13    11.6750
## 18310 64C 2.17        64   Sox13    15.0050
## 18311 64C 2.18        64   Sox13     7.5550
## 18312 64C 2.19        64   Sox13     6.5950
## 18313 64C 2.20        64   Sox13    15.9200
## 18314 64C 2.21        64   Sox13     6.2750
## 18315 64C 2.22        64   Sox13     6.2250
## 18316 64C 2.23        64   Sox13     2.6450
## 18317 64C 2.24        64   Sox13     6.7100
## 18318 64C 2.25        64   Sox13    11.3100
## 18319  64C 3.1        64   Sox13     8.9950
## 18320  64C 3.2        64   Sox13     7.7850
## 18321  64C 3.3        64   Sox13     6.2500
## 18322  64C 3.4        64   Sox13     6.4400
## 18323  64C 3.5        64   Sox13    14.7950
## 18324  64C 3.6        64   Sox13     9.2300
## 18325  64C 3.7        64   Sox13     5.0400
## 18326  64C 3.8        64   Sox13    12.3250
## 18327  64C 4.1        64   Sox13    11.6700
## 18328 64C 4.1b        64   Sox13    14.3350
## 18329  64C 4.2        64   Sox13     7.6950
## 18330  64C 4.3        64   Sox13    12.5350
## 18331  64C 4.4        64   Sox13    13.8350
## 18332  64C 4.5        64   Sox13    12.9500
## 18333  64C 4.6        64   Sox13     6.3850
## 18334  64C 4.7        64   Sox13     5.2250
## 18335  64C 4.8        64   Sox13     8.6800
## 18336  64C 4.9        64   Sox13     6.1250
## 18337 64C 4.10        64   Sox13     8.6450
## 18338 64C 4.11        64   Sox13    11.0800
## 18339 64C 4.12        64   Sox13     7.1800
## 18340 64C 4.13        64   Sox13     7.3750
## 18341 64C 4.14        64   Sox13     6.5150
## 18342 64C 4.15        64   Sox13    11.7900
## 18343 64C 4.16        64   Sox13     4.6200
## 18344 64C 4.17        64   Sox13     5.7800
## 18345 64C 4.18        64   Sox13     6.7900
## 18346 64C 4.19        64   Sox13    13.2800
## 18347 64C 4.20        64   Sox13     6.9975
## 18348 64C 4.21        64   Sox13     5.6750
## 18349 64C 4.22        64   Sox13     4.5800
## 18350 64C 4.23        64   Sox13     6.8000
## 18351 64C 4.24        64   Sox13     6.5950
## 18352 64C 4.25        64   Sox13     3.1350
## 18353 64C 4.26        64   Sox13    12.8250
## 18354 64C 4.27        64   Sox13     6.9650
## 18355 64C 4.28        64   Sox13     6.8450
## 18356 64C 4.29        64   Sox13     7.8775
## 18357 64C 4.30        64   Sox13     8.3150
## 18358 64C 4.31        64   Sox13     7.2500
## 18359 64C 4.32        64   Sox13    12.7000
## 18360 64C 4.33        64   Sox13     4.9550
## 18361 64C 4.34        64   Sox13     7.3400
## 18362 64C 4.35        64   Sox13     5.3050
## 18363 64C 4.36        64   Sox13     8.1250
## 18364 64C 4.37        64   Sox13     7.2200
## 18365 64C 4.38        64   Sox13     6.7925
## 18366 64C 4.39        64   Sox13     7.8350
## 18367  64C 5.1        64   Sox13    11.6150
## 18368  64C 5.2        64   Sox13     6.6400
## 18369  64C 5.3        64   Sox13    10.4750
## 18370  64C 5.4        64   Sox13     5.1050
## 18371  64C 5.5        64   Sox13     6.5950
## 18372  64C 5.6        64   Sox13    12.8950
## 18373  64C 5.7        64   Sox13    13.8650
## 18374  64C 5.8        64   Sox13    12.5000
## 18375  64C 5.9        64   Sox13    14.3950
## 18376 64C 5.10        64   Sox13    13.1550
## 18377 64C 5.11        64   Sox13    11.4100
## 18378 64C 5.12        64   Sox13     7.4450
## 18379 64C 5.13        64   Sox13     6.0000
## 18380 64C 5.14        64   Sox13     4.0450
## 18381 64C 5.15        64   Sox13    13.4050
## 18382 64C 5.16        64   Sox13     8.4050
## 18383  64C 6.1        64   Sox13     8.1700
## 18384  64C 6.2        64   Sox13     7.6500
## 18385  64C 6.3        64   Sox13     7.9850
## 18386  64C 6.4        64   Sox13     4.3250
## 18387  64C 6.5        64   Sox13     6.1150
## 18388  64C 6.6        64   Sox13     4.5050
## 18389  64C 6.7        64   Sox13    10.8700
## 18390  64C 6.8        64   Sox13     8.8050
## 18391  64C 7.1        64   Sox13    13.9250
## 18392  64C 7.2        64   Sox13    12.1200
## 18393  64C 7.3        64   Sox13    13.1350
## 18394  64C 7.4        64   Sox13    11.7600
## 18395  64C 7.5        64   Sox13    11.9200
## 18396  64C 7.6        64   Sox13    11.9500
## 18397  64C 7.7        64   Sox13     6.4950
## 18398  64C 7.8        64   Sox13     6.3700
## 18399  64C 7.9        64   Sox13    14.3400
## 18400 64C 7.10        64   Sox13     7.4550
## 18401 64C 7.11        64   Sox13     6.9750
## 18402 64C 7.12        64   Sox13     7.8500
## 18403 64C 7.13        64   Sox13     8.6650
## 18404 64C 7.14        64   Sox13    11.9400
## 18405   2C 1.1         2 Tcfap2a     6.0800
## 18406   2C 1.2         2 Tcfap2a     8.7950
## 18407   2C 2.1         2 Tcfap2a     6.1800
## 18408   2C 2.2         2 Tcfap2a     9.1950
## 18409   2C 3.1         2 Tcfap2a     6.9400
## 18410   2C 3.2         2 Tcfap2a    12.0050
## 18411   2C 4.1         2 Tcfap2a     8.5800
## 18412   2C 5.1         2 Tcfap2a    11.2950
## 18413   2C 5.2         2 Tcfap2a     6.3950
## 18414   2C 6.1         2 Tcfap2a     6.8250
## 18415   2C 6.2         2 Tcfap2a    12.4150
## 18416   2C 7.1         2 Tcfap2a     5.8500
## 18417   2C 7.2         2 Tcfap2a     8.1100
## 18418   2C 8.1         2 Tcfap2a     7.9050
## 18419   2C 8.2         2 Tcfap2a    13.2550
## 18420   2C 9.1         2 Tcfap2a     9.6300
## 18421   2C 9.2         2 Tcfap2a    13.8750
## 18422  2C 10.1         2 Tcfap2a     6.8850
## 18423  2C 10.2         2 Tcfap2a    11.5100
## 18424   4C 1.1         4 Tcfap2a     9.0000
## 18425   4C 1.2         4 Tcfap2a     7.7800
## 18426   4C 1.3         4 Tcfap2a     8.3400
## 18427   4C 1.4         4 Tcfap2a     8.3650
## 18428   4C 2.1         4 Tcfap2a    11.6700
## 18429   4C 2.2         4 Tcfap2a    10.7500
## 18430   4C 2.3         4 Tcfap2a    10.5400
## 18431   4C 3.1         4 Tcfap2a     6.1600
## 18432   4C 3.2         4 Tcfap2a     5.1150
## 18433   4C 3.3         4 Tcfap2a     7.8800
## 18434   4C 3.4         4 Tcfap2a     9.6000
## 18435   4C 4.1         4 Tcfap2a    14.2350
## 18436   4C 4.2         4 Tcfap2a     9.8600
## 18437   4C 4.3         4 Tcfap2a    10.2450
## 18438   4C 4.4         4 Tcfap2a    13.2600
## 18439   4C 5.1         4 Tcfap2a     8.7000
## 18440   4C 5.2         4 Tcfap2a    12.4350
## 18441   4C 5.3         4 Tcfap2a     6.8650
## 18442   4C 5.4         4 Tcfap2a     6.6050
## 18443   4C 6.1         4 Tcfap2a    10.9800
## 18444   4C 6.2         4 Tcfap2a     7.4700
## 18445   4C 6.3         4 Tcfap2a     7.5250
## 18446   4C 6.4         4 Tcfap2a     7.9850
## 18447   8C 1.1         8 Tcfap2a    13.1700
## 18448   8C 1.2         8 Tcfap2a     7.4200
## 18449   8C 1.3         8 Tcfap2a    11.5150
## 18450   8C 1.4         8 Tcfap2a     2.6950
## 18451   8C 1.5         8 Tcfap2a     8.0650
## 18452   8C 2.1         8 Tcfap2a    11.3750
## 18453   8C 2.2         8 Tcfap2a    13.6700
## 18454   8C 2.3         8 Tcfap2a    14.3150
## 18455   8C 2.4         8 Tcfap2a    15.2400
## 18456   8C 2.5         8 Tcfap2a     6.4500
## 18457   8C 2.6         8 Tcfap2a    12.2750
## 18458   8C 2.7         8 Tcfap2a    10.6750
## 18459   8C 2.8         8 Tcfap2a    11.5250
## 18460   8C 3.1         8 Tcfap2a    12.4650
## 18461   8C 3.2         8 Tcfap2a    13.3750
## 18462   8C 3.3         8 Tcfap2a    13.6300
## 18463   8C 3.4         8 Tcfap2a     7.0350
## 18464   8C 3.5         8 Tcfap2a     9.0800
## 18465   8C 3.6         8 Tcfap2a    11.2600
## 18466   8C 3.7         8 Tcfap2a     6.9150
## 18467   8C 3.8         8 Tcfap2a     5.2150
## 18468   8C 4.2         8 Tcfap2a    11.9650
## 18469   8C 4.3         8 Tcfap2a     4.7050
## 18470   8C 4.4         8 Tcfap2a    13.1800
## 18471   8C 4.5         8 Tcfap2a    13.6550
## 18472   8C 4.6         8 Tcfap2a     8.4625
## 18473   8C 4.7         8 Tcfap2a    12.2800
## 18474   8C 5.1         8 Tcfap2a    13.0100
## 18475   8C 5.2         8 Tcfap2a    12.2600
## 18476   8C 5.3         8 Tcfap2a     4.9100
## 18477   8C 5.4         8 Tcfap2a     4.4350
## 18478   8C 5.5         8 Tcfap2a     6.5100
## 18479   8C 5.6         8 Tcfap2a    11.7300
## 18480   8C 5.7         8 Tcfap2a    13.4950
## 18481   8C 5.8         8 Tcfap2a     9.3625
## 18482   8C 6.1         8 Tcfap2a     8.8950
## 18483   8C 6.2         8 Tcfap2a    13.9850
## 18484   8C 6.3         8 Tcfap2a     7.5950
## 18485   8C 6.4         8 Tcfap2a     9.4650
## 18486   8C 6.5         8 Tcfap2a    11.1450
## 18487   8C 6.6         8 Tcfap2a     3.3750
## 18488   8C 6.7         8 Tcfap2a     7.6000
## 18489   8C 6.8         8 Tcfap2a    10.6900
## 18490  16C 1.1        16 Tcfap2a    11.4600
## 18491  16C 1.2        16 Tcfap2a    13.8850
## 18492  16C 1.3        16 Tcfap2a    13.1300
## 18493  16C 1.4        16 Tcfap2a     8.6050
## 18494  16C 1.5        16 Tcfap2a    11.2100
## 18495  16C 1.6        16 Tcfap2a    11.3750
## 18496  16C 1.7        16 Tcfap2a     5.6000
## 18497  16C 1.8        16 Tcfap2a    12.5900
## 18498  16C 1.9        16 Tcfap2a     9.1750
## 18499 16C 1.10        16 Tcfap2a     7.4700
## 18500 16C 1.11        16 Tcfap2a     9.1850
## 18501 16C 1.12        16 Tcfap2a    11.4600
## 18502 16C 1.13        16 Tcfap2a    11.8600
## 18503 16C 1.14        16 Tcfap2a    11.6300
## 18504 16C 1.15        16 Tcfap2a     7.6950
## 18505 16C 1.16        16 Tcfap2a    11.1400
## 18506  16C 2.1        16 Tcfap2a     9.2300
## 18507  16C 2.2        16 Tcfap2a     9.0200
## 18508  16C 2.3        16 Tcfap2a     6.8350
## 18509  16C 2.4        16 Tcfap2a    14.0100
## 18510  16C 2.5        16 Tcfap2a    13.3200
## 18511  16C 2.6        16 Tcfap2a    12.5350
## 18512  16C 2.7        16 Tcfap2a     7.9900
## 18513  16C 2.8        16 Tcfap2a    11.8950
## 18514  16C 2.9        16 Tcfap2a    11.2000
## 18515 16C 2.10        16 Tcfap2a    10.3350
## 18516 16C 2.11        16 Tcfap2a    10.1100
## 18517 16C 2.12        16 Tcfap2a     8.8850
## 18518 16C 2.13        16 Tcfap2a    14.8100
## 18519 16C 2.14        16 Tcfap2a     9.3550
## 18520 16C 2.15        16 Tcfap2a    12.3950
## 18521 16C 2.16        16 Tcfap2a    12.1750
## 18522  16C 3.1        16 Tcfap2a     6.4050
## 18523  16C 3.2        16 Tcfap2a    11.6200
## 18524  16C 3.3        16 Tcfap2a    13.4600
## 18525  16C 3.4        16 Tcfap2a    12.9150
## 18526  16C 3.5        16 Tcfap2a     7.7750
## 18527  16C 3.6        16 Tcfap2a    12.0500
## 18528  16C 3.7        16 Tcfap2a    13.8750
## 18529  16C 3.8        16 Tcfap2a     8.1250
## 18530  16C 3.9        16 Tcfap2a     8.7000
## 18531 16C 3.10        16 Tcfap2a    12.4300
## 18532 16C 3.11        16 Tcfap2a    11.7000
## 18533 16C 3.12        16 Tcfap2a     9.2500
## 18534 16C 3.13        16 Tcfap2a    13.5650
## 18535 16C 3.14        16 Tcfap2a     8.3700
## 18536 16C 3.15        16 Tcfap2a    13.9200
## 18537  16C 4.1        16 Tcfap2a    14.7300
## 18538  16C 4.2        16 Tcfap2a    12.0900
## 18539  16C 4.3        16 Tcfap2a     5.1150
## 18540  16C 4.4        16 Tcfap2a     5.5600
## 18541  16C 4.5        16 Tcfap2a    12.6600
## 18542  16C 4.6        16 Tcfap2a    14.2350
## 18543  16C 4.7        16 Tcfap2a    12.9600
## 18544  16C 4.8        16 Tcfap2a    14.3950
## 18545  16C 4.9        16 Tcfap2a     6.7400
## 18546 16C 4.10        16 Tcfap2a    12.7300
## 18547 16C 4.11        16 Tcfap2a    12.4350
## 18548 16C 4.12        16 Tcfap2a    11.5450
## 18549 16C 4.13        16 Tcfap2a    10.8650
## 18550 16C 4.14        16 Tcfap2a    10.9800
## 18551 16C 4.15        16 Tcfap2a    14.1900
## 18552 16C 4.16        16 Tcfap2a     7.2250
## 18553  16C 5.1        16 Tcfap2a    13.9450
## 18554  16C 5.2        16 Tcfap2a    13.1700
## 18555  16C 5.3        16 Tcfap2a    12.1000
## 18556  16C 5.4        16 Tcfap2a    11.5150
## 18557  16C 5.5        16 Tcfap2a     8.3950
## 18558  16C 5.6        16 Tcfap2a    11.5650
## 18559  16C 5.7        16 Tcfap2a     9.5250
## 18560  16C 5.8        16 Tcfap2a     8.4900
## 18561  16C 5.9        16 Tcfap2a    14.3150
## 18562 16C 5.10        16 Tcfap2a    11.6300
## 18563 16C 5.11        16 Tcfap2a     5.8900
## 18564 16C 5.12        16 Tcfap2a     6.6750
## 18565  32C 1.1        32 Tcfap2a     0.5850
## 18566  32C 1.2        32 Tcfap2a     6.3450
## 18567  32C 1.3        32 Tcfap2a     4.3250
## 18568  32C 1.4        32 Tcfap2a     4.5650
## 18569  32C 1.5        32 Tcfap2a     7.8100
## 18570  32C 1.6        32 Tcfap2a    13.1050
## 18571  32C 1.7        32 Tcfap2a     6.7700
## 18572  32C 1.8        32 Tcfap2a    11.2600
## 18573  32C 1.9        32 Tcfap2a     7.4450
## 18574 32C 1.10        32 Tcfap2a    10.4450
## 18575 32C 1.11        32 Tcfap2a     6.1150
## 18576 32C 1.12        32 Tcfap2a     1.2050
## 18577 32C 1.13        32 Tcfap2a    13.1800
## 18578 32C 1.14        32 Tcfap2a     4.2350
## 18579 32C 1.15        32 Tcfap2a    13.4025
## 18580 32C 1.16        32 Tcfap2a    12.2800
## 18581 32C 1.17        32 Tcfap2a    13.0100
## 18582 32C 1.18        32 Tcfap2a    12.2600
## 18583 32C 1.19        32 Tcfap2a    10.3100
## 18584 32C 1.20        32 Tcfap2a    11.8050
## 18585 32C 1.21        32 Tcfap2a    11.2000
## 18586  32C 2.1        32 Tcfap2a     4.9900
## 18587  32C 2.2        32 Tcfap2a     6.0250
## 18588  32C 2.3        32 Tcfap2a     3.0525
## 18589  32C 2.4        32 Tcfap2a    14.2450
## 18590  32C 2.5        32 Tcfap2a    13.9850
## 18591  32C 2.6        32 Tcfap2a     3.2550
## 18592  32C 2.7        32 Tcfap2a     3.1850
## 18593  32C 2.8        32 Tcfap2a    11.1450
## 18594  32C 2.9        32 Tcfap2a     1.9850
## 18595 32C 2.10        32 Tcfap2a     4.5800
## 18596 32C 2.11        32 Tcfap2a    13.7500
## 18597 32C 2.12        32 Tcfap2a     3.5800
## 18598 32C 2.13        32 Tcfap2a     7.7650
## 18599 32C 2.14        32 Tcfap2a     8.5400
## 18600 32C 2.15        32 Tcfap2a     6.1950
## 18601 32C 2.16        32 Tcfap2a     5.9000
## 18602  32C 3.1        32 Tcfap2a     2.1850
## 18603  32C 3.2        32 Tcfap2a     3.4300
## 18604  32C 3.3        32 Tcfap2a     5.0700
## 18605  32C 3.4        32 Tcfap2a     6.0750
## 18606  32C 3.5        32 Tcfap2a     4.7500
## 18607  32C 3.6        32 Tcfap2a    13.3950
## 18608  32C 3.7        32 Tcfap2a    14.0200
## 18609  32C 3.8        32 Tcfap2a    11.8600
## 18610  32C 4.1        32 Tcfap2a     2.2800
## 18611  32C 4.2        32 Tcfap2a     4.3450
## 18612  32C 4.3        32 Tcfap2a    11.1400
## 18613  32C 4.4        32 Tcfap2a     9.6300
## 18614  32C 4.5        32 Tcfap2a    14.1500
## 18615  32C 4.6        32 Tcfap2a     7.6950
## 18616  32C 4.7        32 Tcfap2a     6.0000
## 18617  32C 4.8        32 Tcfap2a     3.2200
## 18618 32C 4.10        32 Tcfap2a     2.8850
## 18619 32C 4.11        32 Tcfap2a     7.7400
## 18620 32C 4.12        32 Tcfap2a     4.0450
## 18621 32C 4.13        32 Tcfap2a     2.4800
## 18622 32C 4.14        32 Tcfap2a    14.7350
## 18623 32C 4.15        32 Tcfap2a     7.4900
## 18624 32C 4.16        32 Tcfap2a    13.3850
## 18625 32C 4.17        32 Tcfap2a     7.5100
## 18626 32C 4.18        32 Tcfap2a     5.5950
## 18627 32C 4.19        32 Tcfap2a     2.6350
## 18628 32C 4.20        32 Tcfap2a    12.1750
## 18629 32C 4.21        32 Tcfap2a    12.4150
## 18630 32C 4.22        32 Tcfap2a     5.4400
## 18631 32C 4.23        32 Tcfap2a     4.5800
## 18632 32C 4.24        32 Tcfap2a     6.9750
## 18633  32C 5.1        32 Tcfap2a     8.0550
## 18634  32C 5.2        32 Tcfap2a    12.9500
## 18635  32C 5.3        32 Tcfap2a     9.7450
## 18636  32C 5.4        32 Tcfap2a     2.4450
## 18637  32C 5.5        32 Tcfap2a    11.5100
## 18638  32C 5.6        32 Tcfap2a     4.6300
## 18639  32C 5.7        32 Tcfap2a     4.5600
## 18640  32C 5.8        32 Tcfap2a    14.3100
## 18641  32C 5.9        32 Tcfap2a     6.3050
## 18642 32C 5.10        32 Tcfap2a    11.6700
## 18643 32C 5.11        32 Tcfap2a     8.3100
## 18644 32C 5.12        32 Tcfap2a    14.7300
## 18645 32C 5.13        32 Tcfap2a     3.7500
## 18646 32C 5.14        32 Tcfap2a     1.9850
## 18647 32C 5.15        32 Tcfap2a     4.9000
## 18648 32C 5.16        32 Tcfap2a     6.3400
## 18649 32C 5.17        32 Tcfap2a     7.7050
## 18650 32C 5.18        32 Tcfap2a     5.4700
## 18651 32C 5.19        32 Tcfap2a     8.9850
## 18652 32C 5.20        32 Tcfap2a     6.9600
## 18653 32C 5.21        32 Tcfap2a     7.4900
## 18654 32C 5.22        32 Tcfap2a     6.1850
## 18655 32C 5.23        32 Tcfap2a     5.3650
## 18656  32C 6.1        32 Tcfap2a     5.6300
## 18657  32C 6.2        32 Tcfap2a     1.9250
## 18658  32C 6.3        32 Tcfap2a     6.0550
## 18659  32C 6.4        32 Tcfap2a     6.7550
## 18660  32C 6.6        32 Tcfap2a     7.1550
## 18661  32C 6.7        32 Tcfap2a     6.5850
## 18662  32C 7.1        32 Tcfap2a     3.8700
## 18663  32C 7.2        32 Tcfap2a     5.1450
## 18664  32C 7.3        32 Tcfap2a     0.4700
## 18665  32C 7.4        32 Tcfap2a     3.7950
## 18666  32C 7.5        32 Tcfap2a     5.3800
## 18667  32C 7.6        32 Tcfap2a     7.3900
## 18668  32C 7.8        32 Tcfap2a     6.8750
## 18669  32C 8.1        32 Tcfap2a    10.2350
## 18670  32C 8.2        32 Tcfap2a     5.5100
## 18671  32C 8.4        32 Tcfap2a     6.5450
## 18672  32C 8.5        32 Tcfap2a     3.9100
## 18673  32C 8.6        32 Tcfap2a     4.6200
## 18674  64C 1.1        64 Tcfap2a     6.6150
## 18675  64C 1.2        64 Tcfap2a     5.6750
## 18676  64C 1.3        64 Tcfap2a     9.9300
## 18677  64C 1.4        64 Tcfap2a    10.1650
## 18678  64C 1.5        64 Tcfap2a    10.4900
## 18679  64C 1.6        64 Tcfap2a     7.8700
## 18680  64C 1.7        64 Tcfap2a     6.3250
## 18681  64C 1.8        64 Tcfap2a     4.0350
## 18682  64C 1.9        64 Tcfap2a     6.9350
## 18683 64C 1.10        64 Tcfap2a     3.5150
## 18684 64C 1.11        64 Tcfap2a     9.0200
## 18685 64C 1.12        64 Tcfap2a     8.2350
## 18686 64C 1.13        64 Tcfap2a     8.1025
## 18687 64C 1.14        64 Tcfap2a     5.6700
## 18688 64C 1.15        64 Tcfap2a     8.1600
## 18689 64C 1.16        64 Tcfap2a     5.0300
## 18690 64C 1.17        64 Tcfap2a     2.4300
## 18691 64C 1.18        64 Tcfap2a     4.9250
## 18692 64C 1.19        64 Tcfap2a     5.5400
## 18693 64C 1.20        64 Tcfap2a     6.9200
## 18694 64C 1.21        64 Tcfap2a     9.1150
## 18695 64C 1.22        64 Tcfap2a    12.0825
## 18696 64C 1.23        64 Tcfap2a    14.2450
## 18697 64C 1.24        64 Tcfap2a     8.5450
## 18698 64C 1.25        64 Tcfap2a     6.1150
## 18699 64C 1.26        64 Tcfap2a     9.4650
## 18700 64C 1.27        64 Tcfap2a     3.9750
## 18701 64C 1.28        64 Tcfap2a     3.2550
## 18702 64C 1.29        64 Tcfap2a     6.4000
## 18703 64C 1.30        64 Tcfap2a    10.1400
## 18704 64C 1.31        64 Tcfap2a     6.6600
## 18705 64C 1.32        64 Tcfap2a     6.2550
## 18706 64C 1.33        64 Tcfap2a     6.9400
## 18707 64C 1.34        64 Tcfap2a     8.6050
## 18708 64C 1.35        64 Tcfap2a     2.7600
## 18709 64C 1.36        64 Tcfap2a     3.2750
## 18710 64C 1.37        64 Tcfap2a     5.1200
## 18711 64C 1.38        64 Tcfap2a     6.8900
## 18712 64C 1.39        64 Tcfap2a     6.4850
## 18713 64C 1.40        64 Tcfap2a    12.1600
## 18714 64C 1.41        64 Tcfap2a    13.3950
## 18715 64C 1.42        64 Tcfap2a     7.0700
## 18716 64C 1.43        64 Tcfap2a     6.8700
## 18717 64C 1.44        64 Tcfap2a     6.4300
## 18718 64C 1.45        64 Tcfap2a     6.1350
## 18719 64C 1.46        64 Tcfap2a     3.8200
## 18720 64C 1.47        64 Tcfap2a     8.2300
## 18721 64C 1.48        64 Tcfap2a     6.2100
## 18722  64C 2.1        64 Tcfap2a     4.5750
## 18723  64C 2.2        64 Tcfap2a     5.2800
## 18724  64C 2.3        64 Tcfap2a     4.7200
## 18725  64C 2.4        64 Tcfap2a     4.7650
## 18726  64C 2.5        64 Tcfap2a     7.8000
## 18727  64C 2.6        64 Tcfap2a     5.2350
## 18728  64C 2.7        64 Tcfap2a    11.2000
## 18729  64C 2.8        64 Tcfap2a     9.7850
## 18730  64C 2.9        64 Tcfap2a     5.6200
## 18731 64C 2.10        64 Tcfap2a     4.9250
## 18732 64C 2.11        64 Tcfap2a     7.4100
## 18733 64C 2.12        64 Tcfap2a     6.6850
## 18734 64C 2.13        64 Tcfap2a     4.7450
## 18735 64C 2.14        64 Tcfap2a     5.6850
## 18736 64C 2.15        64 Tcfap2a     4.7750
## 18737 64C 2.16        64 Tcfap2a     6.0100
## 18738 64C 2.17        64 Tcfap2a     9.7100
## 18739 64C 2.18        64 Tcfap2a     5.0250
## 18740 64C 2.19        64 Tcfap2a     5.2350
## 18741 64C 2.20        64 Tcfap2a     8.6700
## 18742 64C 2.21        64 Tcfap2a     8.7650
## 18743 64C 2.22        64 Tcfap2a     5.4950
## 18744 64C 2.23        64 Tcfap2a     5.9000
## 18745 64C 2.24        64 Tcfap2a     5.1600
## 18746 64C 2.25        64 Tcfap2a     6.8500
## 18747  64C 3.1        64 Tcfap2a     7.2600
## 18748  64C 3.2        64 Tcfap2a     5.7650
## 18749  64C 3.3        64 Tcfap2a     4.8700
## 18750  64C 3.4        64 Tcfap2a     6.3600
## 18751  64C 3.5        64 Tcfap2a    11.3400
## 18752  64C 3.6        64 Tcfap2a     6.6100
## 18753  64C 3.7        64 Tcfap2a     2.7150
## 18754  64C 3.8        64 Tcfap2a     4.0100
## 18755  64C 4.1        64 Tcfap2a    12.6600
## 18756 64C 4.1b        64 Tcfap2a    14.2350
## 18757  64C 4.2        64 Tcfap2a    12.9600
## 18758  64C 4.3        64 Tcfap2a    14.3950
## 18759  64C 4.4        64 Tcfap2a    13.2600
## 18760  64C 4.5        64 Tcfap2a    12.7300
## 18761  64C 4.6        64 Tcfap2a    12.4350
## 18762  64C 4.7        64 Tcfap2a     5.6450
## 18763  64C 4.8        64 Tcfap2a    10.8650
## 18764  64C 4.9        64 Tcfap2a     5.0700
## 18765 64C 4.10        64 Tcfap2a    14.1900
## 18766 64C 4.11        64 Tcfap2a    13.0850
## 18767 64C 4.12        64 Tcfap2a     7.5850
## 18768 64C 4.13        64 Tcfap2a     5.9900
## 18769 64C 4.14        64 Tcfap2a     5.8300
## 18770 64C 4.15        64 Tcfap2a     9.4050
## 18771 64C 4.16        64 Tcfap2a     7.6750
## 18772 64C 4.17        64 Tcfap2a    11.5650
## 18773 64C 4.18        64 Tcfap2a     4.4550
## 18774 64C 4.19        64 Tcfap2a     5.7200
## 18775 64C 4.20        64 Tcfap2a     6.7050
## 18776 64C 4.21        64 Tcfap2a     8.5600
## 18777 64C 4.22        64 Tcfap2a     6.1200
## 18778 64C 4.23        64 Tcfap2a     5.9550
## 18779 64C 4.24        64 Tcfap2a     4.3950
## 18780 64C 4.25        64 Tcfap2a     9.0050
## 18781 64C 4.26        64 Tcfap2a     9.0150
## 18782 64C 4.27        64 Tcfap2a     7.3650
## 18783 64C 4.28        64 Tcfap2a    13.6300
## 18784 64C 4.29        64 Tcfap2a     5.7750
## 18785 64C 4.30        64 Tcfap2a    10.1300
## 18786 64C 4.31        64 Tcfap2a     4.0200
## 18787 64C 4.32        64 Tcfap2a    12.5750
## 18788 64C 4.33        64 Tcfap2a     5.7850
## 18789 64C 4.34        64 Tcfap2a     6.4650
## 18790 64C 4.35        64 Tcfap2a    10.7850
## 18791 64C 4.36        64 Tcfap2a     6.6100
## 18792 64C 4.37        64 Tcfap2a     7.6150
## 18793 64C 4.38        64 Tcfap2a     6.4525
## 18794 64C 4.39        64 Tcfap2a     7.6200
## 18795  64C 5.1        64 Tcfap2a     6.0500
## 18796  64C 5.2        64 Tcfap2a    12.2600
## 18797  64C 5.3        64 Tcfap2a    10.3100
## 18798  64C 5.4        64 Tcfap2a     5.0850
## 18799  64C 5.5        64 Tcfap2a    11.2000
## 18800  64C 5.6        64 Tcfap2a    13.3600
## 18801  64C 5.7        64 Tcfap2a     7.0950
## 18802  64C 5.8        64 Tcfap2a    12.0825
## 18803  64C 5.9        64 Tcfap2a     9.8450
## 18804 64C 5.10        64 Tcfap2a    13.9850
## 18805 64C 5.11        64 Tcfap2a     4.4950
## 18806 64C 5.12        64 Tcfap2a     2.0450
## 18807 64C 5.13        64 Tcfap2a     3.1150
## 18808 64C 5.14        64 Tcfap2a     2.6650
## 18809 64C 5.15        64 Tcfap2a     8.1000
## 18810 64C 5.16        64 Tcfap2a    13.7500
## 18811  64C 6.1        64 Tcfap2a    11.4600
## 18812  64C 6.2        64 Tcfap2a    13.8850
## 18813  64C 6.3        64 Tcfap2a    13.1300
## 18814  64C 6.4        64 Tcfap2a    11.7650
## 18815  64C 6.5        64 Tcfap2a    11.2100
## 18816  64C 6.6        64 Tcfap2a    11.3750
## 18817  64C 6.7        64 Tcfap2a    10.9100
## 18818  64C 6.8        64 Tcfap2a    11.0000
## 18819  64C 7.1        64 Tcfap2a    13.5550
## 18820  64C 7.2        64 Tcfap2a    12.1600
## 18821  64C 7.3        64 Tcfap2a    13.3950
## 18822  64C 7.4        64 Tcfap2a    14.0200
## 18823  64C 7.5        64 Tcfap2a    11.8600
## 18824  64C 7.6        64 Tcfap2a    11.6300
## 18825  64C 7.7        64 Tcfap2a    12.1650
## 18826  64C 7.8        64 Tcfap2a     6.0000
## 18827  64C 7.9        64 Tcfap2a    14.7500
## 18828 64C 7.10        64 Tcfap2a     6.2900
## 18829 64C 7.11        64 Tcfap2a     4.9750
## 18830 64C 7.12        64 Tcfap2a     6.9800
## 18831 64C 7.13        64 Tcfap2a     6.1700
## 18832 64C 7.14        64 Tcfap2a     6.5250
## 18833   2C 1.1         2 Tcfap2c     0.2400
## 18834   2C 1.2         2 Tcfap2c     1.7850
## 18835   2C 2.1         2 Tcfap2c     1.7900
## 18836   2C 2.2         2 Tcfap2c     4.5700
## 18837   2C 3.1         2 Tcfap2c     3.7300
## 18838   2C 3.2         2 Tcfap2c     3.1200
## 18839   2C 4.1         2 Tcfap2c     3.3500
## 18840   2C 5.1         2 Tcfap2c     1.8600
## 18841   2C 5.2         2 Tcfap2c     0.9850
## 18842   2C 6.1         2 Tcfap2c     0.7450
## 18843   2C 6.2         2 Tcfap2c     2.1400
## 18844   2C 7.1         2 Tcfap2c     0.4700
## 18845   2C 7.2         2 Tcfap2c     2.8100
## 18846   2C 8.1         2 Tcfap2c     3.4650
## 18847   2C 8.2         2 Tcfap2c     2.7850
## 18848   2C 9.1         2 Tcfap2c     3.1550
## 18849   2C 9.2         2 Tcfap2c     3.1250
## 18850  2C 10.1         2 Tcfap2c     1.8000
## 18851  2C 10.2         2 Tcfap2c     1.5450
## 18852   4C 1.1         4 Tcfap2c     1.3150
## 18853   4C 1.2         4 Tcfap2c     1.6300
## 18854   4C 1.3         4 Tcfap2c     3.8600
## 18855   4C 1.4         4 Tcfap2c     2.6450
## 18856   4C 2.1         4 Tcfap2c     2.9550
## 18857   4C 2.2         4 Tcfap2c     3.3050
## 18858   4C 2.3         4 Tcfap2c     4.1850
## 18859   4C 3.1         4 Tcfap2c     1.3300
## 18860   4C 3.2         4 Tcfap2c    -1.4650
## 18861   4C 3.3         4 Tcfap2c     2.9000
## 18862   4C 3.4         4 Tcfap2c     2.6650
## 18863   4C 4.1         4 Tcfap2c     4.9350
## 18864   4C 4.2         4 Tcfap2c     3.7200
## 18865   4C 4.3         4 Tcfap2c     4.8700
## 18866   4C 4.4         4 Tcfap2c     3.9300
## 18867   4C 5.1         4 Tcfap2c     2.6300
## 18868   4C 5.2         4 Tcfap2c     2.1350
## 18869   4C 5.3         4 Tcfap2c     0.3450
## 18870   4C 5.4         4 Tcfap2c     0.5500
## 18871   4C 6.1         4 Tcfap2c     0.9450
## 18872   4C 6.2         4 Tcfap2c     3.4350
## 18873   4C 6.3         4 Tcfap2c     4.7575
## 18874   4C 6.4         4 Tcfap2c     3.0400
## 18875   8C 1.1         8 Tcfap2c     3.8750
## 18876   8C 1.2         8 Tcfap2c     2.7500
## 18877   8C 1.3         8 Tcfap2c     2.2900
## 18878   8C 1.4         8 Tcfap2c     1.8750
## 18879   8C 1.5         8 Tcfap2c     2.7600
## 18880   8C 2.1         8 Tcfap2c     3.2350
## 18881   8C 2.2         8 Tcfap2c     2.6200
## 18882   8C 2.3         8 Tcfap2c     1.4325
## 18883   8C 2.4         8 Tcfap2c     6.0850
## 18884   8C 2.5         8 Tcfap2c     1.7350
## 18885   8C 2.6         8 Tcfap2c     1.9750
## 18886   8C 2.7         8 Tcfap2c    -0.6850
## 18887   8C 2.8         8 Tcfap2c     1.3900
## 18888   8C 3.1         8 Tcfap2c     1.4050
## 18889   8C 3.2         8 Tcfap2c     3.3250
## 18890   8C 3.3         8 Tcfap2c     4.7950
## 18891   8C 3.4         8 Tcfap2c     3.3450
## 18892   8C 3.5         8 Tcfap2c     2.7650
## 18893   8C 3.6         8 Tcfap2c     0.6800
## 18894   8C 3.7         8 Tcfap2c     0.1750
## 18895   8C 3.8         8 Tcfap2c     0.2000
## 18896   8C 4.2         8 Tcfap2c     2.2750
## 18897   8C 4.3         8 Tcfap2c    -0.3650
## 18898   8C 4.4         8 Tcfap2c     3.6400
## 18899   8C 4.5         8 Tcfap2c     4.8750
## 18900   8C 4.6         8 Tcfap2c     2.4450
## 18901   8C 4.7         8 Tcfap2c     2.5950
## 18902   8C 5.1         8 Tcfap2c     1.3450
## 18903   8C 5.2         8 Tcfap2c     1.3700
## 18904   8C 5.3         8 Tcfap2c    -0.8450
## 18905   8C 5.4         8 Tcfap2c     0.4150
## 18906   8C 5.5         8 Tcfap2c    -0.2650
## 18907   8C 5.6         8 Tcfap2c     2.5100
## 18908   8C 5.7         8 Tcfap2c     2.5750
## 18909   8C 5.8         8 Tcfap2c     2.4100
## 18910   8C 6.1         8 Tcfap2c     3.9500
## 18911   8C 6.2         8 Tcfap2c     3.6250
## 18912   8C 6.3         8 Tcfap2c     2.3050
## 18913   8C 6.4         8 Tcfap2c    -1.1400
## 18914   8C 6.5         8 Tcfap2c     0.7800
## 18915   8C 6.6         8 Tcfap2c     0.6550
## 18916   8C 6.7         8 Tcfap2c     3.6200
## 18917   8C 6.8         8 Tcfap2c     2.8450
## 18918  16C 1.1        16 Tcfap2c     3.9250
## 18919  16C 1.2        16 Tcfap2c     3.6650
## 18920  16C 1.3        16 Tcfap2c     4.3550
## 18921  16C 1.4        16 Tcfap2c     0.2550
## 18922  16C 1.5        16 Tcfap2c     0.3800
## 18923  16C 1.6        16 Tcfap2c     1.2600
## 18924  16C 1.7        16 Tcfap2c     1.0950
## 18925  16C 1.8        16 Tcfap2c     2.8850
## 18926  16C 1.9        16 Tcfap2c     3.8250
## 18927 16C 1.10        16 Tcfap2c     1.5150
## 18928 16C 1.11        16 Tcfap2c     1.6850
## 18929 16C 1.12        16 Tcfap2c     3.3500
## 18930 16C 1.13        16 Tcfap2c     0.5700
## 18931 16C 1.14        16 Tcfap2c     0.4550
## 18932 16C 1.15        16 Tcfap2c     1.2350
## 18933 16C 1.16        16 Tcfap2c     1.5000
## 18934  16C 2.1        16 Tcfap2c     4.9600
## 18935  16C 2.2        16 Tcfap2c     2.9650
## 18936  16C 2.3        16 Tcfap2c     2.2500
## 18937  16C 2.4        16 Tcfap2c     4.1300
## 18938  16C 2.5        16 Tcfap2c     2.5050
## 18939  16C 2.6        16 Tcfap2c     1.8000
## 18940  16C 2.7        16 Tcfap2c     1.2500
## 18941  16C 2.8        16 Tcfap2c     1.8150
## 18942  16C 2.9        16 Tcfap2c     1.4100
## 18943 16C 2.10        16 Tcfap2c     3.0000
## 18944 16C 2.11        16 Tcfap2c     3.6600
## 18945 16C 2.12        16 Tcfap2c     3.8000
## 18946 16C 2.13        16 Tcfap2c     2.6200
## 18947 16C 2.14        16 Tcfap2c     2.9800
## 18948 16C 2.15        16 Tcfap2c     1.3850
## 18949 16C 2.16        16 Tcfap2c     0.7350
## 18950  16C 3.1        16 Tcfap2c     2.2200
## 18951  16C 3.2        16 Tcfap2c     1.4600
## 18952  16C 3.3        16 Tcfap2c     3.8000
## 18953  16C 3.4        16 Tcfap2c     4.5250
## 18954  16C 3.5        16 Tcfap2c     2.7150
## 18955  16C 3.6        16 Tcfap2c     3.1750
## 18956  16C 3.7        16 Tcfap2c     3.9450
## 18957  16C 3.8        16 Tcfap2c     2.2800
## 18958  16C 3.9        16 Tcfap2c     2.6850
## 18959 16C 3.10        16 Tcfap2c     1.6950
## 18960 16C 3.11        16 Tcfap2c     1.6600
## 18961 16C 3.12        16 Tcfap2c     4.5800
## 18962 16C 3.13        16 Tcfap2c     3.6150
## 18963 16C 3.14        16 Tcfap2c     3.3850
## 18964 16C 3.15        16 Tcfap2c     3.0050
## 18965  16C 4.1        16 Tcfap2c     4.0350
## 18966  16C 4.2        16 Tcfap2c     0.5900
## 18967  16C 4.3        16 Tcfap2c    -2.9950
## 18968  16C 4.4        16 Tcfap2c     1.5800
## 18969  16C 4.5        16 Tcfap2c     1.8050
## 18970  16C 4.6        16 Tcfap2c     4.2550
## 18971  16C 4.7        16 Tcfap2c     4.4600
## 18972  16C 4.8        16 Tcfap2c     3.5300
## 18973  16C 4.9        16 Tcfap2c     3.7300
## 18974 16C 4.10        16 Tcfap2c     2.9400
## 18975 16C 4.11        16 Tcfap2c     2.1050
## 18976 16C 4.12        16 Tcfap2c     0.7550
## 18977 16C 4.13        16 Tcfap2c     1.0800
## 18978 16C 4.14        16 Tcfap2c     1.4150
## 18979 16C 4.15        16 Tcfap2c     4.3250
## 18980 16C 4.16        16 Tcfap2c     4.6875
## 18981  16C 5.1        16 Tcfap2c     3.3200
## 18982  16C 5.2        16 Tcfap2c     2.8150
## 18983  16C 5.3        16 Tcfap2c     2.6300
## 18984  16C 5.4        16 Tcfap2c     1.0300
## 18985  16C 5.5        16 Tcfap2c     0.5550
## 18986  16C 5.6        16 Tcfap2c     2.3400
## 18987  16C 5.7        16 Tcfap2c     2.9850
## 18988  16C 5.8        16 Tcfap2c     2.9200
## 18989  16C 5.9        16 Tcfap2c     2.3125
## 18990 16C 5.10        16 Tcfap2c     4.0950
## 18991 16C 5.11        16 Tcfap2c     1.6450
## 18992 16C 5.12        16 Tcfap2c     2.4450
## 18993  32C 1.1        32 Tcfap2c     0.7550
## 18994  32C 1.2        32 Tcfap2c     3.2600
## 18995  32C 1.3        32 Tcfap2c     1.8450
## 18996  32C 1.4        32 Tcfap2c     2.9450
## 18997  32C 1.5        32 Tcfap2c     5.1650
## 18998  32C 1.6        32 Tcfap2c     4.4250
## 18999  32C 1.7        32 Tcfap2c     4.3350
## 19000  32C 1.8        32 Tcfap2c     1.9900
## 19001  32C 1.9        32 Tcfap2c     1.9750
## 19002 32C 1.10        32 Tcfap2c     1.6000
## 19003 32C 1.11        32 Tcfap2c     2.8850
## 19004 32C 1.12        32 Tcfap2c     0.7150
## 19005 32C 1.13        32 Tcfap2c     4.9600
## 19006 32C 1.14        32 Tcfap2c     4.1950
## 19007 32C 1.15        32 Tcfap2c     3.6050
## 19008 32C 1.16        32 Tcfap2c     4.1950
## 19009 32C 1.17        32 Tcfap2c     2.6050
## 19010 32C 1.18        32 Tcfap2c     3.4000
## 19011 32C 1.19        32 Tcfap2c     0.0750
## 19012 32C 1.20        32 Tcfap2c     2.5150
## 19013 32C 1.21        32 Tcfap2c     1.0150
## 19014  32C 2.1        32 Tcfap2c     3.1500
## 19015  32C 2.2        32 Tcfap2c     4.3250
## 19016  32C 2.3        32 Tcfap2c     2.7000
## 19017  32C 2.4        32 Tcfap2c     4.9900
## 19018  32C 2.5        32 Tcfap2c     4.8150
## 19019  32C 2.6        32 Tcfap2c     3.5950
## 19020  32C 2.7        32 Tcfap2c    -0.2600
## 19021  32C 2.8        32 Tcfap2c     2.3300
## 19022  32C 2.9        32 Tcfap2c     0.5850
## 19023 32C 2.10        32 Tcfap2c     3.9300
## 19024 32C 2.11        32 Tcfap2c     4.8050
## 19025 32C 2.12        32 Tcfap2c     3.9950
## 19026 32C 2.13        32 Tcfap2c     5.1950
## 19027 32C 2.14        32 Tcfap2c     4.9350
## 19028 32C 2.15        32 Tcfap2c     1.0750
## 19029 32C 2.16        32 Tcfap2c     1.7500
## 19030  32C 3.1        32 Tcfap2c     2.1800
## 19031  32C 3.2        32 Tcfap2c     2.3550
## 19032  32C 3.3        32 Tcfap2c     3.0850
## 19033  32C 3.4        32 Tcfap2c     4.7850
## 19034  32C 3.5        32 Tcfap2c     3.0150
## 19035  32C 3.6        32 Tcfap2c     3.9650
## 19036  32C 3.7        32 Tcfap2c     5.7100
## 19037  32C 3.8        32 Tcfap2c     3.0800
## 19038  32C 4.1        32 Tcfap2c     1.7450
## 19039  32C 4.2        32 Tcfap2c     3.1450
## 19040  32C 4.3        32 Tcfap2c     1.2400
## 19041  32C 4.4        32 Tcfap2c     5.0400
## 19042  32C 4.5        32 Tcfap2c     4.0450
## 19043  32C 4.6        32 Tcfap2c     3.8800
## 19044  32C 4.7        32 Tcfap2c     5.0800
## 19045  32C 4.8        32 Tcfap2c     2.8050
## 19046 32C 4.10        32 Tcfap2c     2.3300
## 19047 32C 4.11        32 Tcfap2c     2.1200
## 19048 32C 4.12        32 Tcfap2c     2.1850
## 19049 32C 4.13        32 Tcfap2c     1.7400
## 19050 32C 4.14        32 Tcfap2c     3.7500
## 19051 32C 4.15        32 Tcfap2c     4.5100
## 19052 32C 4.16        32 Tcfap2c     5.1400
## 19053 32C 4.17        32 Tcfap2c     2.9300
## 19054 32C 4.18        32 Tcfap2c     3.6000
## 19055 32C 4.19        32 Tcfap2c     1.8650
## 19056 32C 4.20        32 Tcfap2c     1.4650
## 19057 32C 4.21        32 Tcfap2c     3.3600
## 19058 32C 4.22        32 Tcfap2c     0.9000
## 19059 32C 4.23        32 Tcfap2c     4.0000
## 19060 32C 4.24        32 Tcfap2c     4.9950
## 19061  32C 5.1        32 Tcfap2c     2.9050
## 19062  32C 5.2        32 Tcfap2c     3.9650
## 19063  32C 5.3        32 Tcfap2c     4.7850
## 19064  32C 5.4        32 Tcfap2c     2.1700
## 19065  32C 5.5        32 Tcfap2c     2.7450
## 19066  32C 5.6        32 Tcfap2c     2.2850
## 19067  32C 5.7        32 Tcfap2c     2.4900
## 19068  32C 5.8        32 Tcfap2c     5.1500
## 19069  32C 5.9        32 Tcfap2c     2.9650
## 19070 32C 5.10        32 Tcfap2c     4.0350
## 19071 32C 5.11        32 Tcfap2c     3.5650
## 19072 32C 5.12        32 Tcfap2c     5.2950
## 19073 32C 5.13        32 Tcfap2c     2.3200
## 19074 32C 5.14        32 Tcfap2c    -1.9450
## 19075 32C 5.15        32 Tcfap2c     3.0400
## 19076 32C 5.16        32 Tcfap2c     0.1050
## 19077 32C 5.17        32 Tcfap2c     4.2050
## 19078 32C 5.18        32 Tcfap2c     4.5400
## 19079 32C 5.19        32 Tcfap2c     3.0100
## 19080 32C 5.20        32 Tcfap2c     3.1300
## 19081 32C 5.21        32 Tcfap2c     3.0100
## 19082 32C 5.22        32 Tcfap2c     2.2550
## 19083 32C 5.23        32 Tcfap2c     0.6550
## 19084  32C 6.1        32 Tcfap2c     1.1550
## 19085  32C 6.2        32 Tcfap2c     1.8100
## 19086  32C 6.3        32 Tcfap2c     5.9350
## 19087  32C 6.4        32 Tcfap2c     7.0725
## 19088  32C 6.6        32 Tcfap2c     4.5850
## 19089  32C 6.7        32 Tcfap2c     4.5900
## 19090  32C 7.1        32 Tcfap2c     3.5800
## 19091  32C 7.2        32 Tcfap2c     3.5900
## 19092  32C 7.3        32 Tcfap2c     3.4000
## 19093  32C 7.4        32 Tcfap2c     4.3600
## 19094  32C 7.5        32 Tcfap2c     5.5650
## 19095  32C 7.6        32 Tcfap2c     5.2050
## 19096  32C 7.8        32 Tcfap2c     4.5075
## 19097  32C 8.1        32 Tcfap2c     6.5800
## 19098  32C 8.2        32 Tcfap2c     3.5600
## 19099  32C 8.4        32 Tcfap2c     4.7800
## 19100  32C 8.5        32 Tcfap2c     2.6200
## 19101  32C 8.6        32 Tcfap2c     4.5450
## 19102  64C 1.1        64 Tcfap2c     4.0150
## 19103  64C 1.2        64 Tcfap2c     3.2250
## 19104  64C 1.3        64 Tcfap2c     7.0750
## 19105  64C 1.4        64 Tcfap2c     5.8050
## 19106  64C 1.5        64 Tcfap2c     5.5550
## 19107  64C 1.6        64 Tcfap2c     3.7200
## 19108  64C 1.7        64 Tcfap2c     3.0150
## 19109  64C 1.8        64 Tcfap2c     1.5600
## 19110  64C 1.9        64 Tcfap2c     3.5450
## 19111 64C 1.10        64 Tcfap2c     1.4350
## 19112 64C 1.11        64 Tcfap2c     5.3800
## 19113 64C 1.12        64 Tcfap2c     4.9850
## 19114 64C 1.13        64 Tcfap2c     4.9250
## 19115 64C 1.14        64 Tcfap2c     5.4850
## 19116 64C 1.15        64 Tcfap2c     2.9950
## 19117 64C 1.16        64 Tcfap2c     4.0800
## 19118 64C 1.17        64 Tcfap2c     0.9850
## 19119 64C 1.18        64 Tcfap2c     2.2350
## 19120 64C 1.19        64 Tcfap2c     2.1350
## 19121 64C 1.20        64 Tcfap2c     4.2800
## 19122 64C 1.21        64 Tcfap2c     5.7250
## 19123 64C 1.22        64 Tcfap2c     5.1200
## 19124 64C 1.23        64 Tcfap2c     6.6800
## 19125 64C 1.24        64 Tcfap2c     6.0550
## 19126 64C 1.25        64 Tcfap2c     3.5850
## 19127 64C 1.26        64 Tcfap2c     1.9700
## 19128 64C 1.27        64 Tcfap2c     2.0400
## 19129 64C 1.28        64 Tcfap2c     1.9350
## 19130 64C 1.29        64 Tcfap2c     5.0400
## 19131 64C 1.30        64 Tcfap2c     4.5850
## 19132 64C 1.31        64 Tcfap2c     3.5850
## 19133 64C 1.32        64 Tcfap2c     5.6050
## 19134 64C 1.33        64 Tcfap2c     5.6450
## 19135 64C 1.34        64 Tcfap2c     3.5950
## 19136 64C 1.35        64 Tcfap2c     1.2400
## 19137 64C 1.36        64 Tcfap2c     2.4500
## 19138 64C 1.37        64 Tcfap2c     3.4350
## 19139 64C 1.38        64 Tcfap2c     4.0850
## 19140 64C 1.39        64 Tcfap2c     6.0650
## 19141 64C 1.40        64 Tcfap2c     4.1750
## 19142 64C 1.41        64 Tcfap2c     4.7650
## 19143 64C 1.42        64 Tcfap2c     5.7300
## 19144 64C 1.43        64 Tcfap2c     5.3600
## 19145 64C 1.44        64 Tcfap2c     3.9350
## 19146 64C 1.45        64 Tcfap2c     4.8250
## 19147 64C 1.46        64 Tcfap2c     2.9000
## 19148 64C 1.47        64 Tcfap2c     6.8500
## 19149 64C 1.48        64 Tcfap2c     5.8650
## 19150  64C 2.1        64 Tcfap2c     4.0200
## 19151  64C 2.2        64 Tcfap2c     5.5900
## 19152  64C 2.3        64 Tcfap2c     5.4250
## 19153  64C 2.4        64 Tcfap2c     5.3700
## 19154  64C 2.5        64 Tcfap2c     4.6000
## 19155  64C 2.6        64 Tcfap2c     4.4750
## 19156  64C 2.7        64 Tcfap2c     4.1300
## 19157  64C 2.8        64 Tcfap2c     6.7200
## 19158  64C 2.9        64 Tcfap2c     5.6700
## 19159 64C 2.10        64 Tcfap2c     4.8200
## 19160 64C 2.11        64 Tcfap2c     5.1300
## 19161 64C 2.12        64 Tcfap2c     5.5700
## 19162 64C 2.13        64 Tcfap2c     3.4850
## 19163 64C 2.14        64 Tcfap2c     3.1050
## 19164 64C 2.15        64 Tcfap2c     4.2300
## 19165 64C 2.16        64 Tcfap2c     4.2800
## 19166 64C 2.17        64 Tcfap2c     6.4400
## 19167 64C 2.18        64 Tcfap2c     5.3450
## 19168 64C 2.19        64 Tcfap2c     5.4150
## 19169 64C 2.20        64 Tcfap2c     5.7550
## 19170 64C 2.21        64 Tcfap2c     6.1450
## 19171 64C 2.22        64 Tcfap2c     4.2800
## 19172 64C 2.23        64 Tcfap2c     3.9750
## 19173 64C 2.24        64 Tcfap2c     4.0650
## 19174 64C 2.25        64 Tcfap2c     3.8000
## 19175  64C 3.1        64 Tcfap2c     6.5500
## 19176  64C 3.2        64 Tcfap2c     5.2350
## 19177  64C 3.3        64 Tcfap2c     5.2450
## 19178  64C 3.4        64 Tcfap2c     4.3750
## 19179  64C 3.5        64 Tcfap2c     7.2150
## 19180  64C 3.6        64 Tcfap2c     3.7600
## 19181  64C 3.7        64 Tcfap2c    -0.5150
## 19182  64C 3.8        64 Tcfap2c     4.1100
## 19183  64C 4.1        64 Tcfap2c     4.7650
## 19184 64C 4.1b        64 Tcfap2c     7.8050
## 19185  64C 4.2        64 Tcfap2c     6.1300
## 19186  64C 4.3        64 Tcfap2c     7.3000
## 19187  64C 4.4        64 Tcfap2c     6.7200
## 19188  64C 4.5        64 Tcfap2c     6.1700
## 19189  64C 4.6        64 Tcfap2c     5.5950
## 19190  64C 4.7        64 Tcfap2c     2.7050
## 19191  64C 4.8        64 Tcfap2c     3.4600
## 19192  64C 4.9        64 Tcfap2c     3.5050
## 19193 64C 4.10        64 Tcfap2c     6.5750
## 19194 64C 4.11        64 Tcfap2c     7.6475
## 19195 64C 4.12        64 Tcfap2c     5.6800
## 19196 64C 4.13        64 Tcfap2c     4.2250
## 19197 64C 4.14        64 Tcfap2c     3.6300
## 19198 64C 4.15        64 Tcfap2c     3.6100
## 19199 64C 4.16        64 Tcfap2c     2.2350
## 19200 64C 4.17        64 Tcfap2c     4.5000
## 19201 64C 4.18        64 Tcfap2c     5.1550
## 19202 64C 4.19        64 Tcfap2c     4.7300
## 19203 64C 4.20        64 Tcfap2c     2.9625
## 19204 64C 4.21        64 Tcfap2c     5.7250
## 19205 64C 4.22        64 Tcfap2c     3.3050
## 19206 64C 4.23        64 Tcfap2c     3.6350
## 19207 64C 4.24        64 Tcfap2c     2.7450
## 19208 64C 4.25        64 Tcfap2c     3.8100
## 19209 64C 4.26        64 Tcfap2c     4.1250
## 19210 64C 4.27        64 Tcfap2c     5.3950
## 19211 64C 4.28        64 Tcfap2c     6.6250
## 19212 64C 4.29        64 Tcfap2c     3.8450
## 19213 64C 4.30        64 Tcfap2c     6.1950
## 19214 64C 4.31        64 Tcfap2c     2.4000
## 19215 64C 4.32        64 Tcfap2c     3.5750
## 19216 64C 4.33        64 Tcfap2c     2.2000
## 19217 64C 4.34        64 Tcfap2c     2.2750
## 19218 64C 4.35        64 Tcfap2c     2.3950
## 19219 64C 4.36        64 Tcfap2c     4.3400
## 19220 64C 4.37        64 Tcfap2c     4.8750
## 19221 64C 4.38        64 Tcfap2c     4.2750
## 19222 64C 4.39        64 Tcfap2c     6.9350
## 19223  64C 5.1        64 Tcfap2c     3.2850
## 19224  64C 5.2        64 Tcfap2c     5.3500
## 19225  64C 5.3        64 Tcfap2c     2.7950
## 19226  64C 5.4        64 Tcfap2c     3.0850
## 19227  64C 5.5        64 Tcfap2c     3.4050
## 19228  64C 5.6        64 Tcfap2c     6.0400
## 19229  64C 5.7        64 Tcfap2c     5.6250
## 19230  64C 5.8        64 Tcfap2c     5.2600
## 19231  64C 5.9        64 Tcfap2c     6.8900
## 19232 64C 5.10        64 Tcfap2c     5.8050
## 19233 64C 5.11        64 Tcfap2c     3.6650
## 19234 64C 5.12        64 Tcfap2c     1.2900
## 19235 64C 5.13        64 Tcfap2c     2.6400
## 19236 64C 5.14        64 Tcfap2c     1.7450
## 19237 64C 5.15        64 Tcfap2c     5.4900
## 19238 64C 5.16        64 Tcfap2c     4.2950
## 19239  64C 6.1        64 Tcfap2c     4.8850
## 19240  64C 6.2        64 Tcfap2c     6.5750
## 19241  64C 6.3        64 Tcfap2c     8.1350
## 19242  64C 6.4        64 Tcfap2c     3.9150
## 19243  64C 6.5        64 Tcfap2c     4.0500
## 19244  64C 6.6        64 Tcfap2c     3.7200
## 19245  64C 6.7        64 Tcfap2c     4.2950
## 19246  64C 6.8        64 Tcfap2c     6.8550
## 19247  64C 7.1        64 Tcfap2c     7.5850
## 19248  64C 7.2        64 Tcfap2c     5.2050
## 19249  64C 7.3        64 Tcfap2c     5.3450
## 19250  64C 7.4        64 Tcfap2c     7.0600
## 19251  64C 7.5        64 Tcfap2c     5.5500
## 19252  64C 7.6        64 Tcfap2c     4.6550
## 19253  64C 7.7        64 Tcfap2c     5.2350
## 19254  64C 7.8        64 Tcfap2c     5.3900
## 19255  64C 7.9        64 Tcfap2c    14.4500
## 19256 64C 7.10        64 Tcfap2c     4.5350
## 19257 64C 7.11        64 Tcfap2c     4.8800
## 19258 64C 7.12        64 Tcfap2c     4.9800
## 19259 64C 7.13        64 Tcfap2c     5.7050
## 19260 64C 7.14        64 Tcfap2c     4.5500
## 19261   2C 1.1         2   Tcf23    11.4450
## 19262   2C 1.2         2   Tcf23    12.3950
## 19263   2C 2.1         2   Tcf23    11.3550
## 19264   2C 2.2         2   Tcf23    14.2400
## 19265   2C 3.1         2   Tcf23    12.6150
## 19266   2C 3.2         2   Tcf23    13.4350
## 19267   2C 4.1         2   Tcf23     6.3300
## 19268   2C 5.1         2   Tcf23    13.8600
## 19269   2C 5.2         2   Tcf23     7.4550
## 19270   2C 6.1         2   Tcf23     8.9450
## 19271   2C 6.2         2   Tcf23    10.9700
## 19272   2C 7.1         2   Tcf23    11.7300
## 19273   2C 7.2         2   Tcf23    13.2150
## 19274   2C 8.1         2   Tcf23     8.4350
## 19275   2C 8.2         2   Tcf23     7.4750
## 19276   2C 9.1         2   Tcf23     7.3500
## 19277   2C 9.2         2   Tcf23     9.3650
## 19278  2C 10.1         2   Tcf23    11.6550
## 19279  2C 10.2         2   Tcf23     6.5500
## 19280   4C 1.1         4   Tcf23    11.3700
## 19281   4C 1.2         4   Tcf23     7.6750
## 19282   4C 1.3         4   Tcf23    14.8150
## 19283   4C 1.4         4   Tcf23     9.0300
## 19284   4C 2.1         4   Tcf23    13.3900
## 19285   4C 2.2         4   Tcf23     8.5100
## 19286   4C 2.3         4   Tcf23    13.1900
## 19287   4C 3.1         4   Tcf23     7.5250
## 19288   4C 3.2         4   Tcf23     4.2350
## 19289   4C 3.3         4   Tcf23     7.8250
## 19290   4C 3.4         4   Tcf23     3.2950
## 19291   4C 4.1         4   Tcf23    10.3550
## 19292   4C 4.2         4   Tcf23    10.7150
## 19293   4C 4.3         4   Tcf23     7.5500
## 19294   4C 4.4         4   Tcf23     6.5550
## 19295   4C 5.1         4   Tcf23     4.5500
## 19296   4C 5.2         4   Tcf23     4.2800
## 19297   4C 5.3         4   Tcf23     2.5450
## 19298   4C 5.4         4   Tcf23     4.1300
## 19299   4C 6.1         4   Tcf23     7.1100
## 19300   4C 6.2         4   Tcf23     8.7600
## 19301   4C 6.3         4   Tcf23     9.2350
## 19302   4C 6.4         4   Tcf23     5.6800
## 19303   8C 1.1         8   Tcf23     8.2200
## 19304   8C 1.2         8   Tcf23     7.4400
## 19305   8C 1.3         8   Tcf23    10.9850
## 19306   8C 1.4         8   Tcf23     3.3050
## 19307   8C 1.5         8   Tcf23     6.0000
## 19308   8C 2.1         8   Tcf23     5.7200
## 19309   8C 2.2         8   Tcf23    13.1150
## 19310   8C 2.3         8   Tcf23    13.6125
## 19311   8C 2.4         8   Tcf23    13.8100
## 19312   8C 2.5         8   Tcf23     6.4700
## 19313   8C 2.6         8   Tcf23     9.4450
## 19314   8C 2.7         8   Tcf23     5.5650
## 19315   8C 2.8         8   Tcf23     6.6150
## 19316   8C 3.1         8   Tcf23     4.3400
## 19317   8C 3.2         8   Tcf23     9.9900
## 19318   8C 3.3         8   Tcf23     9.0850
## 19319   8C 3.4         8   Tcf23     6.7900
## 19320   8C 3.5         8   Tcf23     6.9300
## 19321   8C 3.6         8   Tcf23     7.2950
## 19322   8C 3.7         8   Tcf23     2.7250
## 19323   8C 3.8         8   Tcf23     4.8650
## 19324   8C 4.2         8   Tcf23    12.6350
## 19325   8C 4.3         8   Tcf23     2.5300
## 19326   8C 4.4         8   Tcf23     6.9000
## 19327   8C 4.5         8   Tcf23     8.3100
## 19328   8C 4.6         8   Tcf23     4.9000
## 19329   8C 4.7         8   Tcf23     7.8600
## 19330   8C 5.1         8   Tcf23     4.9450
## 19331   8C 5.2         8   Tcf23     3.9300
## 19332   8C 5.3         8   Tcf23     2.4850
## 19333   8C 5.4         8   Tcf23     3.9550
## 19334   8C 5.5         8   Tcf23     2.0200
## 19335   8C 5.6         8   Tcf23     8.6150
## 19336   8C 5.7         8   Tcf23     6.8200
## 19337   8C 5.8         8   Tcf23     6.8700
## 19338   8C 6.1         8   Tcf23     9.2400
## 19339   8C 6.2         8   Tcf23     6.3150
## 19340   8C 6.3         8   Tcf23     4.7900
## 19341   8C 6.4         8   Tcf23     3.7000
## 19342   8C 6.5         8   Tcf23     7.8850
## 19343   8C 6.6         8   Tcf23     5.5350
## 19344   8C 6.7         8   Tcf23     7.6200
## 19345   8C 6.8         8   Tcf23     9.1350
## 19346  16C 1.1        16   Tcf23    12.7800
## 19347  16C 1.2        16   Tcf23     6.1050
## 19348  16C 1.3        16   Tcf23    14.4400
## 19349  16C 1.4        16   Tcf23     6.4650
## 19350  16C 1.5        16   Tcf23     5.1350
## 19351  16C 1.6        16   Tcf23     9.8950
## 19352  16C 1.7        16   Tcf23     7.2950
## 19353  16C 1.8        16   Tcf23    11.8650
## 19354  16C 1.9        16   Tcf23    10.1150
## 19355 16C 1.10        16   Tcf23     7.9750
## 19356 16C 1.11        16   Tcf23    14.8800
## 19357 16C 1.12        16   Tcf23     7.1750
## 19358 16C 1.13        16   Tcf23     7.6750
## 19359 16C 1.14        16   Tcf23     7.3250
## 19360 16C 1.15        16   Tcf23     5.6100
## 19361 16C 1.16        16   Tcf23    12.4750
## 19362  16C 2.1        16   Tcf23    13.4600
## 19363  16C 2.2        16   Tcf23     8.6400
## 19364  16C 2.3        16   Tcf23    11.5100
## 19365  16C 2.4        16   Tcf23    13.9100
## 19366  16C 2.5        16   Tcf23     7.6000
## 19367  16C 2.6        16   Tcf23     6.7750
## 19368  16C 2.7        16   Tcf23     5.1050
## 19369  16C 2.8        16   Tcf23     5.6350
## 19370  16C 2.9        16   Tcf23    11.3550
## 19371 16C 2.10        16   Tcf23     7.8400
## 19372 16C 2.11        16   Tcf23     9.4650
## 19373 16C 2.12        16   Tcf23     7.2050
## 19374 16C 2.13        16   Tcf23     9.9600
## 19375 16C 2.14        16   Tcf23     8.1800
## 19376 16C 2.15        16   Tcf23     6.0950
## 19377 16C 2.16        16   Tcf23     5.0150
## 19378  16C 3.1        16   Tcf23    12.6600
## 19379  16C 3.2        16   Tcf23     6.5200
## 19380  16C 3.3        16   Tcf23    13.2150
## 19381  16C 3.4        16   Tcf23    13.8250
## 19382  16C 3.5        16   Tcf23     9.2050
## 19383  16C 3.6        16   Tcf23    13.1700
## 19384  16C 3.7        16   Tcf23     9.7950
## 19385  16C 3.8        16   Tcf23    11.6550
## 19386  16C 3.9        16   Tcf23    11.2700
## 19387 16C 3.10        16   Tcf23    11.3700
## 19388 16C 3.11        16   Tcf23    11.2450
## 19389 16C 3.12        16   Tcf23    11.4250
## 19390 16C 3.13        16   Tcf23    11.9700
## 19391 16C 3.14        16   Tcf23     9.2500
## 19392 16C 3.15        16   Tcf23    13.9800
## 19393  16C 4.1        16   Tcf23    13.1900
## 19394  16C 4.2        16   Tcf23     5.9550
## 19395  16C 4.3        16   Tcf23     5.5750
## 19396  16C 4.4        16   Tcf23     7.9850
## 19397  16C 4.5        16   Tcf23    10.5250
## 19398  16C 4.6        16   Tcf23    13.5550
## 19399  16C 4.7        16   Tcf23    10.6350
## 19400  16C 4.8        16   Tcf23    10.0700
## 19401  16C 4.9        16   Tcf23     8.9750
## 19402 16C 4.10        16   Tcf23     9.2200
## 19403 16C 4.11        16   Tcf23    11.2700
## 19404 16C 4.12        16   Tcf23     7.1250
## 19405 16C 4.13        16   Tcf23    11.6800
## 19406 16C 4.14        16   Tcf23     7.9200
## 19407 16C 4.15        16   Tcf23    11.0400
## 19408 16C 4.16        16   Tcf23    13.7850
## 19409  16C 5.1        16   Tcf23     8.0200
## 19410  16C 5.2        16   Tcf23     7.7000
## 19411  16C 5.3        16   Tcf23     7.2100
## 19412  16C 5.4        16   Tcf23     7.3250
## 19413  16C 5.5        16   Tcf23     4.7550
## 19414  16C 5.6        16   Tcf23     7.4700
## 19415  16C 5.7        16   Tcf23     9.1800
## 19416  16C 5.8        16   Tcf23    13.1150
## 19417  16C 5.9        16   Tcf23     7.1825
## 19418 16C 5.10        16   Tcf23     7.9800
## 19419 16C 5.11        16   Tcf23     7.1200
## 19420 16C 5.12        16   Tcf23     8.3250
## 19421  32C 1.1        32   Tcf23    10.6250
## 19422  32C 1.2        32   Tcf23     6.6650
## 19423  32C 1.3        32   Tcf23    10.4200
## 19424  32C 1.4        32   Tcf23    13.2600
## 19425  32C 1.5        32   Tcf23    10.5250
## 19426  32C 1.6        32   Tcf23     5.2200
## 19427  32C 1.7        32   Tcf23     9.5800
## 19428  32C 1.8        32   Tcf23     8.2550
## 19429  32C 1.9        32   Tcf23     4.2250
## 19430 32C 1.10        32   Tcf23     3.9750
## 19431 32C 1.11        32   Tcf23    12.6350
## 19432 32C 1.12        32   Tcf23    10.8400
## 19433 32C 1.13        32   Tcf23     7.0700
## 19434 32C 1.14        32   Tcf23     9.5200
## 19435 32C 1.15        32   Tcf23     5.4100
## 19436 32C 1.16        32   Tcf23     6.9500
## 19437 32C 1.17        32   Tcf23     4.6750
## 19438 32C 1.18        32   Tcf23     8.5400
## 19439 32C 1.19        32   Tcf23     4.4650
## 19440 32C 1.20        32   Tcf23     3.6850
## 19441 32C 1.21        32   Tcf23     1.5700
## 19442  32C 2.1        32   Tcf23    14.7350
## 19443  32C 2.2        32   Tcf23    13.8200
## 19444  32C 2.3        32   Tcf23    12.9700
## 19445  32C 2.4        32   Tcf23     7.8000
## 19446  32C 2.5        32   Tcf23    12.7150
## 19447  32C 2.6        32   Tcf23    11.5100
## 19448  32C 2.7        32   Tcf23     5.9900
## 19449  32C 2.8        32   Tcf23     4.2350
## 19450  32C 2.9        32   Tcf23    11.0750
## 19451 32C 2.10        32   Tcf23     8.6500
## 19452 32C 2.11        32   Tcf23     8.7250
## 19453 32C 2.12        32   Tcf23    12.7800
## 19454 32C 2.13        32   Tcf23     8.6450
## 19455 32C 2.14        32   Tcf23     7.9300
## 19456 32C 2.15        32   Tcf23     7.7450
## 19457 32C 2.16        32   Tcf23     6.7850
## 19458  32C 3.1        32   Tcf23     9.8950
## 19459  32C 3.2        32   Tcf23    11.5850
## 19460  32C 3.3        32   Tcf23    11.8050
## 19461  32C 3.4        32   Tcf23    10.4250
## 19462  32C 3.5        32   Tcf23    12.3750
## 19463  32C 3.6        32   Tcf23    10.2200
## 19464  32C 3.7        32   Tcf23     7.9250
## 19465  32C 3.8        32   Tcf23     7.0150
## 19466  32C 4.1        32   Tcf23     8.2450
## 19467  32C 4.2        32   Tcf23    12.4100
## 19468  32C 4.3        32   Tcf23     6.0650
## 19469  32C 4.4        32   Tcf23     7.5100
## 19470  32C 4.5        32   Tcf23    13.4100
## 19471  32C 4.6        32   Tcf23     7.9100
## 19472  32C 4.7        32   Tcf23    10.1200
## 19473  32C 4.8        32   Tcf23    13.7500
## 19474 32C 4.10        32   Tcf23    13.2950
## 19475 32C 4.11        32   Tcf23     6.2650
## 19476 32C 4.12        32   Tcf23     5.5150
## 19477 32C 4.13        32   Tcf23     6.7050
## 19478 32C 4.14        32   Tcf23     8.9300
## 19479 32C 4.15        32   Tcf23     6.4450
## 19480 32C 4.16        32   Tcf23     6.1250
## 19481 32C 4.17        32   Tcf23     9.9600
## 19482 32C 4.18        32   Tcf23    13.8600
## 19483 32C 4.19        32   Tcf23     6.5550
## 19484 32C 4.20        32   Tcf23     5.6550
## 19485 32C 4.21        32   Tcf23     6.1700
## 19486 32C 4.22        32   Tcf23     2.9000
## 19487 32C 4.23        32   Tcf23    13.2150
## 19488 32C 4.24        32   Tcf23    13.8250
## 19489  32C 5.1        32   Tcf23     9.6950
## 19490  32C 5.2        32   Tcf23    13.1700
## 19491  32C 5.3        32   Tcf23     9.2850
## 19492  32C 5.4        32   Tcf23    11.6550
## 19493  32C 5.5        32   Tcf23    11.2700
## 19494  32C 5.6        32   Tcf23     6.3500
## 19495  32C 5.7        32   Tcf23     7.9450
## 19496  32C 5.8        32   Tcf23     8.0150
## 19497  32C 5.9        32   Tcf23    14.1800
## 19498 32C 5.10        32   Tcf23     7.2500
## 19499 32C 5.11        32   Tcf23    10.7600
## 19500 32C 5.12        32   Tcf23     8.4900
## 19501 32C 5.13        32   Tcf23    11.6950
## 19502 32C 5.14        32   Tcf23     8.2150
## 19503 32C 5.15        32   Tcf23    12.1450
## 19504 32C 5.16        32   Tcf23     6.8550
## 19505 32C 5.17        32   Tcf23    10.7650
## 19506 32C 5.18        32   Tcf23    14.2150
## 19507 32C 5.19        32   Tcf23     7.5400
## 19508 32C 5.20        32   Tcf23    13.2550
## 19509 32C 5.21        32   Tcf23    12.7900
## 19510 32C 5.22        32   Tcf23    11.2700
## 19511 32C 5.23        32   Tcf23    10.7750
## 19512  32C 6.1        32   Tcf23     3.9550
## 19513  32C 6.2        32   Tcf23     4.8850
## 19514  32C 6.3        32   Tcf23    14.4400
## 19515  32C 6.4        32   Tcf23     7.3800
## 19516  32C 6.6        32   Tcf23     8.8550
## 19517  32C 6.7        32   Tcf23    13.2600
## 19518  32C 7.1        32   Tcf23     8.8550
## 19519  32C 7.2        32   Tcf23     7.1950
## 19520  32C 7.3        32   Tcf23     5.7700
## 19521  32C 7.4        32   Tcf23    12.5800
## 19522  32C 7.5        32   Tcf23     6.4400
## 19523  32C 7.6        32   Tcf23     6.8700
## 19524  32C 7.8        32   Tcf23    10.9375
## 19525  32C 8.1        32   Tcf23    13.8100
## 19526  32C 8.2        32   Tcf23    11.9800
## 19527  32C 8.4        32   Tcf23     6.8450
## 19528  32C 8.5        32   Tcf23     3.9250
## 19529  32C 8.6        32   Tcf23     8.6300
## 19530  64C 1.1        64   Tcf23     3.7500
## 19531  64C 1.2        64   Tcf23    13.2600
## 19532  64C 1.3        64   Tcf23    14.1050
## 19533  64C 1.4        64   Tcf23    12.3100
## 19534  64C 1.5        64   Tcf23     6.6600
## 19535  64C 1.6        64   Tcf23     8.1550
## 19536  64C 1.7        64   Tcf23     2.6150
## 19537  64C 1.8        64   Tcf23    10.2250
## 19538  64C 1.9        64   Tcf23     7.7450
## 19539 64C 1.10        64   Tcf23     7.7800
## 19540 64C 1.11        64   Tcf23     6.4700
## 19541 64C 1.12        64   Tcf23    13.7200
## 19542 64C 1.13        64   Tcf23     5.5300
## 19543 64C 1.14        64   Tcf23    13.5000
## 19544 64C 1.15        64   Tcf23    11.9650
## 19545 64C 1.16        64   Tcf23    11.8900
## 19546 64C 1.17        64   Tcf23     9.5050
## 19547 64C 1.18        64   Tcf23    11.3150
## 19548 64C 1.19        64   Tcf23     9.3900
## 19549 64C 1.20        64   Tcf23    14.7350
## 19550 64C 1.21        64   Tcf23     6.8100
## 19551 64C 1.22        64   Tcf23    10.9300
## 19552 64C 1.23        64   Tcf23    10.9900
## 19553 64C 1.24        64   Tcf23    12.7150
## 19554 64C 1.25        64   Tcf23    11.5100
## 19555 64C 1.26        64   Tcf23     2.7400
## 19556 64C 1.27        64   Tcf23    11.3150
## 19557 64C 1.28        64   Tcf23    11.0750
## 19558 64C 1.29        64   Tcf23    13.3600
## 19559 64C 1.30        64   Tcf23    14.2750
## 19560 64C 1.31        64   Tcf23    12.7800
## 19561 64C 1.32        64   Tcf23    13.2150
## 19562 64C 1.33        64   Tcf23    14.4400
## 19563 64C 1.34        64   Tcf23    11.8250
## 19564 64C 1.35        64   Tcf23    11.0450
## 19565 64C 1.36        64   Tcf23     9.8950
## 19566 64C 1.37        64   Tcf23    11.5850
## 19567 64C 1.38        64   Tcf23    15.2850
## 19568 64C 1.39        64   Tcf23    13.8650
## 19569 64C 1.40        64   Tcf23    12.3750
## 19570 64C 1.41        64   Tcf23     8.3900
## 19571 64C 1.42        64   Tcf23     6.6750
## 19572 64C 1.43        64   Tcf23     5.9250
## 19573 64C 1.44        64   Tcf23    12.0850
## 19574 64C 1.45        64   Tcf23    12.4100
## 19575 64C 1.46        64   Tcf23    12.4750
## 19576 64C 1.47        64   Tcf23    13.4600
## 19577 64C 1.48        64   Tcf23    13.4100
## 19578  64C 2.1        64   Tcf23    11.5100
## 19579  64C 2.2        64   Tcf23    13.9100
## 19580  64C 2.3        64   Tcf23    10.2600
## 19581  64C 2.4        64   Tcf23    13.2950
## 19582  64C 2.5        64   Tcf23     5.2750
## 19583  64C 2.6        64   Tcf23    12.3950
## 19584  64C 2.7        64   Tcf23     4.8650
## 19585  64C 2.8        64   Tcf23    11.5400
## 19586  64C 2.9        64   Tcf23    12.6150
## 19587 64C 2.10        64   Tcf23    13.4350
## 19588 64C 2.11        64   Tcf23     9.9600
## 19589 64C 2.12        64   Tcf23    13.8600
## 19590 64C 2.13        64   Tcf23    11.5150
## 19591 64C 2.14        64   Tcf23     7.4450
## 19592 64C 2.15        64   Tcf23    12.6600
## 19593 64C 2.16        64   Tcf23     6.9100
## 19594 64C 2.17        64   Tcf23     6.1950
## 19595 64C 2.18        64   Tcf23    13.8250
## 19596 64C 2.19        64   Tcf23    12.7650
## 19597 64C 2.20        64   Tcf23    13.1700
## 19598 64C 2.21        64   Tcf23    13.7550
## 19599 64C 2.22        64   Tcf23    11.6550
## 19600 64C 2.23        64   Tcf23    11.2700
## 19601 64C 2.24        64   Tcf23    11.3700
## 19602 64C 2.25        64   Tcf23    11.2450
## 19603  64C 3.1        64   Tcf23    14.8150
## 19604  64C 3.2        64   Tcf23    14.1800
## 19605  64C 3.3        64   Tcf23     9.7800
## 19606  64C 3.4        64   Tcf23    13.9800
## 19607  64C 3.5        64   Tcf23     6.9200
## 19608  64C 3.6        64   Tcf23    11.6950
## 19609  64C 3.7        64   Tcf23    10.4750
## 19610  64C 3.8        64   Tcf23    12.1450
## 19611  64C 4.1        64   Tcf23     3.7050
## 19612 64C 4.1b        64   Tcf23     9.8850
## 19613  64C 4.2        64   Tcf23     8.9250
## 19614  64C 4.3        64   Tcf23     7.4200
## 19615  64C 4.4        64   Tcf23     5.8050
## 19616  64C 4.5        64   Tcf23     6.7300
## 19617  64C 4.6        64   Tcf23     5.2400
## 19618  64C 4.7        64   Tcf23    10.7750
## 19619  64C 4.8        64   Tcf23     4.1900
## 19620  64C 4.9        64   Tcf23    11.8100
## 19621 64C 4.10        64   Tcf23     8.0700
## 19622 64C 4.11        64   Tcf23     9.1850
## 19623 64C 4.12        64   Tcf23    13.4000
## 19624 64C 4.13        64   Tcf23    13.2600
## 19625 64C 4.14        64   Tcf23    11.9000
## 19626 64C 4.15        64   Tcf23    10.9850
## 19627 64C 4.16        64   Tcf23     9.6150
## 19628 64C 4.17        64   Tcf23    12.5800
## 19629 64C 4.18        64   Tcf23    12.3000
## 19630 64C 4.19        64   Tcf23    13.1150
## 19631 64C 4.20        64   Tcf23    13.6125
## 19632 64C 4.21        64   Tcf23    13.8100
## 19633 64C 4.22        64   Tcf23    11.9800
## 19634 64C 4.23        64   Tcf23    12.8450
## 19635 64C 4.24        64   Tcf23    10.6250
## 19636 64C 4.25        64   Tcf23    12.3050
## 19637 64C 4.26        64   Tcf23     3.3500
## 19638 64C 4.27        64   Tcf23    13.2600
## 19639 64C 4.28        64   Tcf23     8.6650
## 19640 64C 4.29        64   Tcf23    12.3100
## 19641 64C 4.30        64   Tcf23     5.8900
## 19642 64C 4.31        64   Tcf23    13.5250
## 19643 64C 4.32        64   Tcf23     2.1150
## 19644 64C 4.33        64   Tcf23    10.2250
## 19645 64C 4.34        64   Tcf23    12.6350
## 19646 64C 4.35        64   Tcf23     5.2400
## 19647 64C 4.36        64   Tcf23    13.0100
## 19648 64C 4.37        64   Tcf23    13.7200
## 19649 64C 4.38        64   Tcf23    12.7400
## 19650 64C 4.39        64   Tcf23    13.5000
## 19651  64C 5.1        64   Tcf23    11.9650
## 19652  64C 5.2        64   Tcf23     6.6900
## 19653  64C 5.3        64   Tcf23     1.9550
## 19654  64C 5.4        64   Tcf23    11.3150
## 19655  64C 5.5        64   Tcf23     3.1300
## 19656  64C 5.6        64   Tcf23     8.0350
## 19657  64C 5.7        64   Tcf23     7.2600
## 19658  64C 5.8        64   Tcf23    12.9700
## 19659  64C 5.9        64   Tcf23     8.4700
## 19660 64C 5.10        64   Tcf23     5.3750
## 19661 64C 5.11        64   Tcf23    11.5100
## 19662 64C 5.12        64   Tcf23     9.2200
## 19663 64C 5.13        64   Tcf23    11.3150
## 19664 64C 5.14        64   Tcf23    11.0750
## 19665 64C 5.15        64   Tcf23    13.3600
## 19666 64C 5.16        64   Tcf23    14.2750
## 19667  64C 6.1        64   Tcf23     5.9900
## 19668  64C 6.2        64   Tcf23     7.3550
## 19669  64C 6.3        64   Tcf23    14.4400
## 19670  64C 6.4        64   Tcf23    11.8250
## 19671  64C 6.5        64   Tcf23    11.0450
## 19672  64C 6.6        64   Tcf23     9.8950
## 19673  64C 6.7        64   Tcf23     4.2350
## 19674  64C 6.8        64   Tcf23    15.2850
## 19675  64C 7.1        64   Tcf23    13.8650
## 19676  64C 7.2        64   Tcf23     6.5550
## 19677  64C 7.3        64   Tcf23    14.8800
## 19678  64C 7.4        64   Tcf23     7.6350
## 19679  64C 7.5        64   Tcf23     8.3550
## 19680  64C 7.6        64   Tcf23     6.4050
## 19681  64C 7.7        64   Tcf23     4.9100
## 19682  64C 7.8        64   Tcf23     7.1650
## 19683  64C 7.9        64   Tcf23     8.1300
## 19684 64C 7.10        64   Tcf23    13.4100
## 19685 64C 7.11        64   Tcf23    11.5100
## 19686 64C 7.12        64   Tcf23    13.9100
## 19687 64C 7.13        64   Tcf23    13.7500
## 19688 64C 7.14        64   Tcf23    13.2950
## 19689   2C 1.1         2    Utf1    11.5150
## 19690   2C 1.2         2    Utf1     8.0600
## 19691   2C 2.1         2    Utf1    11.6750
## 19692   2C 2.2         2    Utf1    15.0050
## 19693   2C 3.1         2    Utf1    10.5450
## 19694   2C 3.2         2    Utf1    13.6650
## 19695   2C 4.1         2    Utf1    15.9200
## 19696   2C 5.1         2    Utf1    11.6350
## 19697   2C 5.2         2    Utf1    11.7950
## 19698   2C 6.1         2    Utf1     9.5250
## 19699   2C 6.2         2    Utf1     9.2100
## 19700   2C 7.1         2    Utf1    11.3100
## 19701   2C 7.2         2    Utf1    14.0950
## 19702   2C 8.1         2    Utf1    14.0350
## 19703   2C 8.2         2    Utf1    11.7500
## 19704   2C 9.1         2    Utf1     9.0900
## 19705   2C 9.2         2    Utf1    10.7550
## 19706  2C 10.1         2    Utf1    11.7000
## 19707  2C 10.2         2    Utf1     7.2600
## 19708   4C 1.1         4    Utf1    12.3250
## 19709   4C 1.2         4    Utf1    11.6700
## 19710   4C 1.3         4    Utf1    14.3350
## 19711   4C 1.4         4    Utf1    13.7550
## 19712   4C 2.1         4    Utf1    10.8150
## 19713   4C 2.2         4    Utf1    13.8350
## 19714   4C 2.3         4    Utf1     8.0800
## 19715   4C 3.1         4    Utf1    12.4350
## 19716   4C 3.2         4    Utf1    11.5450
## 19717   4C 3.3         4    Utf1     9.9000
## 19718   4C 3.4         4    Utf1     8.8850
## 19719   4C 4.1         4    Utf1    14.1050
## 19720   4C 4.2         4    Utf1    11.7800
## 19721   4C 4.3         4    Utf1    13.4500
## 19722   4C 4.4         4    Utf1     8.4450
## 19723   4C 5.1         4    Utf1     7.7250
## 19724   4C 5.2         4    Utf1     9.6000
## 19725   4C 5.3         4    Utf1     7.2800
## 19726   4C 5.4         4    Utf1    11.6000
## 19727   4C 6.1         4    Utf1     9.3300
## 19728   4C 6.2         4    Utf1    12.6700
## 19729   4C 6.3         4    Utf1    12.2975
## 19730   4C 6.4         4    Utf1     8.4250
## 19731   8C 1.1         8    Utf1    12.0700
## 19732   8C 1.2         8    Utf1     8.6300
## 19733   8C 1.3         8    Utf1     7.1450
## 19734   8C 1.4         8    Utf1     9.0650
## 19735   8C 1.5         8    Utf1     8.6150
## 19736   8C 2.1         8    Utf1     8.7550
## 19737   8C 2.2         8    Utf1     8.7950
## 19738   8C 2.3         8    Utf1     9.3375
## 19739   8C 2.4         8    Utf1    14.2550
## 19740   8C 2.5         8    Utf1    12.2000
## 19741   8C 2.6         8    Utf1     8.0600
## 19742   8C 2.7         8    Utf1     6.5750
## 19743   8C 2.8         8    Utf1     8.9300
## 19744   8C 3.1         8    Utf1     5.1450
## 19745   8C 3.2         8    Utf1     9.6950
## 19746   8C 3.3         8    Utf1    13.5600
## 19747   8C 3.4         8    Utf1    12.4625
## 19748   8C 3.5         8    Utf1     7.6750
## 19749   8C 3.6         8    Utf1     3.6350
## 19750   8C 3.7         8    Utf1     5.3500
## 19751   8C 3.8         8    Utf1     3.4450
## 19752   8C 4.2         8    Utf1    12.3650
## 19753   8C 4.3         8    Utf1     5.0750
## 19754   8C 4.4         8    Utf1    12.8950
## 19755   8C 4.5         8    Utf1    13.8650
## 19756   8C 4.6         8    Utf1    11.1200
## 19757   8C 4.7         8    Utf1    10.2050
## 19758   8C 5.1         8    Utf1     6.7050
## 19759   8C 5.2         8    Utf1     5.4100
## 19760   8C 5.3         8    Utf1     2.4850
## 19761   8C 5.4         8    Utf1     3.6400
## 19762   8C 5.5         8    Utf1     6.0250
## 19763   8C 5.6         8    Utf1     6.8150
## 19764   8C 5.7         8    Utf1     6.2950
## 19765   8C 5.8         8    Utf1     6.8400
## 19766   8C 6.1         8    Utf1     9.5100
## 19767   8C 6.2         8    Utf1     8.2550
## 19768   8C 6.3         8    Utf1     2.3250
## 19769   8C 6.4         8    Utf1     4.0850
## 19770   8C 6.5         8    Utf1     5.2950
## 19771   8C 6.6         8    Utf1     4.4200
## 19772   8C 6.7         8    Utf1     5.4950
## 19773   8C 6.8         8    Utf1     7.6250
## 19774  16C 1.1        16    Utf1     5.8900
## 19775  16C 1.2        16    Utf1     5.3650
## 19776  16C 1.3        16    Utf1     5.8300
## 19777  16C 1.4        16    Utf1     5.0700
## 19778  16C 1.5        16    Utf1     3.5800
## 19779  16C 1.6        16    Utf1     6.4250
## 19780  16C 1.7        16    Utf1     2.2700
## 19781  16C 1.8        16    Utf1     7.9700
## 19782  16C 1.9        16    Utf1     4.0750
## 19783 16C 1.10        16    Utf1     4.1950
## 19784 16C 1.11        16    Utf1     6.2100
## 19785 16C 1.12        16    Utf1     4.8850
## 19786 16C 1.13        16    Utf1     2.9300
## 19787 16C 1.14        16    Utf1     3.2100
## 19788 16C 1.15        16    Utf1     4.3150
## 19789 16C 1.16        16    Utf1     4.0800
## 19790  16C 2.1        16    Utf1     8.1650
## 19791  16C 2.2        16    Utf1     5.3500
## 19792  16C 2.3        16    Utf1     5.2400
## 19793  16C 2.4        16    Utf1     6.0100
## 19794  16C 2.5        16    Utf1     5.0900
## 19795  16C 2.6        16    Utf1     2.5400
## 19796  16C 2.7        16    Utf1     4.0650
## 19797  16C 2.8        16    Utf1     4.2000
## 19798  16C 2.9        16    Utf1     3.9550
## 19799 16C 2.10        16    Utf1     9.1050
## 19800 16C 2.11        16    Utf1     6.2550
## 19801 16C 2.12        16    Utf1     6.2050
## 19802 16C 2.13        16    Utf1     9.2900
## 19803 16C 2.14        16    Utf1     3.7550
## 19804 16C 2.15        16    Utf1     6.6850
## 19805 16C 2.16        16    Utf1     1.4550
## 19806  16C 3.1        16    Utf1     6.1200
## 19807  16C 3.2        16    Utf1     4.1300
## 19808  16C 3.3        16    Utf1     5.7750
## 19809  16C 3.4        16    Utf1     6.8850
## 19810  16C 3.5        16    Utf1     3.4300
## 19811  16C 3.6        16    Utf1     6.5800
## 19812  16C 3.7        16    Utf1     7.5850
## 19813  16C 3.8        16    Utf1     5.1100
## 19814  16C 3.9        16    Utf1     4.4500
## 19815 16C 3.10        16    Utf1     3.6750
## 19816 16C 3.11        16    Utf1     4.8300
## 19817 16C 3.12        16    Utf1     7.2450
## 19818 16C 3.13        16    Utf1     6.0550
## 19819 16C 3.14        16    Utf1     5.7250
## 19820 16C 3.15        16    Utf1     6.4350
## 19821  16C 4.1        16    Utf1     5.5300
## 19822  16C 4.2        16    Utf1     4.2350
## 19823  16C 4.3        16    Utf1     4.6650
## 19824  16C 4.4        16    Utf1     7.5100
## 19825  16C 4.5        16    Utf1     4.5850
## 19826  16C 4.6        16    Utf1     6.9150
## 19827  16C 4.7        16    Utf1     6.2800
## 19828  16C 4.8        16    Utf1     6.5200
## 19829  16C 4.9        16    Utf1     8.0150
## 19830 16C 4.10        16    Utf1     7.0450
## 19831 16C 4.11        16    Utf1     5.5000
## 19832 16C 4.12        16    Utf1     3.5400
## 19833 16C 4.13        16    Utf1     4.7600
## 19834 16C 4.14        16    Utf1     5.0400
## 19835 16C 4.15        16    Utf1     6.1300
## 19836 16C 4.16        16    Utf1     6.1175
## 19837  16C 5.1        16    Utf1     7.0150
## 19838  16C 5.2        16    Utf1     4.7200
## 19839  16C 5.3        16    Utf1     6.6800
## 19840  16C 5.4        16    Utf1     5.7250
## 19841  16C 5.5        16    Utf1     2.6450
## 19842  16C 5.6        16    Utf1     7.1950
## 19843  16C 5.7        16    Utf1     5.5450
## 19844  16C 5.8        16    Utf1     7.2750
## 19845  16C 5.9        16    Utf1     4.3675
## 19846 16C 5.10        16    Utf1     8.5350
## 19847 16C 5.11        16    Utf1     4.9000
## 19848 16C 5.12        16    Utf1     6.5000
## 19849  32C 1.1        32    Utf1     6.7850
## 19850  32C 1.2        32    Utf1     3.1500
## 19851  32C 1.3        32    Utf1    10.7950
## 19852  32C 1.4        32    Utf1    12.8150
## 19853  32C 1.5        32    Utf1     5.5100
## 19854  32C 1.6        32    Utf1     4.5125
## 19855  32C 1.7        32    Utf1    10.0350
## 19856  32C 1.8        32    Utf1     2.7850
## 19857  32C 1.9        32    Utf1     2.9100
## 19858 32C 1.10        32    Utf1     3.4650
## 19859 32C 1.11        32    Utf1    12.3650
## 19860 32C 1.12        32    Utf1     6.3650
## 19861 32C 1.13        32    Utf1     4.6850
## 19862 32C 1.14        32    Utf1     6.8650
## 19863 32C 1.15        32    Utf1     3.6000
## 19864 32C 1.16        32    Utf1     5.3150
## 19865 32C 1.17        32    Utf1     5.9250
## 19866 32C 1.18        32    Utf1     2.6800
## 19867 32C 1.19        32    Utf1     1.6850
## 19868 32C 1.20        32    Utf1     2.7800
## 19869 32C 1.21        32    Utf1     1.1950
## 19870  32C 2.1        32    Utf1    11.6550
## 19871  32C 2.2        32    Utf1     8.4050
## 19872  32C 2.3        32    Utf1     6.2000
## 19873  32C 2.4        32    Utf1     6.8100
## 19874  32C 2.5        32    Utf1     6.7750
## 19875  32C 2.6        32    Utf1     9.1850
## 19876  32C 2.7        32    Utf1     3.5750
## 19877  32C 2.8        32    Utf1     3.5050
## 19878  32C 2.9        32    Utf1     6.3300
## 19879 32C 2.10        32    Utf1     6.4150
## 19880 32C 2.11        32    Utf1     4.5250
## 19881 32C 2.12        32    Utf1    10.6800
## 19882 32C 2.13        32    Utf1     5.2450
## 19883 32C 2.14        32    Utf1     4.2500
## 19884 32C 2.15        32    Utf1     3.2100
## 19885 32C 2.16        32    Utf1     2.9700
## 19886  32C 3.1        32    Utf1     8.1050
## 19887  32C 3.2        32    Utf1     7.2800
## 19888  32C 3.3        32    Utf1    14.3400
## 19889  32C 3.4        32    Utf1     7.9450
## 19890  32C 3.5        32    Utf1     6.3850
## 19891  32C 3.6        32    Utf1     4.9800
## 19892  32C 3.7        32    Utf1     4.4850
## 19893  32C 3.8        32    Utf1     3.4400
## 19894  32C 4.1        32    Utf1     5.2300
## 19895  32C 4.2        32    Utf1     6.9550
## 19896  32C 4.3        32    Utf1     3.3400
## 19897  32C 4.4        32    Utf1     5.6850
## 19898  32C 4.5        32    Utf1     4.8600
## 19899  32C 4.6        32    Utf1     4.2200
## 19900  32C 4.7        32    Utf1     9.8600
## 19901  32C 4.8        32    Utf1     7.0700
## 19902 32C 4.10        32    Utf1     5.2600
## 19903 32C 4.11        32    Utf1     2.7850
## 19904 32C 4.12        32    Utf1    12.3600
## 19905 32C 4.13        32    Utf1     6.2350
## 19906 32C 4.14        32    Utf1     7.9850
## 19907 32C 4.15        32    Utf1     4.5850
## 19908 32C 4.16        32    Utf1     6.4950
## 19909 32C 4.17        32    Utf1    15.9200
## 19910 32C 4.18        32    Utf1    12.7750
## 19911 32C 4.19        32    Utf1     6.9150
## 19912 32C 4.20        32    Utf1     0.7850
## 19913 32C 4.21        32    Utf1     5.6800
## 19914 32C 4.22        32    Utf1     0.8000
## 19915 32C 4.23        32    Utf1     9.1350
## 19916 32C 4.24        32    Utf1     5.2150
## 19917  32C 5.1        32    Utf1     4.7200
## 19918  32C 5.2        32    Utf1     8.1300
## 19919  32C 5.3        32    Utf1    10.8150
## 19920  32C 5.4        32    Utf1     6.0900
## 19921  32C 5.5        32    Utf1     4.0500
## 19922  32C 5.6        32    Utf1     7.2150
## 19923  32C 5.7        32    Utf1     8.2000
## 19924  32C 5.8        32    Utf1     4.7150
## 19925  32C 5.9        32    Utf1    10.7450
## 19926 32C 5.10        32    Utf1     5.2050
## 19927 32C 5.11        32    Utf1     9.4450
## 19928 32C 5.12        32    Utf1     4.5600
## 19929 32C 5.13        32    Utf1     7.5650
## 19930 32C 5.14        32    Utf1     4.2750
## 19931 32C 5.15        32    Utf1     8.8100
## 19932 32C 5.16        32    Utf1     7.7250
## 19933 32C 5.17        32    Utf1     9.1950
## 19934 32C 5.18        32    Utf1     8.3000
## 19935 32C 5.19        32    Utf1     5.3900
## 19936 32C 5.20        32    Utf1    12.1050
## 19937 32C 5.21        32    Utf1    11.0250
## 19938 32C 5.22        32    Utf1     7.1300
## 19939 32C 5.23        32    Utf1     7.2900
## 19940  32C 6.1        32    Utf1     4.8900
## 19941  32C 6.2        32    Utf1     9.0700
## 19942  32C 6.3        32    Utf1    13.2800
## 19943  32C 6.4        32    Utf1     6.0725
## 19944  32C 6.6        32    Utf1     7.3350
## 19945  32C 6.7        32    Utf1     8.2700
## 19946  32C 7.1        32    Utf1    12.1200
## 19947  32C 7.2        32    Utf1     4.8350
## 19948  32C 7.3        32    Utf1     9.0650
## 19949  32C 7.4        32    Utf1    12.8250
## 19950  32C 7.5        32    Utf1     8.0750
## 19951  32C 7.6        32    Utf1     6.2550
## 19952  32C 7.8        32    Utf1    12.0575
## 19953  32C 8.1        32    Utf1    14.2550
## 19954  32C 8.2        32    Utf1    12.2000
## 19955  32C 8.4        32    Utf1     8.6550
## 19956  32C 8.5        32    Utf1     4.0150
## 19957  32C 8.6        32    Utf1     9.4600
## 19958  64C 1.1        64    Utf1     5.7050
## 19959  64C 1.2        64    Utf1    12.8150
## 19960  64C 1.3        64    Utf1     9.0700
## 19961  64C 1.4        64    Utf1    10.0625
## 19962  64C 1.5        64    Utf1     7.3950
## 19963  64C 1.6        64    Utf1     3.9750
## 19964  64C 1.7        64    Utf1     6.8700
## 19965  64C 1.8        64    Utf1    10.4750
## 19966  64C 1.9        64    Utf1     8.6850
## 19967 64C 1.10        64    Utf1    11.6550
## 19968 64C 1.11        64    Utf1     8.5550
## 19969 64C 1.12        64    Utf1    13.8650
## 19970 64C 1.13        64    Utf1     9.1600
## 19971 64C 1.14        64    Utf1    14.3950
## 19972 64C 1.15        64    Utf1    13.1550
## 19973 64C 1.16        64    Utf1    11.4100
## 19974 64C 1.17        64    Utf1     9.5850
## 19975 64C 1.18        64    Utf1     7.2000
## 19976 64C 1.19        64    Utf1    10.3450
## 19977 64C 1.20        64    Utf1    13.4050
## 19978 64C 1.21        64    Utf1     8.5750
## 19979 64C 1.22        64    Utf1     6.2300
## 19980 64C 1.23        64    Utf1     8.0100
## 19981 64C 1.24        64    Utf1     9.8150
## 19982 64C 1.25        64    Utf1     5.0350
## 19983 64C 1.26        64    Utf1     6.3350
## 19984 64C 1.27        64    Utf1    11.2950
## 19985 64C 1.28        64    Utf1    10.5800
## 19986 64C 1.29        64    Utf1     8.2750
## 19987 64C 1.30        64    Utf1    13.9250
## 19988 64C 1.31        64    Utf1    12.1200
## 19989 64C 1.32        64    Utf1    13.1350
## 19990 64C 1.33        64    Utf1    13.9900
## 19991 64C 1.34        64    Utf1    11.9200
## 19992 64C 1.35        64    Utf1    11.9500
## 19993 64C 1.36        64    Utf1    12.4350
## 19994 64C 1.37        64    Utf1    10.6400
## 19995 64C 1.38        64    Utf1    14.3400
## 19996 64C 1.39        64    Utf1    12.8350
## 19997 64C 1.40        64    Utf1     4.2650
## 19998 64C 1.41        64    Utf1    13.0100
## 19999 64C 1.42        64    Utf1     8.6750
## 20000 64C 1.43        64    Utf1     6.9300
## 20001 64C 1.44        64    Utf1    11.1700
## 20002 64C 1.45        64    Utf1     8.6950
## 20003 64C 1.46        64    Utf1    12.2600
## 20004 64C 1.47        64    Utf1    13.5550
## 20005 64C 1.48        64    Utf1    13.5000
## 20006  64C 2.1        64    Utf1    13.2900
## 20007  64C 2.2        64    Utf1    14.0200
## 20008  64C 2.3        64    Utf1    13.0200
## 20009  64C 2.4        64    Utf1     9.7000
## 20010  64C 2.5        64    Utf1     6.3550
## 20011  64C 2.6        64    Utf1     8.8900
## 20012  64C 2.7        64    Utf1     4.3550
## 20013  64C 2.8        64    Utf1     8.2650
## 20014  64C 2.9        64    Utf1     9.5350
## 20015 64C 2.10        64    Utf1    13.6650
## 20016 64C 2.11        64    Utf1    10.8500
## 20017 64C 2.12        64    Utf1     8.1750
## 20018 64C 2.13        64    Utf1     8.6850
## 20019 64C 2.14        64    Utf1     5.4250
## 20020 64C 2.15        64    Utf1    13.1700
## 20021 64C 2.16        64    Utf1     5.4800
## 20022 64C 2.17        64    Utf1     8.6850
## 20023 64C 2.18        64    Utf1    14.0350
## 20024 64C 2.19        64    Utf1     7.5000
## 20025 64C 2.20        64    Utf1    12.0100
## 20026 64C 2.21        64    Utf1    14.7950
## 20027 64C 2.22        64    Utf1     8.6000
## 20028 64C 2.23        64    Utf1     6.4500
## 20029 64C 2.24        64    Utf1    12.3250
## 20030 64C 2.25        64    Utf1     8.5200
## 20031  64C 3.1        64    Utf1     9.8050
## 20032  64C 3.2        64    Utf1    10.3950
## 20033  64C 3.3        64    Utf1     8.0050
## 20034  64C 3.4        64    Utf1    13.8350
## 20035  64C 3.5        64    Utf1     7.1200
## 20036  64C 3.6        64    Utf1    12.4350
## 20037  64C 3.7        64    Utf1     7.8150
## 20038  64C 3.8        64    Utf1     9.6600
## 20039  64C 4.1        64    Utf1     8.1950
## 20040 64C 4.1b        64    Utf1     6.3850
## 20041  64C 4.2        64    Utf1     6.7100
## 20042  64C 4.3        64    Utf1     6.1200
## 20043  64C 4.4        64    Utf1     8.6750
## 20044  64C 4.5        64    Utf1     9.6350
## 20045  64C 4.6        64    Utf1     6.3800
## 20046  64C 4.7        64    Utf1     9.0400
## 20047  64C 4.8        64    Utf1     6.5500
## 20048  64C 4.9        64    Utf1     6.7000
## 20049 64C 4.10        64    Utf1     6.8600
## 20050 64C 4.11        64    Utf1     4.7875
## 20051 64C 4.12        64    Utf1    12.7250
## 20052 64C 4.13        64    Utf1     6.8000
## 20053 64C 4.14        64    Utf1    12.1200
## 20054 64C 4.15        64    Utf1     8.0350
## 20055 64C 4.16        64    Utf1     5.6550
## 20056 64C 4.17        64    Utf1     7.2750
## 20057 64C 4.18        64    Utf1     7.5250
## 20058 64C 4.19        64    Utf1    13.6250
## 20059 64C 4.20        64    Utf1     9.0675
## 20060 64C 4.21        64    Utf1    14.2550
## 20061 64C 4.22        64    Utf1    12.2000
## 20062 64C 4.23        64    Utf1     6.8100
## 20063 64C 4.24        64    Utf1     6.8750
## 20064 64C 4.25        64    Utf1     6.9800
## 20065 64C 4.26        64    Utf1     3.7750
## 20066 64C 4.27        64    Utf1     8.0350
## 20067 64C 4.28        64    Utf1     7.8100
## 20068 64C 4.29        64    Utf1    12.7325
## 20069 64C 4.30        64    Utf1    11.5950
## 20070 64C 4.31        64    Utf1    11.6150
## 20071 64C 4.32        64    Utf1     3.7700
## 20072 64C 4.33        64    Utf1     6.5750
## 20073 64C 4.34        64    Utf1     9.3950
## 20074 64C 4.35        64    Utf1     3.9450
## 20075 64C 4.36        64    Utf1    11.6650
## 20076 64C 4.37        64    Utf1     9.0750
## 20077 64C 4.38        64    Utf1    12.5000
## 20078 64C 4.39        64    Utf1    14.3950
## 20079  64C 5.1        64    Utf1    13.1550
## 20080  64C 5.2        64    Utf1     4.0100
## 20081  64C 5.3        64    Utf1     1.7050
## 20082  64C 5.4        64    Utf1    10.6800
## 20083  64C 5.5        64    Utf1     2.7550
## 20084  64C 5.6        64    Utf1     7.7750
## 20085  64C 5.7        64    Utf1     7.2650
## 20086  64C 5.8        64    Utf1     5.5400
## 20087  64C 5.9        64    Utf1     7.4400
## 20088 64C 5.10        64    Utf1     6.7850
## 20089 64C 5.11        64    Utf1     9.1850
## 20090 64C 5.12        64    Utf1    10.5950
## 20091 64C 5.13        64    Utf1    11.2950
## 20092 64C 5.14        64    Utf1    10.8700
## 20093 64C 5.15        64    Utf1    12.5350
## 20094 64C 5.16        64    Utf1    13.9250
## 20095  64C 6.1        64    Utf1     5.1000
## 20096  64C 6.2        64    Utf1     4.9150
## 20097  64C 6.3        64    Utf1     6.3100
## 20098  64C 6.4        64    Utf1     3.7000
## 20099  64C 6.5        64    Utf1     3.8400
## 20100  64C 6.6        64    Utf1     4.2550
## 20101  64C 6.7        64    Utf1     3.5400
## 20102  64C 6.8        64    Utf1     7.9200
## 20103  64C 7.1        64    Utf1     8.2250
## 20104  64C 7.2        64    Utf1     7.2450
## 20105  64C 7.3        64    Utf1     6.2800
## 20106  64C 7.4        64    Utf1     6.2750
## 20107  64C 7.5        64    Utf1     5.8700
## 20108  64C 7.6        64    Utf1     5.4200
## 20109  64C 7.7        64    Utf1     6.2350
## 20110  64C 7.8        64    Utf1     5.0400
## 20111  64C 7.9        64    Utf1     8.1650
## 20112 64C 7.10        64    Utf1    13.5000
## 20113 64C 7.11        64    Utf1    13.2900
## 20114 64C 7.12        64    Utf1    14.0200
## 20115 64C 7.13        64    Utf1    13.0200
## 20116 64C 7.14        64    Utf1    12.1900
## 20117   2C 1.1         2  Tspan8     3.4850
## 20118   2C 1.2         2  Tspan8     5.4050
## 20119   2C 2.1         2  Tspan8     4.7700
## 20120   2C 2.2         2  Tspan8     7.2400
## 20121   2C 3.1         2  Tspan8     5.0650
## 20122   2C 3.2         2  Tspan8     5.0850
## 20123   2C 4.1         2  Tspan8     6.8800
## 20124   2C 5.1         2  Tspan8     6.2150
## 20125   2C 5.2         2  Tspan8     3.8250
## 20126   2C 6.1         2  Tspan8     2.8300
## 20127   2C 6.2         2  Tspan8     3.3900
## 20128   2C 7.1         2  Tspan8     3.3200
## 20129   2C 7.2         2  Tspan8     6.6100
## 20130   2C 8.1         2  Tspan8     5.5550
## 20131   2C 8.2         2  Tspan8     4.3100
## 20132   2C 9.1         2  Tspan8     6.4000
## 20133   2C 9.2         2  Tspan8     6.4700
## 20134  2C 10.1         2  Tspan8     3.3100
## 20135  2C 10.2         2  Tspan8     0.8350
## 20136   4C 1.1         4  Tspan8     4.7100
## 20137   4C 1.2         4  Tspan8     7.1400
## 20138   4C 1.3         4  Tspan8     7.7850
## 20139   4C 1.4         4  Tspan8     5.7800
## 20140   4C 2.1         4  Tspan8     8.5350
## 20141   4C 2.2         4  Tspan8     7.7500
## 20142   4C 2.3         4  Tspan8     6.2900
## 20143   4C 3.1         4  Tspan8     5.5650
## 20144   4C 3.2         4  Tspan8     5.1950
## 20145   4C 3.3         4  Tspan8     3.9550
## 20146   4C 3.4         4  Tspan8     5.4000
## 20147   4C 4.1         4  Tspan8     7.4400
## 20148   4C 4.2         4  Tspan8     6.8150
## 20149   4C 4.3         4  Tspan8     7.0150
## 20150   4C 4.4         4  Tspan8     6.2600
## 20151   4C 5.1         4  Tspan8     5.1300
## 20152   4C 5.2         4  Tspan8     4.9550
## 20153   4C 5.3         4  Tspan8     2.4450
## 20154   4C 5.4         4  Tspan8     4.8150
## 20155   4C 6.1         4  Tspan8     4.7950
## 20156   4C 6.2         4  Tspan8     6.0100
## 20157   4C 6.3         4  Tspan8     9.4250
## 20158   4C 6.4         4  Tspan8     7.9800
## 20159   8C 1.1         8  Tspan8     8.4100
## 20160   8C 1.2         8  Tspan8     6.2650
## 20161   8C 1.3         8  Tspan8     6.1250
## 20162   8C 1.4         8  Tspan8     6.5150
## 20163   8C 1.5         8  Tspan8     7.1250
## 20164   8C 2.1         8  Tspan8     7.1350
## 20165   8C 2.2         8  Tspan8     8.6600
## 20166   8C 2.3         8  Tspan8     7.0750
## 20167   8C 2.4         8  Tspan8     9.2500
## 20168   8C 2.5         8  Tspan8     5.7600
## 20169   8C 2.6         8  Tspan8     6.2950
## 20170   8C 2.7         8  Tspan8     4.9150
## 20171   8C 2.8         8  Tspan8     5.5050
## 20172   8C 3.1         8  Tspan8     5.1150
## 20173   8C 3.2         8  Tspan8     9.8300
## 20174   8C 3.3         8  Tspan8    10.1250
## 20175   8C 3.4         8  Tspan8     7.9525
## 20176   8C 3.5         8  Tspan8     6.7700
## 20177   8C 3.6         8  Tspan8     7.3900
## 20178   8C 3.7         8  Tspan8     9.3400
## 20179   8C 3.8         8  Tspan8     5.8000
## 20180   8C 4.2         8  Tspan8     9.2150
## 20181   8C 4.3         8  Tspan8     4.9700
## 20182   8C 4.4         8  Tspan8    10.0800
## 20183   8C 4.5         8  Tspan8    13.4950
## 20184   8C 4.6         8  Tspan8     6.4925
## 20185   8C 4.7         8  Tspan8     9.3450
## 20186   8C 5.1         8  Tspan8     7.5150
## 20187   8C 5.2         8  Tspan8     5.1950
## 20188   8C 5.3         8  Tspan8     4.1650
## 20189   8C 5.4         8  Tspan8     4.2050
## 20190   8C 5.5         8  Tspan8     2.8750
## 20191   8C 5.6         8  Tspan8     6.1400
## 20192   8C 5.7         8  Tspan8     8.3000
## 20193   8C 5.8         8  Tspan8     5.6900
## 20194   8C 6.1         8  Tspan8     7.1450
## 20195   8C 6.2         8  Tspan8     8.3900
## 20196   8C 6.3         8  Tspan8     6.7550
## 20197   8C 6.4         8  Tspan8     5.5500
## 20198   8C 6.5         8  Tspan8     7.2850
## 20199   8C 6.6         8  Tspan8     5.0800
## 20200   8C 6.7         8  Tspan8     8.2500
## 20201   8C 6.8         8  Tspan8     9.2250
## 20202  16C 1.1        16  Tspan8     8.0300
## 20203  16C 1.2        16  Tspan8     9.0850
## 20204  16C 1.3        16  Tspan8    10.0100
## 20205  16C 1.4        16  Tspan8     6.7200
## 20206  16C 1.5        16  Tspan8     7.7800
## 20207  16C 1.6        16  Tspan8    12.1650
## 20208  16C 1.7        16  Tspan8     6.6500
## 20209  16C 1.8        16  Tspan8     9.2300
## 20210  16C 1.9        16  Tspan8     9.0700
## 20211 16C 1.10        16  Tspan8     9.8050
## 20212 16C 1.11        16  Tspan8     9.0800
## 20213 16C 1.12        16  Tspan8    10.6600
## 20214 16C 1.13        16  Tspan8     8.2550
## 20215 16C 1.14        16  Tspan8     8.5800
## 20216 16C 1.15        16  Tspan8    11.8150
## 20217 16C 1.16        16  Tspan8     6.9400
## 20218  16C 2.1        16  Tspan8     8.5650
## 20219  16C 2.2        16  Tspan8     7.8200
## 20220  16C 2.3        16  Tspan8     9.9750
## 20221  16C 2.4        16  Tspan8    11.8100
## 20222  16C 2.5        16  Tspan8    10.0050
## 20223  16C 2.6        16  Tspan8    10.7950
## 20224  16C 2.7        16  Tspan8    12.1750
## 20225  16C 2.8        16  Tspan8     7.5250
## 20226  16C 2.9        16  Tspan8     6.9200
## 20227 16C 2.10        16  Tspan8     9.3600
## 20228 16C 2.11        16  Tspan8     9.1150
## 20229 16C 2.12        16  Tspan8     7.7550
## 20230 16C 2.13        16  Tspan8    11.0800
## 20231 16C 2.14        16  Tspan8     8.2750
## 20232 16C 2.15        16  Tspan8     5.9850
## 20233 16C 2.16        16  Tspan8     7.4700
## 20234  16C 3.1        16  Tspan8     8.2700
## 20235  16C 3.2        16  Tspan8    11.7000
## 20236  16C 3.3        16  Tspan8     8.8600
## 20237  16C 3.4        16  Tspan8    11.3850
## 20238  16C 3.5        16  Tspan8     8.6900
## 20239  16C 3.6        16  Tspan8     9.8100
## 20240  16C 3.7        16  Tspan8     9.5000
## 20241  16C 3.8        16  Tspan8     8.2300
## 20242  16C 3.9        16  Tspan8     5.2850
## 20243 16C 3.10        16  Tspan8     5.6800
## 20244 16C 3.11        16  Tspan8    10.0800
## 20245 16C 3.12        16  Tspan8     9.2650
## 20246 16C 3.13        16  Tspan8     8.3100
## 20247 16C 3.14        16  Tspan8    10.3250
## 20248 16C 3.15        16  Tspan8    13.2600
## 20249  16C 4.1        16  Tspan8     6.9400
## 20250  16C 4.2        16  Tspan8    12.4350
## 20251  16C 4.3        16  Tspan8     7.8050
## 20252  16C 4.4        16  Tspan8     5.5650
## 20253  16C 4.5        16  Tspan8     8.4500
## 20254  16C 4.6        16  Tspan8     9.6900
## 20255  16C 4.7        16  Tspan8     9.1450
## 20256  16C 4.8        16  Tspan8     8.8350
## 20257  16C 4.9        16  Tspan8    13.1700
## 20258 16C 4.10        16  Tspan8     7.3100
## 20259 16C 4.11        16  Tspan8     6.7150
## 20260 16C 4.12        16  Tspan8     2.0550
## 20261 16C 4.13        16  Tspan8     6.3850
## 20262 16C 4.14        16  Tspan8     8.4350
## 20263 16C 4.15        16  Tspan8     8.4000
## 20264 16C 4.16        16  Tspan8     9.6050
## 20265  16C 5.1        16  Tspan8    10.3900
## 20266  16C 5.2        16  Tspan8     6.5700
## 20267  16C 5.3        16  Tspan8     6.5850
## 20268  16C 5.4        16  Tspan8     5.4150
## 20269  16C 5.5        16  Tspan8     7.3250
## 20270  16C 5.6        16  Tspan8     7.4150
## 20271  16C 5.7        16  Tspan8     7.4150
## 20272  16C 5.8        16  Tspan8     8.1100
## 20273  16C 5.9        16  Tspan8     9.1950
## 20274 16C 5.10        16  Tspan8     8.9700
## 20275 16C 5.11        16  Tspan8     7.0700
## 20276 16C 5.12        16  Tspan8     6.5250
## 20277  32C 1.1        32  Tspan8     2.2150
## 20278  32C 1.2        32  Tspan8     6.4650
## 20279  32C 1.3        32  Tspan8     2.1650
## 20280  32C 1.4        32  Tspan8     3.4400
## 20281  32C 1.5        32  Tspan8    13.6550
## 20282  32C 1.6        32  Tspan8     9.5025
## 20283  32C 1.7        32  Tspan8     3.6100
## 20284  32C 1.8        32  Tspan8    13.0100
## 20285  32C 1.9        32  Tspan8    12.2600
## 20286 32C 1.10        32  Tspan8    10.3100
## 20287 32C 1.11        32  Tspan8     3.4650
## 20288 32C 1.12        32  Tspan8     2.6500
## 20289 32C 1.13        32  Tspan8    10.0600
## 20290 32C 1.14        32  Tspan8     3.3050
## 20291 32C 1.15        32  Tspan8    10.6125
## 20292 32C 1.16        32  Tspan8     9.7550
## 20293 32C 1.17        32  Tspan8    13.9850
## 20294 32C 1.18        32  Tspan8     8.5750
## 20295 32C 1.19        32  Tspan8     9.4650
## 20296 32C 1.20        32  Tspan8     9.2550
## 20297 32C 1.21        32  Tspan8     9.7950
## 20298  32C 2.1        32  Tspan8     3.4800
## 20299  32C 2.2        32  Tspan8     5.9200
## 20300  32C 2.3        32  Tspan8     4.7500
## 20301  32C 2.4        32  Tspan8    13.8850
## 20302  32C 2.5        32  Tspan8    12.2300
## 20303  32C 2.6        32  Tspan8     6.6850
## 20304  32C 2.7        32  Tspan8     9.3800
## 20305  32C 2.8        32  Tspan8    11.3750
## 20306  32C 2.9        32  Tspan8     2.6600
## 20307 32C 2.10        32  Tspan8     2.4900
## 20308 32C 2.11        32  Tspan8    11.4450
## 20309 32C 2.12        32  Tspan8     5.5900
## 20310 32C 2.13        32  Tspan8    10.7250
## 20311 32C 2.14        32  Tspan8    10.0100
## 20312 32C 2.15        32  Tspan8    11.8600
## 20313 32C 2.16        32  Tspan8    11.6300
## 20314  32C 3.1        32  Tspan8     2.7550
## 20315  32C 3.2        32  Tspan8     2.6400
## 20316  32C 3.3        32  Tspan8     6.1900
## 20317  32C 3.4        32  Tspan8     5.8500
## 20318  32C 3.5        32  Tspan8     3.4350
## 20319  32C 3.6        32  Tspan8    12.4200
## 20320  32C 3.7        32  Tspan8    10.3400
## 20321  32C 3.8        32  Tspan8    12.5450
## 20322  32C 4.1        32  Tspan8     3.3900
## 20323  32C 4.2        32  Tspan8     4.0150
## 20324  32C 4.3        32  Tspan8    11.2000
## 20325  32C 4.4        32  Tspan8    14.7350
## 20326  32C 4.5        32  Tspan8    10.2400
## 20327  32C 4.6        32  Tspan8    13.3850
## 20328  32C 4.7        32  Tspan8     7.9100
## 20329  32C 4.8        32  Tspan8     5.1350
## 20330 32C 4.10        32  Tspan8     3.0550
## 20331 32C 4.11        32  Tspan8    12.1750
## 20332 32C 4.12        32  Tspan8     4.8050
## 20333 32C 4.13        32  Tspan8     4.5900
## 20334 32C 4.14        32  Tspan8    13.4600
## 20335 32C 4.15        32  Tspan8    12.9150
## 20336 32C 4.16        32  Tspan8    13.2550
## 20337 32C 4.17        32  Tspan8     7.5500
## 20338 32C 4.18        32  Tspan8     2.5450
## 20339 32C 4.19        32  Tspan8     0.7050
## 20340 32C 4.20        32  Tspan8    11.5100
## 20341 32C 4.21        32  Tspan8    12.4300
## 20342 32C 4.22        32  Tspan8    11.7000
## 20343 32C 4.23        32  Tspan8     5.1200
## 20344 32C 4.24        32  Tspan8    13.5650
## 20345  32C 5.1        32  Tspan8     2.6500
## 20346  32C 5.2        32  Tspan8     6.9500
## 20347  32C 5.3        32  Tspan8    14.7300
## 20348  32C 5.4        32  Tspan8     4.6800
## 20349  32C 5.5        32  Tspan8     6.7150
## 20350  32C 5.6        32  Tspan8     5.0400
## 20351  32C 5.7        32  Tspan8     4.8100
## 20352  32C 5.8        32  Tspan8    14.2350
## 20353  32C 5.9        32  Tspan8     5.7400
## 20354 32C 5.10        32  Tspan8    13.4450
## 20355 32C 5.11        32  Tspan8     6.9100
## 20356 32C 5.12        32  Tspan8    12.7300
## 20357 32C 5.13        32  Tspan8     4.1550
## 20358 32C 5.14        32  Tspan8     6.8750
## 20359 32C 5.15        32  Tspan8     4.7750
## 20360 32C 5.16        32  Tspan8     1.8700
## 20361 32C 5.17        32  Tspan8     5.3700
## 20362 32C 5.18        32  Tspan8     5.1950
## 20363 32C 5.19        32  Tspan8    13.9450
## 20364 32C 5.20        32  Tspan8     7.9600
## 20365 32C 5.21        32  Tspan8     3.7100
## 20366 32C 5.22        32  Tspan8     5.3050
## 20367 32C 5.23        32  Tspan8     1.4450
## 20368  32C 6.1        32  Tspan8     9.1250
## 20369  32C 6.2        32  Tspan8     0.2800
## 20370  32C 6.3        32  Tspan8     4.2750
## 20371  32C 6.4        32  Tspan8    11.7100
## 20372  32C 6.6        32  Tspan8     8.3750
## 20373  32C 6.7        32  Tspan8     5.8000
## 20374  32C 7.1        32  Tspan8     2.4050
## 20375  32C 7.2        32  Tspan8    10.6750
## 20376  32C 7.3        32  Tspan8     3.3150
## 20377  32C 7.4        32  Tspan8     2.4150
## 20378  32C 7.5        32  Tspan8     9.6650
## 20379  32C 7.6        32  Tspan8    13.6300
## 20380  32C 7.8        32  Tspan8     3.4900
## 20381  32C 8.1        32  Tspan8     7.2900
## 20382  32C 8.2        32  Tspan8     5.8950
## 20383  32C 8.4        32  Tspan8     9.3450
## 20384  32C 8.5        32  Tspan8    10.4450
## 20385  32C 8.6        32  Tspan8     3.2450
## 20386  64C 1.1        64  Tspan8    10.7850
## 20387  64C 1.2        64  Tspan8     3.6000
## 20388  64C 1.3        64  Tspan8    12.0450
## 20389  64C 1.4        64  Tspan8    13.4025
## 20390  64C 1.5        64  Tspan8    12.2800
## 20391  64C 1.6        64  Tspan8     8.0200
## 20392  64C 1.7        64  Tspan8    12.2600
## 20393  64C 1.8        64  Tspan8     1.8100
## 20394  64C 1.9        64  Tspan8    11.8050
## 20395 64C 1.10        64  Tspan8     2.6900
## 20396 64C 1.11        64  Tspan8    13.3600
## 20397 64C 1.12        64  Tspan8     4.7350
## 20398 64C 1.13        64  Tspan8    12.0825
## 20399 64C 1.14        64  Tspan8     7.2850
## 20400 64C 1.15        64  Tspan8     6.9550
## 20401 64C 1.16        64  Tspan8     2.0250
## 20402 64C 1.17        64  Tspan8     4.3150
## 20403 64C 1.18        64  Tspan8     2.7650
## 20404 64C 1.19        64  Tspan8     1.3250
## 20405 64C 1.20        64  Tspan8     3.8500
## 20406 64C 1.21        64  Tspan8    10.6600
## 20407 64C 1.22        64  Tspan8     9.7900
## 20408 64C 1.23        64  Tspan8    13.8850
## 20409 64C 1.24        64  Tspan8     4.5100
## 20410 64C 1.25        64  Tspan8     4.6250
## 20411 64C 1.26        64  Tspan8    11.2100
## 20412 64C 1.27        64  Tspan8     1.3650
## 20413 64C 1.28        64  Tspan8     0.0100
## 20414 64C 1.29        64  Tspan8     2.9700
## 20415 64C 1.30        64  Tspan8     5.9950
## 20416 64C 1.31        64  Tspan8     2.2200
## 20417 64C 1.32        64  Tspan8     2.9150
## 20418 64C 1.33        64  Tspan8     4.7400
## 20419 64C 1.34        64  Tspan8     4.8400
## 20420 64C 1.35        64  Tspan8    -0.4100
## 20421 64C 1.36        64  Tspan8     1.3850
## 20422 64C 1.37        64  Tspan8     1.8000
## 20423 64C 1.38        64  Tspan8     5.9100
## 20424 64C 1.39        64  Tspan8     4.7200
## 20425 64C 1.40        64  Tspan8     7.5950
## 20426 64C 1.41        64  Tspan8    12.1600
## 20427 64C 1.42        64  Tspan8    13.3200
## 20428 64C 1.43        64  Tspan8     8.9550
## 20429 64C 1.44        64  Tspan8     3.9800
## 20430 64C 1.45        64  Tspan8     4.4850
## 20431 64C 1.46        64  Tspan8     0.2600
## 20432 64C 1.47        64  Tspan8     3.9050
## 20433 64C 1.48        64  Tspan8     1.5900
## 20434  64C 2.1        64  Tspan8     1.0850
## 20435  64C 2.2        64  Tspan8     4.0200
## 20436  64C 2.3        64  Tspan8     5.4050
## 20437  64C 2.4        64  Tspan8     3.4350
## 20438  64C 2.5        64  Tspan8    10.6150
## 20439  64C 2.6        64  Tspan8     3.2650
## 20440  64C 2.7        64  Tspan8     6.8400
## 20441  64C 2.8        64  Tspan8    10.5900
## 20442  64C 2.9        64  Tspan8     1.5550
## 20443 64C 2.10        64  Tspan8     1.2450
## 20444 64C 2.11        64  Tspan8     3.9200
## 20445 64C 2.12        64  Tspan8     2.9850
## 20446 64C 2.13        64  Tspan8     2.4650
## 20447 64C 2.14        64  Tspan8     0.9600
## 20448 64C 2.15        64  Tspan8     2.2300
## 20449 64C 2.16        64  Tspan8     8.1400
## 20450 64C 2.17        64  Tspan8    14.3100
## 20451 64C 2.18        64  Tspan8     0.5950
## 20452 64C 2.19        64  Tspan8     0.0900
## 20453 64C 2.20        64  Tspan8     3.2700
## 20454 64C 2.21        64  Tspan8     3.9100
## 20455 64C 2.22        64  Tspan8     2.4800
## 20456 64C 2.23        64  Tspan8    -0.1850
## 20457 64C 2.24        64  Tspan8     0.2600
## 20458 64C 2.25        64  Tspan8     5.7900
## 20459  64C 3.1        64  Tspan8     5.1650
## 20460  64C 3.2        64  Tspan8     4.1400
## 20461  64C 3.3        64  Tspan8     6.0550
## 20462  64C 3.4        64  Tspan8     3.6800
## 20463  64C 3.5        64  Tspan8    12.7300
## 20464  64C 3.6        64  Tspan8     4.6650
## 20465  64C 3.7        64  Tspan8     2.3950
## 20466  64C 3.8        64  Tspan8     1.7450
## 20467  64C 4.1        64  Tspan8     7.5200
## 20468 64C 4.1b        64  Tspan8    12.0300
## 20469  64C 4.2        64  Tspan8    10.3450
## 20470  64C 4.3        64  Tspan8    13.9450
## 20471  64C 4.4        64  Tspan8     7.5900
## 20472  64C 4.5        64  Tspan8     6.4800
## 20473  64C 4.6        64  Tspan8    11.5150
## 20474  64C 4.7        64  Tspan8    -0.1450
## 20475  64C 4.8        64  Tspan8     8.0050
## 20476  64C 4.9        64  Tspan8     1.6150
## 20477 64C 4.10        64  Tspan8    10.9000
## 20478 64C 4.11        64  Tspan8    14.3150
## 20479 64C 4.12        64  Tspan8     4.5800
## 20480 64C 4.13        64  Tspan8     0.5000
## 20481 64C 4.14        64  Tspan8     1.9550
## 20482 64C 4.15        64  Tspan8     1.3350
## 20483 64C 4.16        64  Tspan8     0.7950
## 20484 64C 4.17        64  Tspan8     3.3950
## 20485 64C 4.18        64  Tspan8     3.1850
## 20486 64C 4.19        64  Tspan8     1.6500
## 20487 64C 4.20        64  Tspan8     1.9650
## 20488 64C 4.21        64  Tspan8     4.5100
## 20489 64C 4.22        64  Tspan8     1.2800
## 20490 64C 4.23        64  Tspan8     2.2750
## 20491 64C 4.24        64  Tspan8     0.8750
## 20492 64C 4.25        64  Tspan8     1.9950
## 20493 64C 4.26        64  Tspan8     9.9350
## 20494 64C 4.27        64  Tspan8     2.3700
## 20495 64C 4.28        64  Tspan8    13.6550
## 20496 64C 4.29        64  Tspan8     2.0325
## 20497 64C 4.30        64  Tspan8    12.2800
## 20498 64C 4.31        64  Tspan8     1.6900
## 20499 64C 4.32        64  Tspan8     9.4300
## 20500 64C 4.33        64  Tspan8    -0.4000
## 20501 64C 4.34        64  Tspan8     0.2950
## 20502 64C 4.35        64  Tspan8     9.5800
## 20503 64C 4.36        64  Tspan8     1.3400
## 20504 64C 4.37        64  Tspan8     0.4350
## 20505 64C 4.38        64  Tspan8     0.7125
## 20506 64C 4.39        64  Tspan8     3.1650
## 20507  64C 5.1        64  Tspan8     4.5950
## 20508  64C 5.2        64  Tspan8    12.0950
## 20509  64C 5.3        64  Tspan8     9.4650
## 20510  64C 5.4        64  Tspan8     2.5950
## 20511  64C 5.5        64  Tspan8     9.7950
## 20512  64C 5.6        64  Tspan8    12.9200
## 20513  64C 5.7        64  Tspan8    13.7500
## 20514  64C 5.8        64  Tspan8    11.4600
## 20515  64C 5.9        64  Tspan8    10.2550
## 20516 64C 5.10        64  Tspan8    12.1200
## 20517 64C 5.11        64  Tspan8    -0.1550
## 20518 64C 5.12        64  Tspan8     0.2600
## 20519 64C 5.13        64  Tspan8     0.4450
## 20520 64C 5.14        64  Tspan8    -0.8100
## 20521 64C 5.15        64  Tspan8     6.7100
## 20522 64C 5.16        64  Tspan8     4.4550
## 20523  64C 6.1        64  Tspan8     7.0700
## 20524  64C 6.2        64  Tspan8     9.8950
## 20525  64C 6.3        64  Tspan8    14.0200
## 20526  64C 6.4        64  Tspan8     9.7200
## 20527  64C 6.5        64  Tspan8    11.6300
## 20528  64C 6.6        64  Tspan8     7.7950
## 20529  64C 6.7        64  Tspan8     7.6800
## 20530  64C 6.8        64  Tspan8     9.7400
## 20531  64C 7.1        64  Tspan8    14.1500
## 20532  64C 7.2        64  Tspan8    12.2850
## 20533  64C 7.3        64  Tspan8    14.0100
## 20534  64C 7.4        64  Tspan8    13.3200
## 20535  64C 7.5        64  Tspan8    12.5450
## 20536  64C 7.6        64  Tspan8    11.2900
## 20537  64C 7.7        64  Tspan8    11.8950
## 20538  64C 7.8        64  Tspan8     7.0900
## 20539  64C 7.9        64  Tspan8    14.7350
## 20540 64C 7.10        64  Tspan8     3.2200
## 20541 64C 7.11        64  Tspan8     3.4150
## 20542 64C 7.12        64  Tspan8     4.5400
## 20543 64C 7.13        64  Tspan8     5.3150
## 20544 64C 7.14        64  Tspan8     2.8650

But destiny doesn’t use long form data as input, since all single cell data has always a more compact structure of genes×cells, with a certain number of per-sample covariates (The structure of ExpressionSet).

dm <- DiffusionMap(guo_norm)

names(dm) shows what names can be used in dm$<name>, as.data.frame(dm)$<name>, or ggplot(dm, aes(<name>)):

names(dm)  # namely: Diffusion Components, Genes, and Covariates
##  [1] "DC1"       "DC2"       "DC3"       "DC4"       "DC5"       "DC6"      
##  [7] "DC7"       "DC8"       "DC9"       "DC10"      "DC11"      "DC12"     
## [13] "DC13"      "DC14"      "DC15"      "DC16"      "DC17"      "DC18"     
## [19] "DC19"      "DC20"      "Actb"      "Ahcy"      "Aqp3"      "Atp12a"   
## [25] "Bmp4"      "Cdx2"      "Creb312"   "Cebpa"     "Dab2"      "DppaI"    
## [31] "Eomes"     "Esrrb"     "Fgf4"      "Fgfr2"     "Fn1"       "Gapdh"    
## [37] "Gata3"     "Gata4"     "Gata6"     "Grhl1"     "Grhl2"     "Hand1"    
## [43] "Hnf4a"     "Id2"       "Klf2"      "Klf4"      "Klf5"      "Krt8"     
## [49] "Lcp1"      "Mbnl3"     "Msc"       "Msx2"      "Nanog"     "Pdgfa"    
## [55] "Pdgfra"    "Pecam1"    "Pou5f1"    "Runx1"     "Sox2"      "Sall4"    
## [61] "Sox17"     "Snail"     "Sox13"     "Tcfap2a"   "Tcfap2c"   "Tcf23"    
## [67] "Utf1"      "Tspan8"    "Cell"      "num_cells"

Due to the fortify method (which here just means as.data.frame) being defined on DiffusionMap objects, ggplot directly accepts DiffusionMap objects:

ggplot(dm, aes(DC1, DC2, colour = Klf2)) +
    geom_point()

When you want to use a Diffusion Map in a dplyr pipeline, you need to call fortify/as.data.frame directly:

fortify(dm) %>%
    mutate(
        EmbryoState = factor(num_cells) %>%
            lvls_revalue(paste(levels(.), 'cell state'))
    ) %>% ggplot(aes(DC1, DC2, colour = EmbryoState)) +
        geom_point()

The Diffusion Components of a converted Diffusion Map, similar to the genes in the input ExpressionSet, are individual variables instead of two columns in a long-form data frame, but sometimes it can be useful to “tidy” them:

fortify(dm) %>%
    gather(DC, OtherDC, num_range('DC', 2:5)) %>%
    ggplot(aes(DC1, OtherDC, colour = factor(num_cells))) +
        geom_point() +
        facet_wrap(~ DC)

Another tip: To reduce overplotting, use sample_frac(., 1.0, replace = FALSE) (the default) in a pipeline.

Adding a constant alpha improves this even more, and also helps you see density:

fortify(dm) %>%
    sample_frac() %>%
    ggplot(aes(DC1, DC2, colour = factor(num_cells))) +
        geom_point(alpha = .3)

destiny/man/0000755000175200017520000000000014516010071014021 5ustar00biocbuildbiocbuilddestiny/man/DPT-matrix-methods.Rd0000644000175200017520000000333214516010071017703 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/dpt-methods-matrix.r \name{DPT matrix methods} \alias{DPT matrix methods} \alias{[.DPT} \alias{nrow.DPT} \alias{ncol.DPT} \alias{dim.DPT} \alias{[,DPT,index,index,logicalOrMissing-method} \alias{[,DPT,index,missing,logicalOrMissing-method} \alias{[,DPT,missing,index,logicalOrMissing-method} \alias{[,DPT,missing,missing,logicalOrMissing-method} \alias{[[,DPT,index,index-method} \alias{nrow,DPT-method} \alias{ncol,DPT-method} \alias{dim,DPT-method} \title{DPT Matrix methods} \usage{ \S4method{[}{DPT,index,index,logicalOrMissing}(x, i, j, ..., drop = TRUE) \S4method{[}{DPT,index,missing,logicalOrMissing}(x, i, j, ..., drop = TRUE) \S4method{[}{DPT,missing,index,logicalOrMissing}(x, i, j, ..., drop = TRUE) \S4method{[}{DPT,missing,missing,logicalOrMissing}(x, i, j, ..., drop = TRUE) \S4method{[[}{DPT,index,index}(x, i, j, ...) \S4method{nrow}{DPT}(x) \S4method{ncol}{DPT}(x) \S4method{dim}{DPT}(x) } \arguments{ \item{x}{\code{\link{DPT}} object.} \item{i, j}{\link[=numeric]{Numeric} or \link{logical} index.} \item{...}{ignored} \item{drop}{If \code{\link{TRUE}}, coerce result to a vector if it would otherwise have \code{1 \%in\% dim(result)}.} } \value{ \code{[} returns a dense matrix or (if applicable and \code{isTRUE(drop)}) a vector. \code{[[} returns single distance value \code{nrow} and \code{ncol} return the number of cells \code{dim} returns \code{c(n_cells, n_cells)} } \description{ Treat DPT object as a matrix of cell-by-cell DPT distances. } \examples{ data(guo_norm) dm <- DiffusionMap(guo_norm) dpt <- DPT(dm) set.seed(1) plot(dpt[random_root(dpt), ], Biobase::exprs(guo_norm)['DppaI', ]) } \seealso{ \code{\link{as.matrix.DPT}} } destiny/man/DPT-methods.Rd0000644000175200017520000000202414516010071016376 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/dpt-methods.r \name{DPT methods} \alias{DPT methods} \alias{dataset.DPT} \alias{branch_divide} \alias{tips} \alias{dataset,DPT-method} \alias{dataset<-,DPT-method} \title{DPT methods} \usage{ branch_divide(dpt, divide = integer(0L)) tips(dpt) \S4method{dataset}{DPT}(object) \S4method{dataset}{DPT}(object) <- value } \arguments{ \item{dpt, object}{DPT object} \item{divide}{Vector of branch numbers to use for division} \item{value}{Value of slot to set} } \value{ \code{branch_divide} and \code{dataset<-} return the changed object, \code{dataset} the extracted data, and \code{tips} the tip indices. } \description{ Methods for the \link{DPT} class. \code{branch_divide} subdivides branches for plotting (see the examples). } \examples{ data(guo_norm) dpt <- DPT(DiffusionMap(guo_norm)) dpt_9_branches <- branch_divide(dpt, 1:3) plot(dpt_9_branches, col_by = 'branch') } \seealso{ \link{plot.DPT} uses \code{branch_divide} for its \code{divide} argument. } destiny/man/DPT.Rd0000644000175200017520000000311214516010071014734 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/dpt.r \docType{class} \name{DPT-class} \alias{DPT-class} \alias{DPT} \title{Diffusion Pseudo Time} \usage{ DPT(dm, tips = random_root(dm), ..., w_width = 0.1) } \arguments{ \item{dm}{A \code{\link{DiffusionMap}} object. Its transition probabilities will be used to calculate the DPT} \item{tips}{The cell index/indices from which to calculate the DPT(s) (integer of length 1-3)} \item{...}{Unused. All parameters to the right of the \code{...} have to be specified by name (e.g. \code{DPT(dm, w_width = 0.2)})} \item{w_width}{Window width to use for deciding the branch cutoff} } \value{ A \code{DPT} object: } \description{ Create pseudotime ordering and assigns cell to one of three branches } \details{ Treat it as a matrix of pseudotime by subsetting (\code{\link[=dim.DPT]{[ dim nrow ncol}} \code{\link[=as.matrix.DPT]{as.matrix}}), and as a list of pseudodime, and expression vectors (\code{\link[=names.DPT]{$ [[ names}} \code{\link[=as.data.frame.DPT]{as.data.frame}}). } \section{Slots}{ \describe{ \item{\code{branch}}{\code{\link[base]{matrix}} (of \code{\link[base]{integer}}) recursive branch labels for each cell (row); \code{NA} for undeceided. Use \code{\link{branch_divide}} to modify this.} \item{\code{tips}}{\code{\link[base]{matrix}} (of \code{\link[base]{logical}}) indicating if a cell (row) is a tip of the corresponding banch level (col)} \item{\code{dm}}{\code{\link{DiffusionMap}} used to create this DPT object} }} \examples{ data(guo_norm) dm <- DiffusionMap(guo_norm) dpt <- DPT(dm) str(dpt) } destiny/man/DiffusionMap-accessors.Rd0000644000175200017520000000322114516010071020655 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/diffusionmap-methods-accession.r \name{DiffusionMap accession methods} \alias{DiffusionMap accession methods} \alias{eigenvalues,DiffusionMap-method} \alias{eigenvalues<-,DiffusionMap-method} \alias{eigenvectors,DiffusionMap-method} \alias{eigenvectors<-,DiffusionMap-method} \alias{sigmas,DiffusionMap-method} \alias{sigmas<-,DiffusionMap-method} \alias{dataset,DiffusionMap-method} \alias{dataset<-,DiffusionMap-method} \alias{distance,DiffusionMap-method} \alias{distance<-,DiffusionMap-method} \alias{optimal_sigma,DiffusionMap-method} \title{DiffusionMap accession methods} \usage{ \S4method{eigenvalues}{DiffusionMap}(object) \S4method{eigenvalues}{DiffusionMap}(object) <- value \S4method{eigenvectors}{DiffusionMap}(object) \S4method{eigenvectors}{DiffusionMap}(object) <- value \S4method{sigmas}{DiffusionMap}(object) \S4method{sigmas}{DiffusionMap}(object) <- value \S4method{dataset}{DiffusionMap}(object) \S4method{dataset}{DiffusionMap}(object) <- value \S4method{distance}{DiffusionMap}(object) \S4method{distance}{DiffusionMap}(object) <- value \S4method{optimal_sigma}{DiffusionMap}(object) } \arguments{ \item{object}{A DiffusionMap} \item{value}{Vector of eigenvalues or matrix of eigenvectors to get/set} } \value{ The assigned or retrieved value } \description{ Get and set eigenvalues, eigenvectors, and sigma(s) of a \link{DiffusionMap} object. } \examples{ data(guo) dm <- DiffusionMap(guo) eigenvalues(dm) eigenvectors(dm) sigmas(dm) dataset(dm) optimal_sigma(dm) } \seealso{ \link{Extraction methods}, \link{DiffusionMap methods}, \link{Coercion methods} for more } destiny/man/DiffusionMap-class.Rd0000644000175200017520000001341014516010071017776 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/diffusionmap.r \docType{class} \name{DiffusionMap-class} \alias{DiffusionMap-class} \alias{DiffusionMap} \title{Create a diffusion map of cells} \usage{ DiffusionMap( data = stopifnot_distmatrix(distance), sigma = "local", k = find_dm_k(dataset_n_observations(data, distance) - 1L), n_eigs = min(20L, dataset_n_observations(data, distance) - 2L), density_norm = TRUE, ..., distance = c("euclidean", "cosine", "rankcor", "l2"), n_pcs = NULL, n_local = seq(to = min(k, 7L), length.out = min(k, 3L)), rotate = FALSE, censor_val = NULL, censor_range = NULL, missing_range = NULL, vars = NULL, knn_params = list(), verbose = !is.null(censor_range), suppress_dpt = FALSE ) } \arguments{ \item{data}{Expression data to be analyzed and covariates. Provide \code{vars} to select specific columns other than the default: all double value columns. If \code{distance} is a distance matrix, \code{data} has to be a \code{\link{data.frame}} with covariates only.} \item{sigma}{Diffusion scale parameter of the Gaussian kernel. One of \code{'local'}, \code{'global'}, a (\link[base]{numeric}) global sigma or a \link{Sigmas} object. When choosing \code{'global'}, a global sigma will be calculated using \code{\link{find_sigmas}}. (Optional. default: \code{'local'}) A larger sigma might be necessary if the eigenvalues can not be found because of a singularity in the matrix} \item{k}{Number of nearest neighbors to consider (default: a guess betweeen 100 and \eqn{n - 1}. See \code{\link{find_dm_k}}).} \item{n_eigs}{Number of eigenvectors/values to return (default: 20)} \item{density_norm}{logical. If TRUE, use density normalisation} \item{...}{Unused. All parameters to the right of the \code{...} have to be specified by name (e.g. \code{DiffusionMap(data, distance = 'cosine')})} \item{distance}{Distance measurement method applied to \code{data} or a distance matrix/\code{\link[stats]{dist}}. For the allowed values, see \code{\link{find_knn}}. If this is a \code{\link[Matrix]{sparseMatrix}}, zeros are interpreted as "not a close neighbors", which allows the use of kNN-sparsified matrices (see the return value of \code{\link{find_knn}}.} \item{n_pcs}{Number of principal components to compute to base calculations on. Using e.g. 50 DCs results in more regular looking diffusion maps. The default NULL will not compute principal components, but use \code{reducedDims(data, 'pca')} if present. Set to NA to suppress using PCs.} \item{n_local}{If \code{sigma == 'local'}, the \code{n_local}th nearest neighbor(s) determine(s) the local sigma} \item{rotate}{logical. If TRUE, rotate the eigenvalues to get a slimmer diffusion map} \item{censor_val}{Value regarded as uncertain. Either a single value or one for every dimension (Optional, default: censor_val)} \item{censor_range}{Uncertainity range for censoring (Optional, default: none). A length-2-vector of certainty range start and end. TODO: also allow \eqn{2\times G} matrix} \item{missing_range}{Whole data range for missing value model. Has to be specified if NAs are in the data} \item{vars}{Variables (columns) of the data to use. Specifying NULL will select all columns (default: All floating point value columns)} \item{knn_params}{Parameters passed to \code{\link{find_knn}}} \item{verbose}{Show a progressbar and other progress information (default: do it if censoring is enabled)} \item{suppress_dpt}{Specify TRUE to skip calculation of necessary (but spacious) information for \code{\link{DPT}} in the returned object (default: FALSE)} } \value{ A DiffusionMap object: } \description{ The provided data can be a double \link[base]{matrix} of expression data or a \link[base]{data.frame} with all non-integer (double) columns being treated as expression data features (and the others ignored), an \link[Biobase:class.ExpressionSet]{ExpressionSet}, or a \link[SingleCellExperiment]{SingleCellExperiment}. } \section{Slots}{ \describe{ \item{\code{eigenvalues}}{Eigenvalues ranking the eigenvectors} \item{\code{eigenvectors}}{Eigenvectors mapping the datapoints to \code{n_eigs} dimensions} \item{\code{sigmas}}{\link{Sigmas} object with either information about the \link{find_sigmas} heuristic run or just local or \link{optimal_sigma}.} \item{\code{data_env}}{Environment referencing the data used to create the diffusion map} \item{\code{eigenvec0}}{First (constant) eigenvector not included as diffusion component.} \item{\code{transitions}}{Transition probabilities. Can be NULL} \item{\code{d}}{Density vector of transition probability matrix} \item{\code{d_norm}}{Density vector of normalized transition probability matrix} \item{\code{k}}{The k parameter for kNN} \item{\code{n_pcs}}{Number of principal components used in kNN computation (NA if raw data was used)} \item{\code{n_local}}{The \code{n_local}th nearest neighbor(s) is/are used to determine local kernel density} \item{\code{density_norm}}{Was density normalization used?} \item{\code{rotate}}{Were the eigenvectors rotated?} \item{\code{distance}}{Distance measurement method used} \item{\code{censor_val}}{Censoring value} \item{\code{censor_range}}{Censoring range} \item{\code{missing_range}}{Whole data range for missing value model} \item{\code{vars}}{Vars parameter used to extract the part of the data used for diffusion map creation} \item{\code{knn_params}}{Parameters passed to \code{\link{find_knn}}} }} \examples{ data(guo) DiffusionMap(guo) DiffusionMap(guo, 13, censor_val = 15, censor_range = c(15, 40), verbose = TRUE) covars <- data.frame(covar1 = letters[1:100]) dists <- dist(matrix(rnorm(100*10), 100)) DiffusionMap(covars, distance = dists) } \seealso{ \link{DiffusionMap methods} to get and set the slots. \code{\link{find_sigmas}} to pre-calculate a fitting global \code{sigma} parameter } destiny/man/DiffusionMap-methods.Rd0000644000175200017520000000142114516010071020333 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/diffusionmap-methods.r \name{DiffusionMap methods} \alias{DiffusionMap methods} \alias{print.DiffusionMap} \alias{show.DiffusionMap} \alias{print,DiffusionMap-method} \alias{show,DiffusionMap-method} \title{DiffusionMap methods} \usage{ \S4method{print}{DiffusionMap}(x) \S4method{show}{DiffusionMap}(object) } \arguments{ \item{x, object}{A \code{\link{DiffusionMap}}} } \value{ The \code{DiffusionMap} object (\code{print}), or NULL (\code{show}), invisibly } \description{ Methods for external operations on diffusion maps } \examples{ data(guo) dm <- DiffusionMap(guo) print(dm) show(dm) } \seealso{ \link{DiffusionMap accession methods}, \link{Extraction methods}, \link{Coercion methods} for more } destiny/man/ExpressionSet-helpers.Rd0000644000175200017520000000323314516010071020564 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/expressionset-helpers.r \name{ExpressionSet helper methods} \alias{ExpressionSet helper methods} \alias{as.ExpressionSet} \alias{as.ExpressionSet,data.frame-method} \alias{read.ExpressionSet} \title{Convert object to \link[Biobase:class.ExpressionSet]{ExpressionSet} or read it from a file} \usage{ as.ExpressionSet(x, ...) \S4method{as.ExpressionSet}{data.frame}(x, annotation_cols = !sapply(x, is.double)) read.ExpressionSet(file, header = TRUE, ...) } \arguments{ \item{x}{\link[base]{data.frame} to convert to an \link[Biobase:class.ExpressionSet]{ExpressionSet}.} \item{...}{Additional parameters to \link[utils]{read.table}} \item{annotation_cols}{The data.frame columns used as annotations. All others are used as expressions. (Logical, character or numerical index array)} \item{file}{File path to read ASCII data from} \item{header}{Specifies if the file has a header row.} } \value{ an \link[Biobase:class.ExpressionSet]{ExpressionSet} object } \description{ These functions present quick way to create \link[Biobase:class.ExpressionSet]{ExpressionSet} objects. } \details{ They work by using all continuous (double) columns as expression data, and all others as observation annotations. } \examples{ library(Biobase) df <- data.frame(Time = seq_len(3), #integer column Actb = c(0.05, 0.3, 0.8), Gapdh = c(0.2, 0.03, 0.1)) set <- as.ExpressionSet(df) rownames(exprs(set)) == c('Actb', 'Gapdh') phenoData(set)$Time == 1:3 } \seealso{ \link[utils]{read.table} on which \code{read.ExpressionSet} is based, and \link[Biobase:class.ExpressionSet]{ExpressionSet}. } destiny/man/Gene-Relevance-methods.Rd0000644000175200017520000000361214516010071020533 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/gene-relevance-methods.r \name{Gene Relevance methods} \alias{Gene Relevance methods} \alias{featureNames.GeneRelevance} \alias{dataset.GeneRelevance} \alias{print,GeneRelevance-method} \alias{show,GeneRelevance-method} \alias{featureNames,GeneRelevance-method} \alias{featureNames<-,GeneRelevance,characterOrFactor-method} \alias{dataset,GeneRelevance-method} \alias{dataset<-,GeneRelevance-method} \alias{distance,GeneRelevance-method} \alias{distance<-,GeneRelevance-method} \title{Gene Relevance methods} \usage{ \S4method{print}{GeneRelevance}(x) \S4method{show}{GeneRelevance}(object) \S4method{featureNames}{GeneRelevance}(object) \S4method{featureNames}{GeneRelevance,characterOrFactor}(object) <- value \S4method{dataset}{GeneRelevance}(object) \S4method{dataset}{GeneRelevance}(object) <- value \S4method{distance}{GeneRelevance}(object) \S4method{distance}{GeneRelevance}(object) <- value } \arguments{ \item{x, object}{\code{GeneRelevance} object} \item{value}{A text vector (\code{\link{character}} or \code{\link{factor}})} } \value{ \code{dataset}, \code{distance}, and \code{featureNames} return the stored properties. The other methods return a \code{GeneRelevance} object (\code{print}, \code{... <- ...}), or NULL (\code{show}), invisibly } \description{ \code{featureNames <- ...} can be used to set the gene names used for plotting (e.g. if the data contains hardly readably gene or transcript IDs). \code{dataset} gets the expressions used for the gene relevance calculations, and \code{distance} the distance measure. } \examples{ data(guo_norm) dm <- DiffusionMap(guo_norm) gr <- gene_relevance(dm) stopifnot(distance(gr) == distance(dm)) featureNames(gr)[[37]] <- 'Id2 (suppresses differentiation)' # now plot it with the changed gene name(s) } \seealso{ \code{\link{gene_relevance}}, \link{Gene Relevance plotting} } destiny/man/Gene-Relevance-plotting.Rd0000644000175200017520000001337614516010071020740 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/gene-relevance-plotting-differential-map.r, % R/gene-relevance-plotting-gr-map.r, R/gene-relevance-plotting-rank.r, % R/gene-relevance-plotting.r \name{plot_differential_map} \alias{plot_differential_map} \alias{plot_differential_map,matrix,matrix-method} \alias{plot_differential_map,DiffusionMap,missing-method} \alias{plot_differential_map,GeneRelevance,missing-method} \alias{plot_gene_relevance} \alias{plot_gene_relevance,matrix,matrix-method} \alias{plot_gene_relevance,DiffusionMap,missing-method} \alias{plot_gene_relevance,GeneRelevance,missing-method} \alias{plot_gene_relevance_rank} \alias{plot_gene_relevance_rank,matrix,matrix-method} \alias{plot_gene_relevance_rank,DiffusionMap,missing-method} \alias{plot_gene_relevance_rank,GeneRelevance,missing-method} \alias{Gene Relevance plotting} \alias{plot,GeneRelevance,character-method} \alias{plot,GeneRelevance,numeric-method} \alias{plot,GeneRelevance,missing-method} \title{Plot gene relevance or differential map} \usage{ plot_differential_map( coords, exprs, ..., genes, dims = 1:2, pal = hcl.colors, faceter = facet_wrap(~Gene) ) \S4method{plot_differential_map}{matrix,matrix}( coords, exprs, ..., genes, dims = 1:2, pal = hcl.colors, faceter = facet_wrap(~Gene) ) \S4method{plot_differential_map}{DiffusionMap,missing}( coords, exprs, ..., genes, dims = 1:2, pal = hcl.colors, faceter = facet_wrap(~Gene) ) \S4method{plot_differential_map}{GeneRelevance,missing}( coords, exprs, ..., genes, dims = 1:2, pal = hcl.colors, faceter = facet_wrap(~Gene) ) plot_gene_relevance( coords, exprs, ..., iter_smooth = 2L, n_top = 10L, genes = NULL, dims = 1:2, pal = palette(), col_na = "grey", limit = TRUE ) \S4method{plot_gene_relevance}{matrix,matrix}( coords, exprs, ..., iter_smooth = 2L, n_top = 10L, genes = NULL, dims = 1:2, pal = palette(), col_na = "grey", limit = TRUE ) \S4method{plot_gene_relevance}{DiffusionMap,missing}( coords, exprs, ..., iter_smooth = 2L, n_top = 10L, genes = NULL, dims = 1:2, pal = palette(), col_na = "grey", limit = TRUE ) \S4method{plot_gene_relevance}{GeneRelevance,missing}( coords, exprs, ..., iter_smooth = 2L, n_top = 10L, genes = NULL, dims = 1:2, pal = palette(), col_na = "grey", limit = TRUE ) plot_gene_relevance_rank( coords, exprs, ..., genes, dims = 1:2, n_top = 10L, pal = c("#3B99B1", "#F5191C"), bins = 10L, faceter = facet_wrap(~Gene) ) \S4method{plot_gene_relevance_rank}{matrix,matrix}( coords, exprs, ..., genes, dims = 1:2, n_top = 10L, pal = c("#3B99B1", "#F5191C"), bins = 10L, faceter = facet_wrap(~Gene) ) \S4method{plot_gene_relevance_rank}{DiffusionMap,missing}( coords, exprs, ..., genes, dims = 1:2, n_top = 10L, pal = c("#3B99B1", "#F5191C"), bins = 10L, faceter = facet_wrap(~Gene) ) \S4method{plot_gene_relevance_rank}{GeneRelevance,missing}( coords, exprs, ..., genes, dims = 1:2, n_top = 10L, pal = c("#3B99B1", "#F5191C"), bins = 10L, faceter = facet_wrap(~Gene) ) \S4method{plot}{GeneRelevance,character}(x, y, ...) \S4method{plot}{GeneRelevance,numeric}(x, y, ...) \S4method{plot}{GeneRelevance,missing}(x, y, ...) } \arguments{ \item{coords}{A \code{\link{DiffusionMap}}/\code{\link[=gene_relevance]{GeneRelevance}} object or a cells \eqn{\times} dims \code{\link{matrix}}.} \item{exprs}{An cells \eqn{\times} genes \code{\link{matrix}}. Only provide if \code{coords} is a matrix.} \item{...}{Passed to \code{plot_differential_map}/\code{plot_gene_relevance}.} \item{genes}{Genes to base relevance map on (vector of strings). You can also pass an index into the gene names (vector of numbers or logicals with length > 1). The default NULL means all genes.} \item{dims}{Names or indices of dimensions to plot. When not plotting a \code{\link[=gene_relevance]{GeneRelevance}} object, the relevance for the dimensions \code{1:max(dims)} will be calculated.} \item{pal}{Palette. Either A colormap function or a list of colors.} \item{faceter}{A ggplot faceter like \code{\link[ggplot2]{facet_wrap}(~ Gene)}.} \item{iter_smooth}{Number of label smoothing iterations to perform on relevance map. The higher the more homogenous and the less local structure.} \item{n_top}{Number the top n genes per cell count towards the score defining which genes to return and plot in the relevance map.} \item{col_na}{Color for cells that end up with no most relevant gene.} \item{limit}{Limit the amount of displayed gene labels to the amount of available colors in \code{pal}?} \item{bins}{Number of hexagonal bins for \code{plot_gene_relevance_rank}.} \item{x}{\code{\link[=gene_relevance]{GeneRelevance}} object.} \item{y}{Gene name(s) or index/indices to create differential map for. (integer or character)} } \value{ ggplot2 plot, when plotting a relevance map with a list member \code{$ids} containing the gene IDs used. } \description{ \code{plot(gene_relevance, 'Gene')} plots the differential map of this/these gene(s), \code{plot(gene_relevance)} a relevance map of a selection of genes. Alternatively, you can use \code{plot_differential_map} or \code{plot_gene_relevance} on a \code{\link[=gene_relevance]{GeneRelevance}} or \code{\link{DiffusionMap}} object, or with two matrices. } \examples{ data(guo_norm) dm <- DiffusionMap(guo_norm) gr <- gene_relevance(dm) plot(gr) # or plot_gene_relevance(dm) plot(gr, 'Fgf4') # or plot_differential_map(dm, 'Fgf4') guo_norm_mat <- t(Biobase::exprs(guo_norm)) pca <- prcomp(guo_norm_mat)$x plot_gene_relevance(pca, guo_norm_mat, dims = 2:3) plot_differential_map(pca, guo_norm_mat, genes = c('Fgf4', 'Nanog')) } \seealso{ \code{\link{gene_relevance}}, \link{Gene Relevance methods} } destiny/man/Gene-Relevance.Rd0000644000175200017520000000711014516010071017067 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/gene-relevance.r \docType{class} \name{GeneRelevance-class} \alias{GeneRelevance-class} \alias{gene_relevance} \alias{gene_relevance,DiffusionMap,missing-method} \alias{gene_relevance,matrix,dMatrixOrMatrix-method} \title{Gene relevances for entire data set} \usage{ gene_relevance( coords, exprs, ..., k = 20L, dims = 1:2, distance = NULL, smooth = TRUE, remove_outliers = FALSE, verbose = FALSE ) \S4method{gene_relevance}{DiffusionMap,missing}( coords, exprs, ..., k = 20L, dims = 1:2, distance = NULL, smooth = TRUE, remove_outliers = FALSE, verbose = FALSE ) \S4method{gene_relevance}{matrix,dMatrixOrMatrix}( coords, exprs, ..., pcs = NULL, knn_params = list(), weights = 1, k, dims, distance, smooth, remove_outliers, verbose ) } \arguments{ \item{coords}{A \code{\link{DiffusionMap}} object or a cells \eqn{\times} dims \code{\link{matrix}}.} \item{exprs}{An cells \eqn{\times} genes \code{\link{matrix}}. Only provide if \code{coords} is no \code{\link{DiffusionMap}}.} \item{...}{Unused. All parameters to the right of the \code{...} have to be specified by name.} \item{k}{Number of nearest neighbors to use} \item{dims}{Index into columns of \code{coord}} \item{distance}{Distance measure to use for the nearest neighbor search.} \item{smooth}{Smoothing parameters \code{c(window, alpha)} (see \code{\link[smoother]{smth.gaussian}}). Alternatively \code{\link{TRUE}} to use the \link[smoother]{smoother} \link[smoother:smth.options]{defaults} or \code{\link{FALSE}} to skip smoothing,} \item{remove_outliers}{Remove cells that are only within one other cell's nearest neighbor, as they tend to get large norms.} \item{verbose}{If TRUE, log additional info to the console} \item{pcs}{A cell \eqn{\times} \code{n_pcs} matrix of principal components to use for the distances.} \item{knn_params}{A \code{\link{list}} of parameters for \code{\link{find_knn}}.} \item{weights}{Weights for the partial derivatives. A vector of the same length as \code{dims}.} } \value{ A \code{GeneRelevance} object: } \description{ The relevance map is cached insided of the \code{\link{DiffusionMap}}. } \section{Slots}{ \describe{ \item{\code{coords}}{A cells \eqn{\times} dims \code{\link{matrix}} or \code{\link[Matrix:sparseMatrix-class]{sparseMatrix}} of coordinates (e.g. diffusion components), reduced to the dimensions passed as \code{dims}} \item{\code{exprs}}{A cells \eqn{\times} genes matrix of expressions} \item{\code{partials}}{Array of partial derivatives wrt to considered dimensions in reduced space (genes \eqn{\times} cells \eqn{\times} dimensions)} \item{\code{partials_norm}}{Matrix with norm of aforementioned derivatives. (n\_genes \eqn{\times} cells)} \item{\code{nn_index}}{Matrix of k nearest neighbor indices. (cells \eqn{\times} k)} \item{\code{dims}}{Column index for plotted dimensions. Can \code{\link{character}}, \code{\link{numeric}} or \code{\link{logical}}} \item{\code{distance}}{Distance measure used in the nearest neighbor search. See \code{\link{find_knn}}} \item{\code{smooth_window}}{Smoothing window used (see \code{\link[smoother]{smth.gaussian}})} \item{\code{smooth_alpha}}{Smoothing kernel width used (see \code{\link[smoother]{smth.gaussian}})} }} \examples{ data(guo_norm) dm <- DiffusionMap(guo_norm) gr <- gene_relevance(dm) m <- t(Biobase::exprs(guo_norm)) gr_pca <- gene_relevance(prcomp(m)$x, m) # now plot them! } \seealso{ \link{Gene Relevance methods}, \link{Gene Relevance plotting}: \code{plot_differential_map}/\code{plot_gene_relevance} } destiny/man/Sigmas-class.Rd0000644000175200017520000000420214516010071016634 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/sigmas.r \docType{class} \name{Sigmas-class} \alias{Sigmas-class} \alias{Sigmas} \alias{Sigmas-methods} \alias{optimal_sigma,Sigmas-method} \alias{print,Sigmas-method} \alias{show,Sigmas-method} \title{Sigmas Object} \usage{ Sigmas(...) \S4method{optimal_sigma}{Sigmas}(object) \S4method{print}{Sigmas}(x) \S4method{show}{Sigmas}(object) } \arguments{ \item{object, x}{\link{Sigmas} object} \item{...}{See \dQuote{\strong{Slots}} below} } \value{ \code{Sigmas} creates an object of the same class \code{optimal_sigma} retrieves the numeric value of the optimal sigma or local sigmas } \description{ Holds the information about how the \code{sigma} parameter for a \link{DiffusionMap} was obtained, and in this way provides a plotting function for the \link{find_sigmas} heuristic. You should not need to create a Sigmas object yourself. Provide \code{sigma} to \link{DiffusionMap} instead or use \link{find_sigmas}. } \details{ A Sigmas object is either created by \link{find_sigmas} or by specifying the \code{sigma} parameter to \link{DiffusionMap}. In the second case, if the \code{sigma} parameter is just a number, the resulting \code{Sigmas} object has all slots except of \code{optimal_sigma} set to \code{NULL}. } \section{Slots}{ \describe{ \item{\code{log_sigmas}}{Vector of length \eqn{m} containing the \eqn{\log_{10}} of the \eqn{\sigma}s} \item{\code{dim_norms}}{Vector of length \eqn{m-1} containing the average dimensionality \eqn{\langle p \rangle} for the respective kernel widths} \item{\code{optimal_sigma}}{Multiple local sigmas or the mean of the two global \eqn{\sigma}s around the highest \eqn{\langle p \rangle} (\code{c(optimal_idx, optimal_idx+1L)})} \item{\code{optimal_idx}}{The index of the highest \eqn{\langle p \rangle}.} \item{\code{avrd_norms}}{Vector of length \eqn{m} containing the average dimensionality for the corresponding sigma.} }} \examples{ data(guo) sigs <- find_sigmas(guo, verbose = FALSE) optimal_sigma(sigs) print(sigs) } \seealso{ \code{\link{find_sigmas}}, the function to determine a locally optimal sigma and returning this class } destiny/man/coercions.Rd0000644000175200017520000000344714516010071016304 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/methods-coercion.r \name{Coercion methods} \alias{Coercion methods} \alias{as.data.frame.DiffusionMap} \alias{fortify.DiffusionMap} \alias{as.data.frame.DPT} \alias{fortify.DPT} \alias{as.matrix.DPT} \alias{as.data.frame,DiffusionMap-method} \alias{as.data.frame,DPT-method} \alias{as.matrix,DPT-method} \title{Coercion methods} \usage{ \S4method{as.data.frame}{DiffusionMap}(x, row.names = NULL, optional = FALSE, ...) fortify.DiffusionMap(model, data, ...) \S4method{as.data.frame}{DPT}(x, row.names = NULL, optional = FALSE, ...) fortify.DPT(model, data, ...) \S4method{as.matrix}{DPT}(x, ...) } \arguments{ \item{x, model}{A \code{\link{DiffusionMap}} or \code{\link{DPT}} object} \item{row.names}{NULL or a character vector giving the row names for the data frame. Missing values are not allowed.} \item{optional}{logical. If TRUE, setting row names and converting column names (to syntactic names: see make.names) is optional.} \item{...}{Passed to \code{\link[base]{as.data.frame}}} \item{data}{ignored} } \value{ An object of the desired class } \description{ Convert a \code{\link{DiffusionMap}} or \code{\link{DPT}} object to other classes } \details{ \link[ggplot2]{fortify} is a ggplot2 generic allowing a diffusion map to be used as \code{data} parameter in \link[ggplot2]{ggplot} or \link[ggplot2]{qplot}. } \examples{ library(Biobase) data(guo) dm <- DiffusionMap(guo) classes <- vapply(as.data.frame(dm), class, character(1L)) stopifnot(all(classes[paste0('DC', 1:20)] == 'numeric')) stopifnot(all(classes[featureNames(guo) ] == 'numeric')) stopifnot(all(classes[ varLabels(guo) ] == c('factor', 'integer'))) } \seealso{ \link{DiffusionMap accession methods}, \link{Extraction methods}, \link{DiffusionMap methods} for more } destiny/man/colorlegend.Rd0000644000175200017520000000453414516010071016613 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/colorlegend.r \name{colorlegend} \alias{colorlegend} \title{Color legend} \usage{ colorlegend( col, pal = palette(), log = FALSE, posx = c(0.9, 0.93), posy = c(0.05, 0.9), main = NULL, cex_main = par("cex.sub"), cex_axis = par("cex.axis"), col_main = par("col.sub"), col_lab = par("col.lab"), steps = 5, steps_color = 100, digit = 2, left = FALSE, ..., cex.main = NULL, cex.axis = NULL, col.main = NULL, col.lab = NULL ) } \arguments{ \item{col}{Vector of factor, integer, or double used to determine the ticks.} \item{pal}{If \code{col} is double, pal is used as a continuous palette, else as categorical one} \item{log}{Use logarithmic scale?} \item{posx}{Left and right borders of the color bar relative to plot area (Vector of length 2; 0-1)} \item{posy}{Bottom and top borders of color bar relative to plot area (Vector of length 2; 0-1)} \item{main}{Legend title} \item{cex_main}{Size of legend title font (default: subtitle font size \code{\link{par}('cex.sub')})} \item{cex_axis}{Size of ticks/category labels (default: axis font size \code{\link{par}('cex.axis')})} \item{col_main}{Color of legend title (default: subtitle color \code{\link{par}('col.sub')})} \item{col_lab}{Color of tick or category labels (default: axis color \code{\link{par}('col.lab')})} \item{steps}{Number of labels in case of a continuous axis. If 0 or FALSE, draw no ticks} \item{steps_color}{Number of gradient samples in case of continuous axis} \item{digit}{Number of digits for continuous axis labels} \item{left}{logical. If TRUE, invert posx} \item{...}{Additional parameters for the \link[graphics]{text} call used for labels} \item{cex.main, cex.axis, col.main, col.lab}{For compatibility with \code{\link{par}}} } \value{ This function is called for the side effect of adding a colorbar to a plot and returns nothing/NULL. } \description{ Creates a color legend for a vector used to color a plot. It will use the current \code{\link[grDevices]{palette}()} or the specified \code{pal} as reference. } \details{ When passed a factor or integer vector, it will create a discrete legend, whereas a double vector will result in a continuous bar. } \examples{ color_data <- 1:6 par(mar = par('mar') + c(0, 0, 0, 3)) plot(sample(6), col = color_data) colorlegend(color_data) } destiny/man/cube_helix.Rd0000644000175200017520000000451714516010071016426 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/cube_helix.r \name{cube_helix} \alias{cube_helix} \alias{scale_colour_cube_helix} \alias{scale_color_cube_helix} \alias{scale_fill_cube_helix} \title{Sequential color palette using the cube helix system} \usage{ cube_helix( n = 6, start = 0, r = 0.4, hue = 0.8, gamma = 1, light = 0.85, dark = 0.15, reverse = FALSE ) scale_colour_cube_helix( ..., start = 0, r = 0.4, hue = 0.8, gamma = 1, light = 0.85, dark = 0.15, reverse = FALSE, discrete = TRUE, guide = if (discrete) "legend" else "colourbar" ) scale_color_cube_helix( ..., start = 0, r = 0.4, hue = 0.8, gamma = 1, light = 0.85, dark = 0.15, reverse = FALSE, discrete = TRUE, guide = if (discrete) "legend" else "colourbar" ) scale_fill_cube_helix( ..., start = 0, r = 0.4, hue = 0.8, gamma = 1, light = 0.85, dark = 0.15, reverse = FALSE, discrete = TRUE, guide = if (discrete) "legend" else "colourbar" ) } \arguments{ \item{n}{Number of colors to return (default: 6)} \item{start}{Hue to start helix at (\eqn{\textrm{start} \in [0,3]}, default: 0)} \item{r}{Number of rotations of the helix. Can be negative. (default: 0.4)} \item{hue}{Saturation. 0 means greyscale, 1 fully saturated colors (default: 0.8)} \item{gamma}{Emphasize darker (gamma < 1) or lighter (gamma > 1) colors (default: 1)} \item{light}{Lightest lightness (default: 0.85)} \item{dark}{Darkest lightness (default: 0.15)} \item{reverse}{logical. If TRUE, reverse lightness (default: FALSE)} \item{...}{parameters passed to \code{\link[ggplot2]{discrete_scale}} or \code{\link[ggplot2]{continuous_scale}}} \item{discrete}{If TRUE, return a discrete scale, if FALSE a continuous one (default: TRUE)} \item{guide}{Type of scale guide to use. See \code{\link[ggplot2]{guides}}} } \value{ A \code{character} vector of hex colors with length \code{n} } \description{ Creates a perceptually monotonously decreasing (or increasing) lightness color palette with different tones. This was necessary in pre-viridis times, by now you can probably just use \code{\link[grDevices]{hcl.colors}} } \examples{ palette(cube_helix()) image(matrix(1:6), col = 1:6, pch = 19, axes = FALSE) cr <- scales::colour_ramp(cube_helix(12, r = 3)) r <- runif(100) plot(1:100, r, col = cr(r), type = 'b', pch = 20) } destiny/man/destiny-generics.Rd0000644000175200017520000000312014516010071017560 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/accessor-generics.r \name{destiny generics} \alias{destiny generics} \alias{eigenvalues} \alias{eigenvalues<-} \alias{eigenvectors} \alias{eigenvectors<-} \alias{sigmas} \alias{sigmas<-} \alias{dataset} \alias{dataset<-} \alias{distance} \alias{distance<-} \alias{optimal_sigma} \title{destiny generics} \usage{ eigenvalues(object) eigenvalues(object) <- value eigenvectors(object) eigenvectors(object) <- value sigmas(object) sigmas(object) <- value dataset(object) dataset(object) <- value distance(object) distance(object) <- value optimal_sigma(object) } \arguments{ \item{object}{Object from which to extract or to which to assign a value} \item{value}{Value to assign within an object} } \value{ \code{eigenvalues} retrieves the numeric eigenvalues \code{eigenvectors} retrieves the eigenvectors matrix \code{sigmas} retrieves the \code{\link{Sigmas}} from an object utilizing it as kernel width \code{dataset} retrieves the data the object was created from \code{distance} retrieves the distance metric used to create the object, e.g. \code{euclidean} \code{optimal_sigma} retrieves the numeric value of the optimal sigma or local sigmas } \description{ destiny provides several generic methods and implements them for the \code{\link{DiffusionMap}} and \code{\link{Sigmas}} classes. } \examples{ data(guo_norm) dm <- DiffusionMap(guo_norm) eigenvalues(dm) eigenvectors(dm) sigmas(dm) optimal_sigma(dm) dataset(dm) distance(dm) } \seealso{ \link{DiffusionMap methods} and \link{Sigmas} class for implementations } destiny/man/destiny.Rd0000644000175200017520000000060714516010071015772 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/destiny-package.r \docType{package} \name{destiny} \alias{destiny} \title{Create and plot diffusion maps} \description{ The main function is \code{\link{DiffusionMap}}, which returns an object you can \code{\link{plot}} (\code{\link{plot.DiffusionMap}} is then called). } \examples{ demo(destiny, ask = FALSE) } destiny/man/dm_predict.Rd0000644000175200017520000000232314516010071016422 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/predict.r \name{dm_predict} \alias{dm_predict} \title{Predict new data points using an existing DiffusionMap. The resulting matrix can be used in \link[=plot.DiffusionMap]{the plot method for the DiffusionMap}} \usage{ dm_predict(dm, new_data, ..., verbose = FALSE) } \arguments{ \item{dm}{A \code{\link{DiffusionMap}} object.} \item{new_data}{New data points to project into the diffusion map. Can be a \link[base]{matrix}, \link[base]{data.frame}, \link[Biobase:class.ExpressionSet]{ExpressionSet}, or \link[SingleCellExperiment]{SingleCellExperiment}.} \item{...}{Passed to \code{\link[proxy:dist]{proxy::dist}(new_data, data, dm@distance, ...)}.} \item{verbose}{Show progress messages?} } \value{ A \eqn{nrow(new\_data) \times ncol(eigenvectors(dif))} matrix of projected diffusion components for the new data. } \description{ Predict new data points using an existing DiffusionMap. The resulting matrix can be used in \link[=plot.DiffusionMap]{the plot method for the DiffusionMap} } \examples{ data(guo) g1 <- guo[, guo$num_cells != 32L] g2 <- guo[, guo$num_cells == 32L] dm <- DiffusionMap(g1) dc2 <- dm_predict(dm, g2) plot(dm, new_dcs = dc2) } destiny/man/eig_decomp.Rd0000644000175200017520000000153414516010071016406 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/eig_decomp.r \name{eig_decomp} \alias{eig_decomp} \title{Fast eigen decomposition using \code{\link[RSpectra]{eigs}}} \usage{ eig_decomp(M, n_eigs, sym, ..., opts = list()) } \arguments{ \item{M}{A matrix (e.g. from the Matrix package) or a function (see \code{\link[RSpectra]{eigs}}).} \item{n_eigs}{Number of eigenvectors to return.} \item{sym}{defunct and ignored.} \item{...}{Passed to \code{\link[RSpectra]{eigs}}.} \item{opts}{Passed to \code{\link[RSpectra]{eigs}}.} } \value{ see \code{\link[RSpectra]{eigs}}. } \description{ By default uses a random initialization vector that you can make deterministic using \code{\link[base]{set.seed}} or override by specifying \code{opts = list(initvec = ...)}. } \examples{ eig_decomp(cbind(c(1,0,-1), c(0,1,0), c(-1,0,1)), 2) } destiny/man/extractions.Rd0000644000175200017520000000326614516010071016662 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/methods-extraction.r \name{Extraction methods} \alias{Extraction methods} \alias{names.DPT} \alias{names.DiffusionMap} \alias{[[.DPT} \alias{[[.DiffusionMap} \alias{$.DPT} \alias{$.DiffusionMap} \alias{names,DiffusionMap-method} \alias{names,DPT-method} \alias{[[,DiffusionMap,character,missing-method} \alias{[[,DPT,character,missing-method} \alias{$,DiffusionMap-method} \alias{$,DPT-method} \title{Extraction methods} \usage{ \S4method{names}{DiffusionMap}(x) \S4method{names}{DPT}(x) \S4method{[[}{DiffusionMap,character,missing}(x, i, j, ...) \S4method{[[}{DPT,character,missing}(x, i, j, ...) \S4method{$}{DiffusionMap}(x, name) \S4method{$}{DPT}(x, name) } \arguments{ \item{x}{\code{\link{DiffusionMap}} or \code{\link{DPT}} object} \item{i, name}{Name of a diffusion component \code{'DCx'}, \code{'DPTx'}, \code{'Branch'} or column from the data} \item{j}{N/A} \item{...}{ignored} } \value{ The names or data row, see respective generics. } \description{ Extract common information from objects. Apart from the input data's branches, you can extract diffusion components via \code{$DCx}. From \code{\link{DPT}} objects, you can also extract the branch label via \code{$Branch}, or the diffusion pseudo time for a numbered cell via \code{$DPTx}. } \examples{ data(guo) dm <- DiffusionMap(guo) dm$DC1 # A diffusion component dm$Actb # A gene expression vector dm$num_cells # Phenotype metadata dpt <- DPT(dm) dm$Branch dm$DPT1 } \seealso{ \link[base]{Extract}, \code{\link[base]{names}} for the generics. \link{DiffusionMap accession methods}, \link{DiffusionMap methods}, \link{Coercion methods} for more } destiny/man/find_dm_k.Rd0000644000175200017520000000203414516010071016221 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/find_dm_k.r \name{find_dm_k} \alias{find_dm_k} \title{Find a suitable k} \usage{ find_dm_k(n, min_k = 100L, small = 1000L, big = 10000L) } \arguments{ \item{n}{Number of possible neighbors (nrow(dataset) - 1)} \item{min_k}{Minimum number of neighbors. Will be chosen for \eqn{n \ge big}} \item{small}{Number of neighbors considered small. If/where \eqn{n \le small}, n itself will be returned.} \item{big}{Number of neighbors considered big. If/where \eqn{n \ge big}, \code{min_k} will be returned.} } \value{ A vector of the same length as \code{n} that contains suitable \code{k} values for the respective \code{n} } \description{ The \code{k} parameter for the k nearest neighbors used in \link{DiffusionMap} should be as big as possible while still being computationally feasible. This function approximates it depending on the size of the dataset \code{n}. } \examples{ curve(find_dm_k(n), 0, 13000, xname = 'n') curve(find_dm_k(n) / n, 0, 13000, xname = 'n') } destiny/man/find_sigmas.Rd0000644000175200017520000000440014516010071016571 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/sigmas.r \name{find_sigmas} \alias{find_sigmas} \title{Calculate the average dimensionality for m different gaussian kernel widths (\eqn{\sigma}).} \usage{ find_sigmas( data, step_size = 0.1, steps = 10L, start = NULL, sample_rows = 500L, early_exit = FALSE, ..., censor_val = NULL, censor_range = NULL, missing_range = NULL, vars = NULL, verbose = TRUE ) } \arguments{ \item{data}{Data set with \eqn{n} observations. Can be a \link[base]{data.frame}, \link[base]{matrix}, \link[Biobase:class.ExpressionSet]{ExpressionSet} or \link[SingleCellExperiment]{SingleCellExperiment}.} \item{step_size}{Size of log-sigma steps} \item{steps}{Number of steps/calculations} \item{start}{Initial value to search from. (Optional. default: \eqn{\log_{10}(min(dist(data)))})} \item{sample_rows}{Number of random rows to use for sigma estimation or vector of row indices/names to use. In the first case, only used if actually smaller than the number of available rows (Optional. default: 500)} \item{early_exit}{logical. If TRUE, return if the first local maximum is found, else keep running} \item{...}{Unused. All parameters to the right of the \code{...} have to be specified by name (e.g. \code{find_sigmas(data, verbose = FALSE)})} \item{censor_val}{Value regarded as uncertain. Either a single value or one for every dimension} \item{censor_range}{Uncertainity range for censoring. A length-2-vector of certainty range start and end. TODO: also allow \eqn{2\times G} matrix} \item{missing_range}{Whole data range for missing value model. Has to be specified if NAs are in the data} \item{vars}{Variables (columns) of the data to use. Specifying TRUE will select all columns (default: All floating point value columns)} \item{verbose}{logical. If TRUE, show a progress bar and plot the output} } \value{ Object of class \link{Sigmas} } \description{ The sigma with the maximum value in average dimensionality is close to the ideal one. Increasing step number gets this nearer to the ideal one. } \examples{ data(guo) sigs <- find_sigmas(guo, verbose = TRUE) DiffusionMap(guo, sigs) } \seealso{ \code{\link{Sigmas}}, the class returned by this; \code{\link{DiffusionMap}}, the class this is used for } destiny/man/find_tips.Rd0000644000175200017520000000114614516010071016271 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/dpt-helpers.r \name{find_tips} \alias{find_tips} \title{Find tips in a DiffusionMap object} \usage{ find_tips(dm_or_dpt, root = random_root(dm_or_dpt)) } \arguments{ \item{dm_or_dpt}{A \code{\link{DiffusionMap}} or \code{\link{DPT}} object} \item{root}{Root cell index from which to find tips. (default: random)} } \value{ An integer vector of length 3 } \description{ Find tips in a DiffusionMap object } \examples{ data(guo) dm <- DiffusionMap(guo) is_tip <- l_which(find_tips(dm), len = ncol(guo)) plot(dm, col = factor(is_tip)) } destiny/man/guo.Rd0000644000175200017520000000232114516010071015100 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/guo-data.r \docType{data} \name{guo} \alias{guo} \alias{data:guo} \alias{data:guo_norm} \alias{guo_norm} \title{Guo at al. mouse embryonic stem cell qPCR data} \format{ An \link[Biobase:class.ExpressionSet]{ExpressionSet} with 48 features, 428 observations and 2 \link[Biobase]{phenoData} annotations. } \usage{ data(guo) data(guo_norm) } \value{ an \link[Biobase:class.ExpressionSet]{ExpressionSet} with 48 features and 428 observations containing qPCR Ct values and a "num.cells" observation annotation. } \description{ Gene expression data of 48 genes and an annotation column \code{$num_cells} containing the cell stage at which the embryos were harvested. } \details{ The data is normalized using the mean of two housekeeping genes. The difference between \code{guo} and \code{guo_norm} is the LoD being set to 10 in the former, making it usable with the \code{censor_val} parameter of \link{DiffusionMap}. } \references{ \url{http://www.sciencedirect.com/science/article/pii/S1534580710001103} } \author{ Guoji Guo, Mikael Huss, Guo Qing Tong, Chaoyang Wang, Li Li Sun, Neil D. Clarke, Paul Robson \email{robsonp@gis.a-star.edu.sg} } \keyword{data} destiny/man/knn.Rd0000644000175200017520000000334314516010071015101 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/knn.r \name{find_knn} \alias{find_knn} \title{kNN search} \usage{ find_knn( data, k, ..., query = NULL, distance = c("euclidean", "cosine", "rankcor", "l2"), method = c("covertree", "hnsw"), sym = TRUE, verbose = FALSE ) } \arguments{ \item{data}{Data matrix} \item{k}{Number of nearest neighbors} \item{...}{Parameters passed to \code{\link[RcppHNSW]{hnsw_knn}}} \item{query}{Query matrix. Leave it out to use \code{data} as query} \item{distance}{Distance metric to use. Allowed measures: Euclidean distance (default), cosine distance (\eqn{1-corr(c_1, c_2)}) or rank correlation distance (\eqn{1-corr(rank(c_1), rank(c_2))})} \item{method}{Method to use. \code{'hnsw'} is tunable with \code{...} but generally less exact than \code{'covertree'} (default: 'covertree')} \item{sym}{Return a symmetric matrix (as long as query is NULL)?} \item{verbose}{Show a progressbar? (default: FALSE)} } \value{ A \code{\link{list}} with the entries: \describe{ \item{\code{index}}{A \eqn{nrow(data) \times k} \link{integer} \link{matrix} containing the indices of the k nearest neighbors for each cell.} \item{\code{dist}}{A \eqn{nrow(data) \times k} \link{double} \link{matrix} containing the distances to the k nearest neighbors for each cell.} \item{\code{dist_mat}}{ A \code{\link[Matrix:dgCMatrix-class]{dgCMatrix}} if \code{sym == TRUE}, else a \code{\link[Matrix:dsCMatrix-class]{dsCMatrix}} (\eqn{nrow(query) \times nrow(data)}). Any zero in the matrix (except for the diagonal) indicates that the cells in the corresponding pair are close neighbors. } } } \description{ Approximate k nearest neighbor search with flexible distance function. } destiny/man/l_which.Rd0000644000175200017520000000176414516010071015735 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/l_which.r \name{l_which} \alias{l_which} \title{Logical which} \usage{ l_which(idx, nms = seq_len(len), len = length(nms), useNames = TRUE) } \arguments{ \item{idx}{Numeric or character indices.} \item{nms}{Array of names or a sequence. Required if \code{idx} is a character array} \item{len}{Length of output array. Alternative to \code{nms} if \code{idx} is numeric} \item{useNames}{Use the names of nms or idx} } \value{ Logical vector of length \code{len} or the same length as \code{nms} } \description{ Inverse of \link[base]{which}. Converts an array of numeric or character indices to a logical index array. This function is useful if you need to perform logical operation on an index array but are only given numeric indices. } \details{ Either \code{nms} or \code{len} has to be specified. } \examples{ all(l_which(2, len = 3L) == c(FALSE, TRUE, FALSE)) all(l_which(c('a', 'c'), letters[1:3]) == c(TRUE, FALSE, TRUE)) } destiny/man/plot.DPT.Rd0000644000175200017520000000365414516010071015724 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/dpt-plotting.r \name{plot.DPT} \alias{plot.DPT} \alias{plot,DPT,numeric-method} \alias{plot,DPT,missing-method} \title{Plot DPT} \usage{ plot.DPT( x, root = NULL, paths_to = integer(0L), dcs = 1:2, divide = integer(0L), w_width = 0.1, col_by = "dpt", col_path = rev(palette()), col_tip = "red", ..., col = NULL, legend_main = col_by ) \S4method{plot}{DPT,numeric}(x, y, ...) \S4method{plot}{DPT,missing}(x, y, ...) } \arguments{ \item{x}{A \code{\link{DPT}} object.} \item{paths_to}{Numeric Branch IDs. Are used as target(s) for the path(s) to draw.} \item{dcs}{The dimensions to use from the DiffusionMap} \item{divide}{If \code{col_by = 'branch'}, this specifies which branches to divide. (see \code{\link{branch_divide}})} \item{w_width}{Window width for smoothing the path (see \code{\link[smoother]{smth.gaussian}})} \item{col_by}{Color by 'dpt' (DPT starting at \code{branches[[1]]}), 'branch', or a veriable of the data.} \item{col_path}{Colors for the path or a function creating n colors} \item{col_tip}{Color for branch tips} \item{...}{Graphical parameters supplied to \code{\link{plot.DiffusionMap}}} \item{col}{See \code{\link{plot.DiffusionMap}}. This overrides \code{col_by}} \item{legend_main}{See \code{\link{plot.DiffusionMap}}.} \item{y, root}{Root branch ID. Will be used as the start of the DPT. (default: lowest branch ID) (If longer than size 1, will be interpreted as \code{c(root, branches)})} } \value{ The return value of the underlying call is returned, i.e. a scatterplot3d or rgl object for 3D plots. } \description{ Plots diffusion components from a Diffusion Map and the accompanying Diffusion Pseudo Time (\code{\link{DPT}}) } \examples{ data(guo_norm) dm <- DiffusionMap(guo_norm) dpt <- DPT(dm) plot(dpt) plot(dpt, 2L, col_by = 'branch') plot(dpt, 1L, 2:3, col_by = 'num_cells') plot(dpt, col_by = 'DPT3') } destiny/man/plot.DiffusionMap.Rd0000644000175200017520000001000614516010071017646 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/diffusionmap-plotting.r \name{plot.DiffusionMap} \alias{plot.DiffusionMap} \alias{plot,DiffusionMap,numeric-method} \alias{plot,DiffusionMap,missing-method} \title{3D or 2D plot of diffusion map} \usage{ plot.DiffusionMap( x, dims = 1:3, new_dcs = if (!is.null(new_data)) dm_predict(x, new_data), new_data = NULL, col = NULL, col_by = NULL, col_limits = NULL, col_new = "red", pal = NULL, pal_new = NULL, ..., ticks = FALSE, axes = TRUE, box = FALSE, legend_main = col_by, legend_opts = list(), interactive = FALSE, draw_legend = !is.null(col_by) || (length(col) > 1 && !is.character(col)), consec_col = TRUE, col_na = "grey", plot_more = function(p, ..., rescale = NULL) p ) \S4method{plot}{DiffusionMap,numeric}(x, y, ...) \S4method{plot}{DiffusionMap,missing}(x, y, ...) } \arguments{ \item{x}{A \link{DiffusionMap}} \item{dims, y}{Diffusion components (eigenvectors) to plot (default: first three components; 1:3)} \item{new_dcs}{An optional matrix also containing the rows specified with \code{y} and plotted. (default: no more points)} \item{new_data}{A data set in the same format as \code{x} that is used to create \code{new_dcs <- \link{dm_predict}(dif, new_data)}} \item{col}{Single color string or vector of discrete or categoric values to be mapped to colors. E.g. a column of the data matrix used for creation of the diffusion map. (default: \code{\link[igraph]{cluster_louvain}} if igraph is installed)} \item{col_by}{Specify a \code{dataset(x)} or \code{phenoData(dataset(x))} column to use as color} \item{col_limits}{If \code{col} is a continuous (=double) vector, this can be overridden to map the color range differently than from min to max (e.g. specify \code{c(0, 1)})} \item{col_new}{If \code{new_dcs} is given, it will take on this color. A vector is also possible. (default: red)} \item{pal}{Palette used to map the \code{col} vector to colors. (default: use \code{\link{hcl.colors}} for continuous and \code{\link{palette}()} for discrete data)} \item{pal_new}{Palette used to map the \code{col_new} vector to colors. (default: see \code{pal} argument)} \item{...}{Parameters passed to \link{plot}, \link[scatterplot3d]{scatterplot3d}, or \link[rgl]{plot3d} (if \code{interactive == TRUE})} \item{ticks}{logical. If TRUE, show axis ticks (default: FALSE)} \item{axes}{logical. If TRUE, draw plot axes (default: Only if \code{ticks} is TRUE)} \item{box}{logical. If TRUE, draw plot frame (default: TRUE or the same as \code{axes} if specified)} \item{legend_main}{Title of legend. (default: nothing unless \code{col_by} is given)} \item{legend_opts}{Other \link{colorlegend} options (default: empty list)} \item{interactive}{Use \link[rgl]{plot3d} to plot instead of \link[scatterplot3d]{scatterplot3d}?} \item{draw_legend}{logical. If TRUE, draw color legend (default: TRUE if \code{col_by} is given or \code{col} is given and a vector to be mapped)} \item{consec_col}{If \code{col} or \code{col_by} refers to an integer column, with gaps (e.g. \code{c(5,0,0,3)}) use the palette color consecutively (e.g. \code{c(3,1,1,2)})} \item{col_na}{Color for \code{NA} in the data. specify \code{NA} to hide.} \item{plot_more}{Function that will be called while the plot margins are temporarily changed (its \code{p} argument is the rgl or scatterplot3d instance or NULL, its \code{rescale} argument is \code{NULL}, a \code{list(from = c(a, b), to = c(c, d))}), or an array of shape \eqn{from|to \times dims \times min|max}, i.e. \eqn{2 \times length(dims) \times 2}. In case of 2d plotting, it should take and return a ggplot2 object.} } \value{ The return value of the underlying call is returned, i.e. a scatterplot3d or rgl object. } \description{ If you want to plot the eigenvalues, simply \code{plot(eigenvalues(dm)[start:end], ...)} } \details{ If you specify negative numbers as diffusion components (e.g. \code{plot(dm, c(-1,2))}), then the corresponding components will be flipped. } \examples{ data(guo) plot(DiffusionMap(guo)) } destiny/man/plot.Sigmas.Rd0000644000175200017520000000271414516010071016514 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/sigmas-plotting.r \name{plot.Sigmas} \alias{plot.Sigmas} \alias{plot,Sigmas,missing-method} \title{Plot \link{Sigmas} object} \usage{ \S4method{plot}{Sigmas,missing}( x, col = par("fg"), col_highlight = "#E41A1C", col_line = "#999999", type = c("b", "b"), pch = c(par("pch"), 4L), only_dim = FALSE, ..., xlab = NULL, ylab = NULL, main = "" ) } \arguments{ \item{x}{Sigmas object to plot} \item{col}{Vector of bar colors or single color for all bars} \item{col_highlight}{Color for highest bar. Overrides col} \item{col_line}{Color for the line and its axis} \item{type}{Plot type of both lines. Can be a vector of length 2 to specify both separately (default: 'b' aka \dQuote{both lines and points})} \item{pch}{Point identifier for both lines. Can be a vector of length 2 to specify both separately (default: \code{par(pch)} and 4 (a \sQuote{\eqn{\times}}))} \item{only_dim}{logical. If TRUE, only plot the derivative line} \item{...}{Options passed to the call to plot} \item{xlab}{X label. NULL to use default} \item{ylab}{Either one y label or y labels for both plots. NULL to use both defauts, a NULL in a list of length 2 to use one default.} \item{main}{Title of the plot} } \value{ This method plots a Sigma object to the current device and returns nothing/NULL } \description{ Plot \link{Sigmas} object } \examples{ data(guo) sigs <- find_sigmas(guo) plot(sigs) } destiny/man/projection_dist.Rd0000644000175200017520000000211414516010071017505 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/projection-dist.r \name{projection_dist} \alias{projection_dist} \title{Projection distance} \usage{ projection_dist(dm, new_dcs = NULL, ..., new_data, verbose = FALSE) } \arguments{ \item{dm}{A \code{\link{DiffusionMap}} object.} \item{new_dcs}{Diffusion component matrix of which to calculate the distance to the data.} \item{...}{Passed to \code{\link[proxy:dist]{proxy::dist}} if \code{new_data} was passed.} \item{new_data}{New data points to project into the diffusion map. Can be a \link[base]{matrix}, \link[base]{data.frame}, \link[Biobase:class.ExpressionSet]{ExpressionSet}, or \link[SingleCellExperiment]{SingleCellExperiment}.} \item{verbose}{If \code{\link{TRUE}}, log additional info to the console.} } \value{ A vector of distances each new data point has to the existing data. } \description{ Projection distance } \examples{ data(guo_norm) g2_32 <- guo_norm[, guo_norm$num_cells < 64] g64 <- guo_norm[, guo_norm$num_cells == 64] dm <- DiffusionMap(g2_32) d <- projection_dist(dm, new_data = g64) } destiny/man/random_root.Rd0000644000175200017520000000072714516010071016641 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/dpt-helpers.r \name{random_root} \alias{random_root} \title{Find a random root cell index} \usage{ random_root(dm_or_dpt) } \arguments{ \item{dm_or_dpt}{A \code{\link{DiffusionMap}} or \code{\link{DPT}} object} } \value{ A cell index } \description{ Finds a cell that has the maximum DPT distance from a randomly selected one. } \examples{ data(guo) dm <- DiffusionMap(guo) random_root(dm) } destiny/man/updateObject-methods.Rd0000644000175200017520000000174014516010071020364 0ustar00biocbuildbiocbuild% Generated by roxygen2: do not edit by hand % Please edit documentation in R/methods-update.r \name{updateObject methods} \alias{updateObject methods} \alias{updateObject.DiffusionMap} \alias{updateObject.Sigmas} \alias{updateObject.GeneRelevance} \alias{updateObject,DiffusionMap-method} \alias{updateObject,Sigmas-method} \alias{updateObject,GeneRelevance-method} \title{Update old destiny objects to a newer version.} \usage{ \S4method{updateObject}{DiffusionMap}(object, ..., verbose = FALSE) \S4method{updateObject}{Sigmas}(object, ..., verbose = FALSE) \S4method{updateObject}{GeneRelevance}(object, ..., verbose = FALSE) } \arguments{ \item{object}{An object created with an older destiny release} \item{...}{ignored} \item{verbose}{tells what is being updated} } \value{ A \link{DiffusionMap} or \link{Sigmas} object that is valid when used with the current destiny release } \description{ Handles \link{DiffusionMap}, \link{Sigmas}, and \link[=gene_relevance]{GeneRelevance}. } destiny/src/0000755000175200017520000000000014516030526014044 5ustar00biocbuildbiocbuilddestiny/src/Makevars0000644000175200017520000000002314516010071015524 0ustar00biocbuildbiocbuildPKG_CXXFLAGS=-ggdb destiny/src/RcppExports.cpp0000644000175200017520000000670314516010071017040 0ustar00biocbuildbiocbuild// Generated by using Rcpp::compileAttributes() -> do not edit by hand // Generator token: 10BE3573-1514-4C36-9D1C-5A225CD40393 #include #include using namespace Rcpp; #ifdef RCPP_USE_GLOBAL_ROSTREAM Rcpp::Rostream& Rcpp::Rcout = Rcpp::Rcpp_cout_get(); Rcpp::Rostream& Rcpp::Rcerr = Rcpp::Rcpp_cerr_get(); #endif // censoring_impl Eigen::SparseMatrix censoring_impl(const NumericMatrix data, const NumericVector sigmas, const Eigen::SparseMatrix dists, const SEXP thr_or_null, const SEXP uncertain_or_null, const SEXP missing_or_null, const Function callback); RcppExport SEXP _destiny_censoring_impl(SEXP dataSEXP, SEXP sigmasSEXP, SEXP distsSEXP, SEXP thr_or_nullSEXP, SEXP uncertain_or_nullSEXP, SEXP missing_or_nullSEXP, SEXP callbackSEXP) { BEGIN_RCPP Rcpp::RObject rcpp_result_gen; Rcpp::RNGScope rcpp_rngScope_gen; Rcpp::traits::input_parameter< const NumericMatrix >::type data(dataSEXP); Rcpp::traits::input_parameter< const NumericVector >::type sigmas(sigmasSEXP); Rcpp::traits::input_parameter< const Eigen::SparseMatrix >::type dists(distsSEXP); Rcpp::traits::input_parameter< const SEXP >::type thr_or_null(thr_or_nullSEXP); Rcpp::traits::input_parameter< const SEXP >::type uncertain_or_null(uncertain_or_nullSEXP); Rcpp::traits::input_parameter< const SEXP >::type missing_or_null(missing_or_nullSEXP); Rcpp::traits::input_parameter< const Function >::type callback(callbackSEXP); rcpp_result_gen = Rcpp::wrap(censoring_impl(data, sigmas, dists, thr_or_null, uncertain_or_null, missing_or_null, callback)); return rcpp_result_gen; END_RCPP } // predict_censoring_impl NumericMatrix predict_censoring_impl(const NumericMatrix data, const NumericMatrix data2, const double thr, const NumericVector uncertain, const NumericVector missing, const double sigma); RcppExport SEXP _destiny_predict_censoring_impl(SEXP dataSEXP, SEXP data2SEXP, SEXP thrSEXP, SEXP uncertainSEXP, SEXP missingSEXP, SEXP sigmaSEXP) { BEGIN_RCPP Rcpp::RObject rcpp_result_gen; Rcpp::RNGScope rcpp_rngScope_gen; Rcpp::traits::input_parameter< const NumericMatrix >::type data(dataSEXP); Rcpp::traits::input_parameter< const NumericMatrix >::type data2(data2SEXP); Rcpp::traits::input_parameter< const double >::type thr(thrSEXP); Rcpp::traits::input_parameter< const NumericVector >::type uncertain(uncertainSEXP); Rcpp::traits::input_parameter< const NumericVector >::type missing(missingSEXP); Rcpp::traits::input_parameter< const double >::type sigma(sigmaSEXP); rcpp_result_gen = Rcpp::wrap(predict_censoring_impl(data, data2, thr, uncertain, missing, sigma)); return rcpp_result_gen; END_RCPP } // rank_mat NumericMatrix rank_mat(const NumericMatrix x); RcppExport SEXP _destiny_rank_mat(SEXP xSEXP) { BEGIN_RCPP Rcpp::RObject rcpp_result_gen; Rcpp::RNGScope rcpp_rngScope_gen; Rcpp::traits::input_parameter< const NumericMatrix >::type x(xSEXP); rcpp_result_gen = Rcpp::wrap(rank_mat(x)); return rcpp_result_gen; END_RCPP } static const R_CallMethodDef CallEntries[] = { {"_destiny_censoring_impl", (DL_FUNC) &_destiny_censoring_impl, 7}, {"_destiny_predict_censoring_impl", (DL_FUNC) &_destiny_predict_censoring_impl, 6}, {"_destiny_rank_mat", (DL_FUNC) &_destiny_rank_mat, 1}, {NULL, NULL, 0} }; RcppExport void R_init_destiny(DllInfo *dll) { R_registerRoutines(dll, NULL, CallEntries, NULL, NULL); R_useDynamicSymbols(dll, FALSE); } destiny/src/censoring.cpp0000644000175200017520000001335414516010071016536 0ustar00biocbuildbiocbuild// [[Rcpp::plugins(cpp11)]] // [[Rcpp::depends(RcppEigen)]] #include #include #include using namespace Rcpp; inline double censor_pair( const double c, const double d, const double sigma, const double kt, const double thr, const double uncertain0, const double uncertain1, const double missing0, const double missing1 ) { bool use_d; const bool one_uncertain = (c == thr) || (d == thr), one_missing = NumericVector::is_na(c) || NumericVector::is_na(d), one_of_each_invalid = one_uncertain && one_missing, both_valid = !one_uncertain && !one_missing; /* Rcout << "one uncertain=" << one_uncertain << " one missing=" << one_missing << " one of each invalid=" << one_of_each_invalid << " both valid=" << both_valid << '\n'; Rcout << "sigma=" << sigma << " kt=" << kt << '\n'; Rcout << "before i=" << row_idx << " (" << c << "), j=" << nn_idx << " (" << d << "): " << x << '\n'; */ //4 totally different models, depending on combinations // u: uncertain // m: missing // v: valid // // | | v | u | m | // |---|---|---|---| // | v | 1 | 2a| 2b| // | u | 2a| 4 | 3 | // | m | 2b| 3 | 4 | // // 1. (valid×2): interference of two gaussians // 2. (invalid-valid): interference of box function and gaussian. a/b are parameters for the box // 3. (missing-uncertain): interference of two different box functions // 4. (invalid×2): two missing or two uncertain => 1 if (both_valid) { //1 return exp(-pow(c-d, 2) / (kt*2)); } else { //at least one invalid if (one_of_each_invalid) { //3 const double uncertain_range = uncertain1 - uncertain0 + 2*sigma; return uncertain_range / (sqrt(uncertain_range) * sqrt(missing1 - missing0)); } else if (one_uncertain || one_missing) { //2 double m0, m1; if (one_uncertain && !one_missing) { m0 = uncertain0; m1 = uncertain1; use_d = c == thr; } else if (!one_uncertain && one_missing) { m0 = missing0; m1 = missing1; use_d = NumericVector::is_na(c); } const double v = use_d ? d : c; return pow(M_PI*kt/2, -1./4) * sqrt(M_PI*kt/4) * ( std::erfc((m0-v) / sigma) - std::erfc((m1-v) / sigma) ) / sqrt(m1-m0); //Rcout << "m0=" << m0 << " m1=" << m1 << " use d=" << use_d << " x=" << x << " v=" << v << '\n'; } else {// both are uncertain or both are missing => x *= 1 => noop return 1; } } } // [[Rcpp::export]] Eigen::SparseMatrix censoring_impl( const NumericMatrix data, const NumericVector sigmas, const Eigen::SparseMatrix dists, const SEXP thr_or_null, const SEXP uncertain_or_null, const SEXP missing_or_null, const Function callback ) { const int n = data.nrow(), G = data.ncol(); const Rboolean no_threshold = Rf_isNull(thr_or_null), no_uncertain = Rf_isNull(uncertain_or_null), no_missing = Rf_isNull(missing_or_null); NumericVector thr_v = (no_threshold) ? NumericVector(0) : NumericVector(thr_or_null); NumericMatrix uncertain_m = (no_uncertain) ? NumericMatrix(0, 2) : NumericMatrix(uncertain_or_null); NumericMatrix missing_m = (no_missing) ? NumericMatrix(0, 2) : NumericMatrix(missing_or_null); typedef Eigen::SparseMatrix M; M trans_p(dists); //either length 1 or n const NumericVector kts = pow(sigmas, 2); const bool local_sigma = sigmas.length() != 1; for (int idx_major=0; idx_major #include using namespace Rcpp; Eigen::SparseMatrix censoring_impl(const NumericMatrix data, const NumericVector sigmas, const Eigen::SparseMatrix dists, const SEXP thr_or_null, const SEXP uncertain_or_null, const SEXP missing_or_null, const Function callback); NumericMatrix predict_censoring_impl(const NumericMatrix data, const NumericMatrix data2, const double thr, const NumericVector uncertain, const NumericVector missing, const double sigma); NumericMatrix rank_mat(const NumericMatrix x); #endif destiny/src/utils.cpp0000644000175200017520000000164114516010071015703 0ustar00biocbuildbiocbuild#include "utils.h" using namespace Rcpp; double cor(const NumericVector v1, const NumericVector v2) { const int n = v1.size(); if (n != v2.size()) stop("v1 needs to be of same size as v2"); double v1sum, v2sum, v12sum, v1sqr_sum, v2sqr_sum; v1sum = v2sum = v12sum = v1sqr_sum = v2sqr_sum = 0; for (int i=0; i using namespace Rcpp; double cor(const NumericVector v1, const NumericVector v2); IntegerVector rank(const NumericVector x); NumericMatrix rank_mat(const NumericMatrix x); #endif destiny/tests/0000755000175200017520000000000014516010071014410 5ustar00biocbuildbiocbuilddestiny/tests/testthat/0000755000175200017520000000000014516010071016250 5ustar00biocbuildbiocbuilddestiny/tests/testthat.R0000644000175200017520000000007214516010071016372 0ustar00biocbuildbiocbuildlibrary(testthat) library(destiny) test_check('destiny') destiny/tests/testthat/test_basic.r0000644000175200017520000000116514516010071020556 0ustar00biocbuildbiocbuildcontext('basic functionality') test_that('DiffusionMap works', { data(guo_norm) dm <- DiffusionMap(guo_norm) expect_identical(dm@distance, 'euclidean') }) test_that('Eigenvectors retain cell names', { data(guo_norm) dm <- DiffusionMap(guo_norm) expect_identical(rownames(dm@eigenvectors), Biobase::sampleNames(guo_norm)) }) test_that('DM works with dist matrices', { data(guo_norm) dists <- as(dist(t(Biobase::exprs(guo_norm))), 'sparseMatrix') rownames(dists) <- colnames(dists) <- Biobase::sampleNames(guo_norm) dm <- DiffusionMap(distance = dists) expect_identical(rownames(dm@eigenvectors), rownames(dists)) }) destiny/tests/testthat/test_dataset_types.r0000644000175200017520000001007414516010071022345 0ustar00biocbuildbiocbuildcontext('dataset types') library(Biobase) library(SingleCellExperiment) test_nobss <- 4L test_nfeat <- 3L test_obss <- paste0('c', seq_len(test_nobss)) test_feat <- paste0('g', seq_len(test_nfeat)) mk_test_matrix <- function() { m <- matrix(runif(test_nobss * test_nfeat), test_nobss, test_nfeat, dimnames = list(test_obss, test_feat)) m[m < mean(m)] <- 0 m } test_matrix <- mk_test_matrix() for (attempt in seq_len(100L)) { if (!any(duplicated(test_matrix))) break test_matrix <- mk_test_matrix() } if (any(duplicated(test_matrix))) stop('Could not create sensible test matrix after 100 attempts') test_df <- data.frame(test_matrix, cm1 = LETTERS[seq_len(test_nobss)], stringsAsFactors = FALSE) test_es <- ExpressionSet( t(test_matrix), AnnotatedDataFrame(data.frame(cm1 = LETTERS[seq_len(test_nobss)], row.names = test_obss, stringsAsFactors = FALSE)), AnnotatedDataFrame(data.frame(gm1 = letters[seq_len(test_nfeat)], row.names = test_feat, stringsAsFactors = FALSE))) test_se <- SingleCellExperiment( assays = list(logcounts = t(test_matrix)), colData = DataFrame(cm1 = LETTERS[seq_len(test_nobss)]), rowData = DataFrame(gm1 = letters[seq_len(test_nfeat)])) test_se_sparse <- test_se assay(test_se_sparse) <- as(assay(test_se_sparse), 'sparseMatrix') test_that('The helpers work with matrix data', { expect_identical(dataset_extract_doublematrix(test_matrix), test_matrix) expect_identical(dataset_n_observations (test_matrix), test_nobss) expect_identical(dataset_n_features (test_matrix), test_nfeat) expect_identical(dataset_to_df (test_matrix), test_df[, 1:3]) expect_identical(dataset_names (test_matrix), test_feat) expect_identical(dataset_get_feature (test_matrix, 'g2'), test_matrix[, 'g2']) }) test_that('The helpers work with data.frame data', { expect_identical(dataset_extract_doublematrix(test_df), test_matrix) expect_identical(dataset_n_observations (test_df), test_nobss) expect_identical(dataset_n_features (test_df), test_nfeat) expect_identical(dataset_to_df (test_df), test_df) expect_identical(dataset_names (test_df), c(test_feat, 'cm1')) expect_identical(dataset_get_feature (test_df, 'g3'), test_df$g3) expect_identical(dataset_get_feature (test_df, 'cm1'), test_df$cm1) }) test_that('The helpers work with ExpressionSet data', { expect_identical(dataset_extract_doublematrix(test_es), test_matrix) expect_identical(dataset_n_observations (test_es), test_nobss) expect_identical(dataset_n_features (test_es), test_nfeat) expect_identical(dataset_to_df (test_es), test_df) expect_identical(dataset_names (test_es), c(test_feat, 'cm1')) expect_identical(dataset_get_feature (test_es, 'g1'), exprs(test_es)['g1', ]) expect_identical(dataset_get_feature (test_es, 'cm1'), test_es$cm1) }) test_that('The helpers work with SingleCellExperiment data', { expect_identical(dataset_extract_doublematrix(test_se), test_matrix) expect_identical(dataset_n_observations (test_se), test_nobss) expect_identical(dataset_n_features (test_se), test_nfeat) expect_identical(dataset_to_df (test_se), test_df) expect_identical(dataset_names (test_se), c(test_feat, 'cm1')) expect_identical(dataset_get_feature (test_se, 'g1'), assay(test_se, 'logcounts')['g1', ]) expect_identical(dataset_get_feature (test_se, 'cm1'), test_se$cm1) }) test_that('The helpers work with sparse SingleCellExperiment data', { expect_identical(dataset_extract_doublematrix(test_se_sparse), as(test_matrix, 'sparseMatrix')) expect_identical(dataset_n_observations (test_se_sparse), test_nobss) expect_identical(dataset_n_features (test_se_sparse), test_nfeat) expect_identical(dataset_to_df (test_se_sparse), test_df) expect_identical(dataset_names (test_se_sparse), c(test_feat, 'cm1')) expect_identical(dataset_get_feature (test_se_sparse, 'g1'), assay(test_se_sparse, 'logcounts')['g1', ]) expect_identical(dataset_get_feature (test_se_sparse, 'cm1'), test_se_sparse$cm1) }) destiny/tests/testthat/test_distances.r0000644000175200017520000000207514516010071021453 0ustar00biocbuildbiocbuildcontext('distance metrics') library(Matrix) full_t_p_local <- function(dat, sigma, dists) { d2 <- as.matrix(dists ^ 2) S1 <- sigma %*% t(sigma) S2 <- outer(sigma ^ 2, sigma ^ 2, '+') rv <- sqrt(2 * S1 / S2) * exp(-d2 / S2) rv[d2 == 0] <- 0 rv } test_that('no_censoring produces the correct output for local sigma', { test_data <- matrix(rnorm(4L*5L), 4L, 5L) k <- 3L n_local <- 2:3 knn <- find_knn(test_data, k) expect_identical(dim(knn$dist), c(nrow(test_data), k)) expect_identical(dim(knn$dist_mat), rep(nrow(test_data), 2L)) expect_identical(sum(!is.finite(knn$dist_mat)), 0L) sigma <- optimal_sigma(get_sigmas(test_data, knn$dist, 'local', n_local)) expect_identical(length(sigma), nrow(test_data)) dists_expected <- full_t_p_local(test_data, sigma, knn$dist_mat) dists <- no_censoring(knn$dist_mat, sigma) expect_equal(dim(dists), dim(dists_expected)) expect_equal(as.matrix(dists), dists_expected) }) matidx_apply <- function(nrow, ncol, FUN) { mat <- matrix(NA, nrow, ncol) vals <- mapply(FUN, row(mat), col(mat)) matrix(vals, nrow, ncol) } destiny/tests/testthat/test_ggplot.r0000644000175200017520000000332314516010071020767 0ustar00biocbuildbiocbuildcontext('ggplot') data(guo_norm) get_geom <- function(p, name) { } guo_df <- as(guo_norm, 'data.frame') guo_32 <- guo_df[guo_df$num_cells == 32, ] guo_no_32 <- guo_df[guo_df$num_cells != 32, ] dm_no_32 <- DiffusionMap(guo_no_32) #3d. no idea how to test this if (FALSE) { plot.DiffusionMap(dm_no_32, 1:3, col_by = 'num_cells', pch = 20) plot.DiffusionMap(dm_no_32, 1:3, col_by = 'num_cells', ticks = TRUE, pch = 20) plot.DiffusionMap(dm_no_32, 1:3, col_by = 'num_cells', axes = FALSE, pch = 20) plot.DiffusionMap(dm_no_32, 1:3, col_by = 'num_cells', box = TRUE, pch = 20) } test_that('ggplot plots have the ticks/boxes they should have', { p1 <- plot.DiffusionMap(dm_no_32, 1:2, col_by = 'num_cells') p2 <- plot.DiffusionMap(dm_no_32, 1:2, col_by = 'num_cells', ticks = TRUE) p3 <- plot.DiffusionMap(dm_no_32, 1:2, col_by = 'num_cells', axes = FALSE) p4 <- plot.DiffusionMap(dm_no_32, 1:2, col_by = 'num_cells', box = TRUE) # check range_frame expect_identical(length(p1$layers), 2L) expect_identical(length(p2$layers), 2L) expect_identical(length(p3$layers), 1L) expect_identical(length(p4$layers), 2L) # check ticks expect_identical(class(p1$theme$axis.ticks)[[1L]], 'element_blank') expect_identical(class(p2$theme$axis.ticks)[[1L]], 'element_line') expect_identical(class(p3$theme$axis.ticks)[[1L]], 'element_blank') expect_identical(class(p4$theme$axis.ticks)[[1L]], 'element_blank') # check box expect_identical(class(p1$theme$panel.border)[[1L]], 'element_blank') expect_identical(class(p2$theme$panel.border)[[1L]], 'element_blank') expect_identical(class(p3$theme$panel.border)[[1L]], 'element_blank') expect_identical(class(p4$theme$panel.border)[[1L]], 'element_rect') }) destiny/tests/testthat/test_gr.r0000644000175200017520000000160314516010071020102 0ustar00biocbuildbiocbuildcontext('gene relevance') smps <- 120L part <- 1/4 test_data <- local({ d <- data.frame( A = c( seq(1, 0, length = smps * part), rep(0, smps*3*part)), B = c( seq(0, 1, length = smps*2*part), rep(1, smps*2*part)), C = c(rep(0, smps*part), seq(0, 1, length = smps*2*part), rep(0, smps * part)), D = c(rep(0, smps*part), seq(0, .5, length = smps * part), rep(0, smps * part), seq(.5, 1, length = smps*part)), # + rnorm(smps, 0, .05) stringsAsFactors = FALSE ) d$Cell <- seq_len(nrow(d)) d$Type <- as.integer(ceiling(d$Cell / (smps/4))) d }) test_that('Gene Relevance returns the right genes', { set.seed(0) dm <- DiffusionMap(test_data, distance = 'rankcor') gr <- gene_relevance(dm, smooth = FALSE) gr_plot <- plot_gene_relevance(gr, iter_smooth = 0, n_top = 1) skip('Not yet stable') expect_identical(gr_plot$ids[1:2], c('D', 'C')) }) destiny/tests/testthat/test_knn.r0000644000175200017520000000217714516010071020267 0ustar00biocbuildbiocbuildcontext('kNN integrity') test_that('knn works similarly to FNN', { skip_if_not_installed('FNN') data(guo_norm, package = 'destiny') e <- t(Biobase::exprs(guo_norm)) r_destiny <- destiny::find_knn(e, 5L) r_fnn <- FNN::get.knn(e, 5L) dimnames(r_destiny$index) <- dimnames(r_destiny$dist) <- NULL rows_eq <- sapply(seq_len(nrow(e)), function(r) isTRUE(all.equal(r_destiny$index[r, ], r_fnn$nn.index[r, ]))) expect_lte(sum(!rows_eq), 5L) expect_equal(r_destiny$dist[rows_eq, ], r_fnn$nn.dist[rows_eq, ], tolerance = 1e-5) }) test_that('knnx works similarly to FNN', { skip_if_not_installed('FNN') data(guo_norm, package = 'destiny') e <- t(Biobase::exprs(guo_norm)) nc <- guo_norm$num_cells r_destiny <- destiny::find_knn(e[nc != 32L,], 5L, query = e[nc == 32L,]) r_fnn <- FNN::get.knnx(e[nc != 32L,], e[nc == 32L,], 5L) dimnames(r_destiny$index) <- dimnames(r_destiny$dist) <- NULL rows_eq <- sapply(seq_len(sum(nc == 32L)), function(r) isTRUE(all.equal(r_destiny$index[r, ], r_fnn$nn.index[r, ]))) expect_lte(sum(!rows_eq), 30L) expect_equal(r_destiny$dist[rows_eq, ], r_fnn$nn.dist[rows_eq, ], tolerance = 1e-5) }) destiny/tests/testthat/test_pca.r0000644000175200017520000000266714516010071020250 0ustar00biocbuildbiocbuildcontext('PCA') library(Biobase) library(SingleCellExperiment) test_nobss <- 30L test_nfeat <- 20L test_n_pcs <- 4L test_obss <- paste0('c', seq_len(test_nobss)) test_feat <- paste0('g', seq_len(test_nfeat)) test_matrix <- matrix(runif(test_nobss * test_nfeat), test_nobss, test_nfeat, dimnames = list(test_obss, test_feat)) test_matrix[test_matrix < mean(test_matrix)] <- 0 test_matrix_sparse <- as(test_matrix, 'sparseMatrix') test_se <- SingleCellExperiment( assays = list(logcounts = t(test_matrix)), colData = DataFrame(cm1 = LETTERS[seq_len(test_nobss)]), rowData = DataFrame(gm1 = letters[seq_len(test_nfeat)])) test_se_sparse <- test_se assay(test_se_sparse) <- t(test_matrix_sparse) test_that('PCA works sparse and dense data', { # Each PC can be flipped individually, # so the correct alignment would be to see which ones need to be flipped # Using abs() is simpler for comparison, but destroys the real PCs. pcs_dense <- abs(pca_scores(test_matrix, test_n_pcs)) pcs_sparse <- abs(pca_scores(test_matrix_sparse, test_n_pcs)) expect_equal(pcs_dense, pcs_sparse, tolerance = 1e-5) }) test_that('PCA with sparse data does not densify', with_mock( prcomp = function(...) stop('prcomp should not be called'), princomp = function(...) stop('princomp should not be called'), as.matrix = function(...) stop('as.matrix should not be called'), { pca_scores(test_matrix_sparse, test_n_pcs) succeed('The matrix was not densified') } )) destiny/tests/testthat/test_utils.r0000644000175200017520000000121614516010071020632 0ustar00biocbuildbiocbuildcontext('utils') library(Matrix) test_that('duplicated.dgCMatrix works', { m <- Matrix(c( 1, 1, 2, 0, 0, 0, 3, 3, 0, 3, 3, 0, 0, 0, 0 ), 5L, 3L, TRUE, sparse = TRUE) expect_is(m, 'dgCMatrix') expect_identical(duplicated(m), c(FALSE, FALSE, FALSE, TRUE, TRUE)) expect_identical(duplicated(m, MARGIN = 2), c(FALSE, TRUE, FALSE)) expect_error(duplicated(m, MARGIN = 3), 'Invalid MARGIN 3') }) test_that('duplicated.dgCMatrix works with zero columns', { m <- sparseMatrix( c(1, 1, 1, 2, 1), c(1, 2, 4, 4, 6), x = c(1, 1, 2, 3, 1)) expect_is(m, 'dgCMatrix') expect_identical(which(duplicated(m, MARGIN = 2)), c(2L, 5L, 6L)) }) destiny/vignettes/0000755000175200017520000000000014516030526015265 5ustar00biocbuildbiocbuilddestiny/vignettes/.install_extras0000644000175200017520000000005214516010071020310 0ustar00biocbuildbiocbuild^.*\.ipynb$ ^.*\.tplx$ ^.*\.bib$ ^.*\.py$ destiny/vignettes/DPT.Rmd0000644000175200017520000000510114516010071016346 0ustar00biocbuildbiocbuild--- title: destiny 2.0 brought the Diffusion Pseudo Time (DPT) class output: rmarkdown::html_vignette bibliography: bibliography.bib vignette: > %\VignetteIndexEntry{destiny 2.0 brought the Diffusion Pseudo Time (DPT) class} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} --- ```{r} set.seed(1) ``` Diffusion Pseudo Time (DPT) is a pseudo time metric based on the transition probability of a diffusion process [@haghverdi_diffusion_2016]. *destiny* supports `DPT` in addition to its primary function of creating `DiffusionMap`s from data. ```{r} library(destiny) # load destiny… data(guo) # …and sample data library(gridExtra) # Also we need grid.arrange ``` `DPT` is in practice independent of Diffusion Maps: ```{r} par(mar = rep(0, 4)) graph <- igraph::graph_from_literal( data -+ 'transition probabilities' -+ DiffusionMap, 'transition probabilities' -+ DPT) plot( graph, layout = igraph::layout_as_tree, vertex.size = 50, vertex.color = 'transparent', vertex.frame.color = 'transparent', vertex.label.color = 'black') ``` However in order not to overcomplicate things, in *destiny*, you have to create `DPT` objects from `DiffusionMap` objects. (If you really only need the DPT, skip Diffusion Component creation by specifying `n_eigs = 0`) ```{r} dm <- DiffusionMap(guo) dpt <- DPT(dm) ``` The resulting object of a call like this will have three automatically chosen tip cells. You can also specify tip cells: ```{r} set.seed(4) dpt_random <- DPT(dm, tips = sample(ncol(guo), 3L)) ``` Plotting without parameters results in the DPT of the first root cell: TODO: wide plot ```{r} grid.arrange(plot(dpt), plot(dpt_random), ncol = 2) ``` Other possibilities include the DPT from the other tips or everything supported by `plot.DiffusionMap`: TODO: wide plot ```{r} grid.arrange( plot(dpt, col_by = 'DPT3'), plot(dpt, col_by = 'Gata4', pal = viridis::magma), ncol = 2 ) ``` The `DPT` object also contains a clustering based on the tip cells and DPT, and you can specify where to draw paths from and to: ```{r} plot(dpt, root = 2, paths_to = c(1,3), col_by = 'branch') ``` You can further divide branches. First simply plot branch colors like we did above, then identify the number of the branch you intend to plot, and then specify it in a subsequent `plot` call. In order to see the new branches best, we specify a `dcs` argument that visually spreads out out all four branches. ```{r} plot(dpt, col_by = 'branch', divide = 3, dcs = c(-1,-3,2), pch = 20) ``` References ==========
destiny/vignettes/Diffusion-Map-recap.Rmd0000644000175200017520000000214514516010071021455 0ustar00biocbuildbiocbuild--- title: Reproduce the Diffusion Map vignette with the supplied data() output: rmarkdown::html_vignette vignette: > %\VignetteIndexEntry{Reproduce the Diffusion Map vignette with the supplied data()} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} --- Quickstart ========== A short version to achive the above is by using the preprocessed version of the dataset provided with this package. `data(guo)` is already preprocessed (using the method first mentioned), has its threshold set to a constant 15 and is ready to use. Since the platform’s maximum amplification cycles are 40, that number can be used as upper border of the uncertainty range. ```{r} library(destiny) data(guo) ``` It can be used directly for diffusion map creation: ```{r} dm_guo <- DiffusionMap(guo, verbose = FALSE, censor_val = 15, censor_range = c(15, 40)) dm_guo ``` ```{r} plot(dm_guo) ``` using the annotation shows that the approximation worked ```{r} palette(cube_helix(6)) plot(dm_guo, col_by = 'num_cells', legend_main = 'Cell stage') ``` References ==========
destiny/vignettes/Diffusion-Maps.Rmd0000644000175200017520000004660214516010071020556 0ustar00biocbuildbiocbuild--- title: 'destiny main vignette: Start here!' output: rmarkdown::html_vignette bibliography: bibliography.bib vignette: > %\VignetteIndexEntry{destiny main vignette: Start here!} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} --- ```{r} library(base64enc) library(ggplot2) # would shadow Biobase::exprs suppressPackageStartupMessages({ library(readxl) library(destiny) library(Biobase) }) #setHook('on.rgl.close', function(...) { # name <- tempfile() # par3d(windowRect = c(0, 0, 1200, 1200)) # Sys.sleep(1) # # rgl.snapshot( filename = paste0(name, '.png')) # #rgl.postscript(filename = paste0(name, '.pdf'), fmt='pdf') # doesn’t work with spheres # # publish_mimebundle(list( # 'image/png' = base64encode(paste0(name, '.png')) # #, 'application/pdf' = base64encode(paste0(name, '.pdf')) # )) #}, 'replace') ``` Diffusion maps are spectral method for non-linear dimension reduction introduced by @coifman_geometric_2005. Diffusion maps are based on a distance metric (diffusion distance) which is conceptually relevant to how differentiating cells follow noisy diffusion-like dynamics, moving from a pluripotent state towards more differentiated states. The R package **destiny** implements the formulation of diffusion maps presented in @haghverdi_diffusion_2015 which is especially suited for analyzing single-cell gene expression data from time-course experiments. It implicitly arranges cells along their developmental path, with bifurcations where differentiation events occur. In particular we follow @haghverdi_diffusion_2015 and present an implementation of diffusion maps in R that is less affected by sampling density heterogeneities and thus capable of identifying both abundant and rare cell populations. In addition, **destiny** implements complex noise models reflecting zero-inflation/censoring due to drop-out events in single-cell qPCR data and allows for missing values. Finally, we further improve on the implementation from @haghverdi_diffusion_2015, and implement a nearest neighbour approximation capable of handling very large data sets of up to 300.000 cells. For those familiar with R, and data preprocessing, we recommend the section [Plotting](#Plotting). All code in this vignette is accessible via `edit(vignette('destiny'))` Preprocessing of single qPCR data ================================= As an example, we present in the following the preprocessing of data from @guo_resolution_2010. This dataset was produced by the Biomark RT-qPCR system and contains Ct values for 48 genes of 442 mouse embryonic stem cells at 7 different developmental time points, from the zygote to blastocyst. Starting at the totipotent 1-cell stage, cells transition smoothly in the transcriptional landscape towards either the trophoectoderm lineage or the inner cell mass. Subsequently, cells transition from the inner cell mass either towards the endoderm or epiblast lineage. This smooth transition from one developmental state to another, including two bifurcation events, is reflected in the expression profiles of the cells and can be visualized using **destiny**. Import ------ Downloading the table S4 from the [publication website](http://www.sciencedirect.com/science/article/pii/S1534580710001103) will give you a spreadsheet “mmc4.xls”, from which the data can be loaded: ```{r} library(readxl) raw_ct <- read_xls('mmc4.xls', 'Sheet1') raw_ct[1:9, 1:9] #preview of a few rows and columns ``` The value 28 is the assumed background expression of 28 cycle times. In order to easily clean and normalize the data without mangling the annotations, we convert the `data.frame` into a Bioconductor `ExpressionSet` using the `as.ExpressionSet` function from the **destiny** package, and assign it to the name `ct`: ```{r} library(destiny) library(Biobase) # as.data.frame because ExpressionSets # do not support readxl’s “tibbles” ct <- as.ExpressionSet(as.data.frame(raw_ct)) ct ``` The advantage of `ExpressionSet` over `data.frame` is that tasks like normalizing the expressions are both faster and do not accidentally destroy annotations by applying “normalization” to columns that are not expressions. The approach of handling a separate expression `matrix` and annotation `data.frame` requires you to be careful when adding or removing samples on both variables, while `ExpressionSet` does it internally for you. The object internally stores an expression matrix of features × samples, retrievable using `exprs(ct)`, and an annotation `data.frame` of samples × annotations as `phenoData(ct)`. Annotations can be accessed directly via `ct$column` and `ct[['column']]`. Note that the expression matrix is transposed compared to the usual samples × features `data.frame`. Data cleaning ------------- We remove all cells that have a value bigger than the background expression, indicating data points not available (`NA`). Also we remove cells from the 1 cell stage embryos, since they were treated systematically different [@guo_resolution_2010]. For this, we add an annotation column containing the embryonic cell stage for each sample by extracting the number of cells from the “Cell” annotation column: ```{r} num_cells <- gsub('^(\\d+)C.*$', '\\1', ct$Cell) ct$num_cells <- as.integer(num_cells) ``` We then use the new annotation column to create two filters: ```{r} # cells from 2+ cell embryos have_duplications <- ct$num_cells > 1 # cells with values <= 28 normal_vals <- apply(exprs(ct), 2, function(smp) all(smp <= 28)) ``` We can use the combination of both filters to exclude both non-divided cells and such containing Ct values higher than the baseline, and store the result as `cleaned_ct`: ```{r} cleaned_ct <- ct[, have_duplications & normal_vals] ``` Normalization ------------- Finally we follow @guo_resolution_2010 and normalize each cell using the endogenous controls Actb and Gapdh by subtracting their average expression for each cell. Note that it is not clear how to normalise sc-qPCR data as the expression of housekeeping genes is also stochastic. Consequently, if such housekeeping normalisation is performed, it is crucial to take the mean of several genes. ```{r} housekeepers <- c('Actb', 'Gapdh') # houskeeper gene names normalizations <- colMeans(exprs(cleaned_ct)[housekeepers, ]) guo_norm <- cleaned_ct exprs(guo_norm) <- exprs(guo_norm) - normalizations ``` The resulting `ExpressionSet` contains the normalized Ct values of all cells retained after cleaning. Plotting ======== The data necessary to create a diffusion map with our package is a a cell×gene `matrix` or `data.frame`, or alternatively an `ExpressionSet` (which has a gene×cell `exprs` matrix). In order to create a `DiffusionMap` object, you just need to supply one of those formats as first parameter to the `DiffusionMap` function. In the case of a `data.frame`, each floating point column is interpreted as expression levels, and columns of different type (e.g. `factor`, `character` or `integer`) are assumed to be annotations and ignored. Note that single-cell RNA-seq count data should be transformed using a variance-stabilizing transformation (e.g. log or rlog); the Ct scale for qPCR data is logarithmic already (an increase in 1 Ct corresponds to a doubling of transcripts). In order to create a diffusion map to plot, you have to call `DiffusionMap`, optionally with parameters. If the number of cells is small enough (< ~1000), you do not need to specify approximations like `k` (for k nearest neighbors). If you started reading here, execute `data(guo.norm)` to load the dataset that was created in the previous section. ```{r} library(destiny) #data(guo_norm) dm <- DiffusionMap(guo_norm) ``` Simply calling `plot` on the resulting object `dif` will visualize the diffusion components: ```{r} plot(dm) ``` The diffusion map nicely illustrates a branching during the first days of embryonic development. The annotation column containing the cell stage can be used to annotate our diffusion map. Using the annotation as `col` parameter will automatically color the map using the current R color palette. Use `palette(colors)` to configure it globally or `plot(..., pal = colors)` for one plot. ```{r} palette(cube_helix(6)) # configure color palette plot(dm, pch = 20, # pch for prettier points col_by = 'num_cells', # or “col” with a vector or one color legend_main = 'Cell stage') ``` Three branches appear in the map, with a bifurcation occurring the 16 cell stage and the 32 cell stage. The diffusion map is able to arrange cells according to their expression profile: Cells that divided the most and the least appear at the tips of the different branches. In order to display a 2D plot we supply a vector containing two diffusion component numbers (here 1 & 2) as second argument. ```{r} plot(dm, 1:2, col_by = 'num_cells', legend_main = 'Cell stage') ``` Alternative visualizations -------------------------- Diffusion maps consist of eigenvectors called Diffusion Components (DCs) and corresponding eigenvalues. Per default, the first 20 are returned. You are also able to use packages for interative plots like `rgl` in a similar fashion, by directly subsetting the DCs using `eigenvectors(dif)`: ```{r} library(rgl) plot3d( eigenvectors(dm)[, 1:3], col = log2(guo_norm$num_cells), type = 's', radius = .01) view3d(theta = 10, phi = 30, zoom = .8) # now use your mouse to rotate the plot in the window rgl.close() ``` For the popular `ggplot2` package, there is built in support in the form of a `fortify.DiffusionMap` method, which allows to use DiffusionMap objects as `data` parameter in the `ggplot` and `qplot` functions. But the regular `plot` function already returns a `ggplot` object anyway. ```{r} library(ggplot2) qplot(DC1, DC2, data = dm, colour = factor(num_cells)) + scale_color_cube_helix() # or alternatively: #ggplot(dif, aes(DC1, DC2, colour = factor(num.cells))) + ... ``` As aesthetics, all diffusion components, gene expressions, and annotations are available. If you plan to make many plots, create a `data.frame` first by using `as.data.frame(dif)` or `fortify(dif)`, assign it to a variable name, and use it for plotting. Parameter selection =================== The most important parameter for the visualization, `dims`, is described in the following section. An important parameter in v1, $\sigma$, is explained in its own vignette “Global Sigma”. [Other parameters](#Other-parameters) are explained at the end of this section. Dimensions `dims` ----------------- Diffusion maps consist of the eigenvectors (which we refer to as diffusion components) and corresponding eigenvalues of the diffusion distance matrix. The latter indicate the diffusion components’ importance, i.e. how well the eigenvectors approximate the data. The eigenvectors are decreasingly meaningful. ```{r} qplot(y = eigenvalues(dm)) + theme_minimal() + labs(x = 'Diffusion component (DC)', y = 'Eigenvalue') ``` The later DCs often become noisy and less useful: TODO: wide plot ```{r} plot(dm, 3:4, col_by = 'num_cells', draw_legend = FALSE) plot(dm, 19:20, col_by = 'num_cells', draw_legend = FALSE) ``` Other parameters ---------------- If the automatic exclusion of categorical and integral features for data frames is not enough, you can also supply a vector of variable names or indices to use with the `vars` parameter. If you find that calculation time or used memory is too large, the parameter `k` allows you to decrease the quality/runtime+memory ratio by limiting the number of transitions calculated and stored. It is typically not needed if you have less than few thousand cells. The `n.eigs` parameter specifies the number of diffusion components returned. For more information, consult `help(DiffusionMap)`. Missing and uncertain values ============================ **destiny** is particularly well suited for gene expression data due to its ability to cope with missing and uncertain data. Censored values --------------- Platforms such as RT-qPCR cannot detect expression values below a certain threshold. To cope with this, **destiny** allows to censor specific values. In the case of @guo_resolution_2010, only up to 28 qPCR cycles were counted. All transcripts that would need more than 28 cycles are grouped together under this value. This is illustrated by gene Aqp3: ```{r} hist(exprs(cleaned_ct)['Aqp3', ], breaks = 20, xlab = 'Ct of Aqp3', main = 'Histogram of Aqp3 Ct', col = palette()[[4]], border = 'white') ``` For our censoring noise model we need to identify the limit of detection (LoD). While most researchers use a global LoD of 28, reflecting the overall sensitivity of the qPCR machine, different strategies to quantitatively establish this gene-dependent LoD exist. For example, dilution series of bulk data can be used to establish an LoD such that a qPCR reaction will be detected with a specified probability if the Ct value is below the LoD. Here, we use such dilution series provided by Guo et al. and first determine a gene-wise LoD as the largest Ct value smaller than 28. We then follow the manual [Application Guidance: Single-Cell Data Analysis](https://www.bioke.com/Product%20Support/Manuals%20%26%20Downloads/?webshop_supplier=15&webshop_downloadtype=10&webshop_application=199&q=) of the popular Biomarks system and determine a global LoD as the median over the gene-wise LoDs. We use the dilution series from table S7 (`mmc6.xls`). If you have problems with the speed of `read.xlsx`, consider storing your data in tab separated value format and using `read.delim` or `read.ExpressionSet`. ```{r} dilutions <- read_xls('mmc6.xls', 1L) dilutions$Cell <- NULL # remove annotation column get_lod <- function(gene) gene[[max(which(gene != 28))]] lods <- apply(dilutions, 2, get_lod) lod <- ceiling(median(lods)) lod ``` This LoD of 25 and the maximum number of cycles the platform can perform (40), defines the uncertainty range that denotes the possible range of censored values in the censoring model. Using the mean of the normalization vector, we can adjust the uncertainty range and censoring value to be more similar to the other values in order to improve distance measures between data points: ```{r} lod_norm <- ceiling(median(lods) - mean(normalizations)) max_cycles_norm <- ceiling(40 - mean(normalizations)) list(lod_norm = lod_norm, max_cycles_norm = max_cycles_norm) ``` We then also need to set the normalized values that should be censored – namely all data points were no expression was detected after the LoD – to this special value, because the values at the cycle threshold were changed due to normalization. ```{r} guo <- guo_norm exprs(guo)[exprs(cleaned_ct) >= 28] <- lod_norm ``` This version of the dataset is avaliable as `data(guo)` from the **destiny** package. Now we call the the `DiffusionMap` function using the censoring model: ```{r} thresh_dm <- DiffusionMap(guo, censor_val = lod_norm, censor_range = c(lod_norm, max_cycles_norm), verbose = FALSE) plot(thresh_dm, 1:2, col_by = 'num_cells', legend_main = 'Cell stage') ``` Compared to the diffusion map created without censoring model, this map looks more homogeneous since it contains more data points. Missing values -------------- Gene expression experiments may fail to produce some data points, conventionally denoted as “not available” (`NA`). By calling `DiffusionMap(..., missings = c(total.minimum, total.maximum))`, you can specify the parameters for the missing value model. As in the data from @guo_resolution_2010 no missing values occurred, we illustrate the capacity of **destiny** to handle missing values by artificially treating ct values of 999 (i. e. data points were no expression was detected after 40 cycles) as missing. This is purely for illustrative purposes and in practice these values should be treated as censored as illustrated in the previous section. ```{r} # remove rows with divisionless cells ct_w_missing <- ct[, ct$num_cells > 1L] # and replace values larger than the baseline exprs(ct_w_missing)[exprs(ct_w_missing) > 28] <- NA ``` We then perform normalization on this version of the data: ```{r} housekeep <- colMeans( exprs(ct_w_missing)[housekeepers, ], na.rm = TRUE) w_missing <- ct_w_missing exprs(w_missing) <- exprs(w_missing) - housekeep exprs(w_missing)[is.na(exprs(ct_w_missing))] <- lod_norm ``` Finally, we create a diffusion map with both missing value model and the censoring model from before: ```{r} dif_w_missing <- DiffusionMap(w_missing, censor_val = lod_norm, censor_range = c(lod_norm, max_cycles_norm), missing_range = c(1, 40), verbose = FALSE) plot(dif_w_missing, 1:2, col_by = 'num_cells', legend_main = 'Cell stage') ``` This result looks very similar to our previous diffusion map since only six additional data points have been added. However if your platform creates more missing values, including missing values will be more useful. Prediction ========== In order to project cells into an existing diffusion map, for example to compare two experiments measured by the same platform or to add new data to an existing map, we implemented `dm.predict`. It calculates the transition probabilities between datapoints in old and new data and projects cells into the diffusion map using the existing diffusion components. As an example we assume that we created a diffusion map from one experiment on 64 cell stage embryos: ```{r} ct64 <- guo[, guo$num_cells == 64] dm64 <- DiffusionMap(ct64) ``` Let us compare the expressions from the 32 cell state embryos to the existing map. We use `dm.predict` to create the diffusion components for the new cells using the existing diffusion components from the old data: ```{r} ct32 <- guo[, guo$num_cells == 32] pred32 <- dm_predict(dm64, ct32) ``` By providing the `more` and `col.more` parameters of the `plot` function, we show the first two DCs for both old and new data: ```{r} plot(dm64, 1:2, col = palette()[[6]], new_dcs = pred32, col_new = palette()[[4]]) ``` Clearly, the 32 and 64 cell state embryos occupy similar regions in the map, while the cells from the 64 cell state are developed further. Troubleshooting =============== There are several properties of data that can yield subpar results. This section explains a few strategies of dealing with them: **Preprocessing**: if there is a strong dependency of the variance on the mean in your data (as for scRNA-Seq count data), use a variance stabilizing transformation such as the square root or a (regularized) logarithm before running **destiny**. **Outliers**: If a Diffusion Component strongly separates some outliers from the remaining cells such that there is a much greater distance between them than within the rest of the cells (i. e. almost two discrete values), consider removing those outliers and recalculating the map, or simply select different Diffusion Components. It may also a be a good idea to check whether the outliers are also present in a PCA plot to make sure they are not biologically relevant. **Large datasets**: If memory is not sufficient and no machine with more RAM is available, the `k` parameter could be decreased. In addition (particularly for >500,000 cells), you can also downsample the data (possibly in a density dependent fashion). **“Large-p-small-n” data**: E.g. for scRNA-Seq, it is may be necessary to first perform a Principal Component Analysis (PCA) on the data (e.g. using `prcomp` or `princomp`) and to calculate the Diffusion Components from the Principal Components (typically using the top 50 components yields good results). References ==========
destiny/vignettes/Gene-Relevance.Rmd0000644000175200017520000001054214516010071020504 0ustar00biocbuildbiocbuild--- title: detecting relevant genes with destiny 3 output: rmarkdown::html_vignette vignette: > %\VignetteIndexEntry{detecting relevant genes with destiny 3} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} --- Single Cell RNA-Sequencing data and gene relevance ================================================== Libraries --------- We need of course destiny, scran for preprocessing, and some tidyverse niceties. ```{r} library(conflicted) library(destiny) suppressPackageStartupMessages(library(scran)) library(purrr) library(ggplot2) library(SingleCellExperiment) ``` Data ---- Let’s use data from the `scRNAseq`[1] package. If necessary, install it via `BiocManager::install('scRNAseq')`. [1] Risso D, Cole M (2019). [scRNAseq: A Collection of Public Single-Cell RNA-Seq Datasets](https://bioconductor.org/packages/scRNAseq/). ```{r} # The parts of the help we’re interested in help('scRNAseq-package', package = 'scRNAseq') %>% repr::repr_html() %>% stringr::str_extract_all(stringr::regex('

The dataset.*?

', dotall = TRUE)) %>% unlist() %>% paste(collapse = '') %>% knitr::raw_html() ``` 379 cells seems sufficient to see something! ```{r} allen <- scRNAseq::ReprocessedAllenData() ``` Preprocessing ------------- We’ll mostly stick to the [scran vignette][] here. Let’s add basic information to the data and choose what to work with. As `scran` expects the raw counts in the `counts` assay, we rename the more accurate RSEM counts to `counts`. Our data has ERCC spike-ins in an `altExp` slot: [scran vignette]: https://bioconductor.org/packages/devel/bioc/vignettes/scran/inst/doc/scran.html ```{r} rowData(allen)$Symbol <- rownames(allen) rowData(allen)$EntrezID <- AnnotationDbi::mapIds(org.Mm.eg.db::org.Mm.eg.db, rownames(allen), 'ENTREZID', 'ALIAS') rowData(allen)$Uniprot <- AnnotationDbi::mapIds(org.Mm.eg.db::org.Mm.eg.db, rownames(allen), 'UNIPROT', 'ALIAS', multiVals = 'list') assayNames(allen)[assayNames(allen) == 'rsem_counts'] <- 'counts' assayNames(altExp(allen, 'ERCC'))[assayNames(altExp(allen, 'ERCC')) == 'rsem_counts'] <- 'counts' allen ``` Now we can use it to renormalize the data. We normalize the `counts` using the spike-in size factors and logarithmize them into `logcounts`. ```{r} allen <- computeSpikeFactors(allen, 'ERCC') allen <- logNormCounts(allen) allen ``` We also use the spike-ins to detect highly variable genes more accurately: ```{r} decomp <- modelGeneVarWithSpikes(allen, 'ERCC') rowData(allen)$hvg_order <- order(decomp$bio, decreasing = TRUE) ``` We create a subset of the data containing only rasonably highly variable genes: ```{r} allen_hvg <- subset(allen, hvg_order <= 5000L) ``` Let’s create a Diffusion map. For rapid results, people often create a PCA first, which can be stored in your `SingleCellExperiment` before creating the Diffusion map or simply created implicitly using `DiffusionMap(..., n_pcs = )`. However, even with many more principal components than necessary to get a nicely resolved Diffusion Map, the close spatial correspondence between diffusion components and genes are lost. ```{r} #reducedDim(allen_hvg, 'pca') <- irlba::prcomp_irlba(t(assay(allen, 'logcounts')), 50)$x ``` The chosen distance metric has big implications on your results, you should try at least cosine and rankcor. ```{r} set.seed(1) dms <- c('euclidean', 'cosine', 'rankcor') %>% #, 'l2' set_names() %>% map(~ DiffusionMap(allen_hvg, distance = ., knn_params = list(method = 'covertree'))) ``` TODO: wide plot ```{r} dms %>% imap(function(dm, dist) plot(dm, 1:2, col_by = 'driver_1_s') + ggtitle(dist)) %>% cowplot::plot_grid(plotlist = ., nrow = 1) ``` ```{r} grs <- map(dms, gene_relevance) ``` TODO: wide plot ```{r} gms <- imap(grs, function(gr, dist) plot(gr, iter_smooth = 0) + ggtitle(dist)) cowplot::plot_grid(plotlist = gms, nrow = 1) ``` As you can see, despite the quite different embedding, the rankcor and Cosine diffusion Maps display a number of the same driving genes. ```{r} gms[-1] %>% map(~ .$ids[1:10]) %>% purrr::reduce(intersect) %>% cat(sep = ' ') ``` ```{r} httr::GET('https://www.uniprot.org/uniprot/', query = list( columns = 'id,genes,comment(TISSUE SPECIFICITY)', format = 'tab', query = rowData(allen)$Uniprot[gms$cosine$ids[1:6]] %>% unlist() %>% paste(collapse = ' or ') )) %>% httr::content(type = 'text/tab-separated-values', encoding = 'utf-8', ) ``` destiny/vignettes/Global-Sigma.Rmd0000644000175200017520000000424414516010071020164 0ustar00biocbuildbiocbuild--- title: The effects of a global vs. local kernel output: rmarkdown::html_vignette bibliography: bibliography.bib vignette: > %\VignetteIndexEntry{The effects of a global vs. local kernel} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} --- Gaussian kernel width `sigma` ============================= The other important parameter for `DiffusionMap` is the Gaussian kernel width `sigma` ($\sigma$) that determines the transition probability between data points. The default call of **destiny** – `DiffusionMap(data)` aka `DiffusionMap(data, 'local')`) – uses a local `sigma` per cell, derived from a local density estimate around each cell. Using the 1.0 default, `sigma = 'global'`, estimates sigma using a heuristic. It is also possible to specify this parameter manually to tweak the result. The eigenvector plot explained above will show a continuous decline instead of sharp drops if either the dataset is too big or the `sigma` is chosen too small. The sigma estimation algorithm is explained in detail in @haghverdi_diffusion_2015. In brief, it works by finding a maximum in the slope of the log-log plot of local density versus `sigma`. ```{r} library(destiny) data(guo_norm) ``` Using find_sigmas ----------------- An efficient variant of that procedure is provided by `find_sigmas`. This function determines the optimal sigma for a subset of the given data and provides the default sigma for a `DiffusionMap` call. Due to a different starting point, the resulting sigma is different from above: ```{r} sigmas <- find_sigmas(guo_norm, verbose = FALSE) optimal_sigma(sigmas) ``` The resulting diffusion map’s approximation depends on the chosen sigma. Note that the sigma estimation heuristic only finds local optima and even the global optimum of the heuristic might not be ideal for your data. ```{r} palette(cube_helix(6)) plots <- lapply( list('local', 5, round(optimal_sigma(sigmas), 2), 100), function(sigma) plot( DiffusionMap(guo_norm, sigma), 1:2, main = paste('σ =', sigma), col_by = 'num_cells', draw_legend = FALSE)) do.call(gridExtra::grid.arrange, c(plots, ncol = 2)) ``` References ==========
destiny/vignettes/bibliography.bib0000644000175200017520000001062714516010071020415 0ustar00biocbuildbiocbuild@article{coifman_geometric_2005, title = {Geometric diffusions as a tool for harmonic analysis and structure definition of data: {Diffusion} maps}, url = {http://www.pnas.org/content/102/21/7426.long}, journal = {PNAS}, author = {Coifman, R. R. and Lafon, S. and Lee, A. B. and Maggioni, M. and Nadler, B. and Warner, F. and Zucker, S. W.}, year = {2005}, keywords = {diffusionmap}, file = {Coifman et al_2005_Geometric diffusions as a tool for harmonic analysis and structure definition.pdf:/home/angerer/.mozilla/firefox/6e2r9n55.default/zotero/storage/JJ3J5GKE/Coifman et al_2005_Geometric diffusions as a tool for harmonic analysis and structure definition.pdf:application/pdf} } @article{haghverdi_diffusion_2015, title = {Diffusion maps for high-dimensional single-cell analysis of differentiation data}, number = {in revision}, journal = {Bioinformatics}, author = {Haghverdi, Laleh and Buettner, Florian and Theis, Fabian J.}, year = {2015}, keywords = {diffusionmap}, file = {Haghverdi et al_2014_Diffusion maps for high-dimensional single-cell analysis of differentiation data.pdf:/home/angerer/.mozilla/firefox/6e2r9n55.default/zotero/storage/WHMAVF8P/Haghverdi et al_2014_Diffusion maps for high-dimensional single-cell analysis of differentiation data.pdf:application/pdf;Haghverdi et al_2015_Diffusion maps for high-dimensional single-cell analysis of differentiation data.pdf:/home/angerer/.mozilla/firefox/6e2r9n55.default/zotero/storage/MP8B6VAE/Haghverdi et al_2015_Diffusion maps for high-dimensional single-cell analysis of differentiation data.pdf:application/pdf} } @article{guo_resolution_2010, title = {Resolution of cell fate decisions revealed by single-cell gene expression analysis from zygote to blastocyst}, volume = {18}, issn = {1878-1551}, url = {http://www.sciencedirect.com/science/article/pii/S1534580710001103}, doi = {10.1016/j.devcel.2010.02.012}, abstract = {Three distinct cell types are present within the 64-cell stage mouse blastocyst. We have investigated cellular development up to this stage using single-cell expression analysis of more than 500 cells. The 48 genes analyzed were selected in part based on a whole-embryo analysis of more than 800 transcription factors. We show that in the morula, blastomeres coexpress transcription factors specific to different lineages, but by the 64-cell stage three cell types can be clearly distinguished according to their quantitative expression profiles. We identify Id2 and Sox2 as the earliest markers of outer and inner cells, respectively. This is followed by an inverse correlation in expression for the receptor-ligand pair Fgfr2/Fgf4 in the early inner cell mass. Position and signaling events appear to precede the maturation of the transcriptional program. These results illustrate the power of single-cell expression analysis to provide insight into developmental mechanisms. The technique should be widely applicable to other biological systems.}, language = {eng}, number = {4}, journal = {Developmental Cell}, author = {Guo, Guoji and Huss, Mikael and Tong, Guo Qing and Wang, Chaoyang and Li Sun, Li and Clarke, Neil D. and Robson, Paul}, month = apr, year = {2010}, pmid = {20412781}, keywords = {Animals, Blastocyst, Cell Cycle, Cell Differentiation, Cell Lineage, Developmental Biology, Female, Gene Expression Profiling, Gene Expression Regulation, Developmental, Male, Mice, Signal Transduction, Transcriptional Activation, Transcription, Genetic, Zygote}, pages = {675--685}, file = {Guo et al_2010_Resolution of cell fate decisions revealed by single-cell gene expression.pdf:/home/angerer/.mozilla/firefox/6e2r9n55.default/zotero/storage/P9ZJIHJQ/Guo et al_2010_Resolution of cell fate decisions revealed by single-cell gene expression.pdf:application/pdf} } @article{haghverdi_diffusion_2016, title = {Diffusion pseudotime robustly reconstructs lineage branching}, issn = {1548-7091, 1548-7105}, url = {http://www.nature.com/doifinder/10.1038/nmeth.3971}, doi = {10.1038/nmeth.3971}, journal = {Nature Methods}, author = {Haghverdi, Laleh and Büttner, Maren and Wolf, F Alexander and Buettner, Florian and Theis, Fabian J}, urldate = {2016-09-26}, date = {2016-08-29}, year = {2016}, file = {Haghverdi et al. - 2016 - Diffusion pseudotime robustly reconstructs lineage.pdf:/home/angerer/.mozilla/firefox/6e2r9n55.default/zotero/storage/2FZK7BSS/Haghverdi et al. - 2016 - Diffusion pseudotime robustly reconstructs lineage.pdf:application/pdf} } destiny/vignettes/mmc4.xls0000644000175200017520000062200014516010071016646 0ustar00biocbuildbiocbuildࡱ;   !"#$%&'()*+,-./0123456789:;<=>?@ABCDEFGHIJKLMNOPQRSTUVWXYZ[\]^_`abcdefghijklmnopqrstuvwxyz{|}~Root Entry  \pCalc Ba==@ 8@"1Verdana1Arial1Arial1Arial1Arial1Arial GENERAL                + ) , *      `Sheet111TZR3  @@   CellActbAhcyAqp3Atp12aBmp4Cdx2Creb312CebpaDab2DppaIEomesEsrrbFgf4Fgfr2Fn1GapdhGata3Gata4Gata6Grhl1Grhl2Hand1Hnf4aId2Klf2Klf4Klf5Krt8Lcp1Mbnl3MscMsx2NanogPdgfaPdgfraPecam1Pou5f1Runx1Sox2Sall4Sox17SnailSox13Tcfap2aTcfap2cTcf23Utf1Tspan81C 11C 21C 31C 41C 51C 61C 71C 81C 92C 1.12C 1.22C 2.12C 2.22C 3.12C 3.22C 4.12C 5.12C 5.22C 6.12C 6.22C 7.12C 7.22C 8.12C 8.22C 9.12C 9.22C 10.12C 10.24C 1.14C 1.24C 1.34C 1.44C 2.14C 2.24C 2.34C 3.14C 3.24C 3.34C 3.44C 4.14C 4.24C 4.34C 4.44C 5.14C 5.24C 5.34C 5.44C 6.14C 6.24C 6.34C 6.48C 1.18C 1.28C 1.38C 1.48C 1.58C 2.18C 2.28C 2.38C 2.48C 2.58C 2.68C 2.78C 2.88C 3.18C 3.28C 3.38C 3.48C 3.58C 3.68C 3.78C 3.88C 4.18C 4.28C 4.38C 4.48C 4.58C 4.68C 4.78C 5.18C 5.28C 5.38C 5.48C 5.58C 5.68C 5.78C 5.88C 6.18C 6.28C 6.38C 6.48C 6.58C 6.68C 6.78C 6.816C 1.116C 1.216C 1.316C 1.416C 1.516C 1.616C 1.716C 1.816C 1.916C 1.1016C 1.1116C 1.1216C 1.1316C 1.1416C 1.1516C 1.1616C 2.116C 2.216C 2.316C 2.416C 2.516C 2.616C 2.716C 2.816C 2.916C 2.1016C 2.1116C 2.1216C 2.1316C 2.1416C 2.1516C 2.1616C 3.116C 3.216C 3.316C 3.416C 3.516C 3.616C 3.716C 3.816C 3.916C 3.1016C 3.1116C 3.1216C 3.1316C 3.1416C 3.1516C 4.116C 4.216C 4.316C 4.416C 4.516C 4.616C 4.716C 4.816C 4.916C 4.1016C 4.1116C 4.1216C 4.1316C 4.1416C 4.1516C 4.1616C 5.116C 5.216C 5.316C 5.416C 5.516C 5.616C 5.716C 5.816C 5.916C 5.1016C 5.1116C 5.1232C 1.132C 1.232C 1.332C 1.432C 1.532C 1.632C 1.732C 1.832C 1.932C 1.1032C 1.1132C 1.1232C 1.1332C 1.1432C 1.1532C 1.1632C 1.1732C 1.1832C 1.1932C 1.2032C 1.2132C 2.132C 2.232C 2.332C 2.432C 2.532C 2.632C 2.732C 2.832C 2.932C 2.1032C 2.1132C 2.1232C 2.1332C 2.1432C 2.1532C 2.1632C 3.132C 3.232C 3.332C 3.432C 3.532C 3.632C 3.732C 3.832C 4.132C 4.232C 4.332C 4.432C 4.532C 4.632C 4.732C 4.832C 4.1032C 4.1132C 4.1232C 4.1332C 4.1432C 4.1532C 4.1632C 4.1732C 4.1832C 4.1932C 4.2032C 4.2132C 4.2232C 4.2332C 4.2432C 5.132C 5.232C 5.332C 5.432C 5.532C 5.632C 5.732C 5.832C 5.932C 5.1032C 5.1132C 5.1232C 5.1332C 5.1432C 5.1532C 5.1632C 5.1732C 5.1832C 5.1932C 5.2032C 5.2132C 5.2232C 5.2332C 6.132C 6.232C 6.332C 6.432C 6.532C 6.632C 6.732C 6.832C 7.132C 7.232C 7.332C 7.432C 7.532C 7.632C 7.732C 7.832C 8.132C 8.232C 8.332C 8.432C 8.532C 8.664C 1.164C 1.264C 1.364C 1.464C 1.564C 1.664C 1.764C 1.864C 1.964C 1.1064C 1.1164C 1.1264C 1.1364C 1.1464C 1.1564C 1.1664C 1.1764C 1.1864C 1.1964C 1.2064C 1.2164C 1.2264C 1.2364C 1.2464C 1.2564C 1.2664C 1.2764C 1.2864C 1.2964C 1.3064C 1.3164C 1.3264C 1.3364C 1.3464C 1.3564C 1.3664C 1.3764C 1.3864C 1.3964C 1.4064C 1.4164C 1.4264C 1.4364C 1.4464C 1.4564C 1.4664C 1.4764C 1.4864C 2.164C 2.264C 2.364C 2.464C 2.564C 2.664C 2.764C 2.864C 2.964C 2.1064C 2.1164C 2.1264C 2.1364C 2.1464C 2.1564C 2.1664C 2.1764C 2.1864C 2.1964C 2.2064C 2.2164C 2.2264C 2.2364C 2.2464C 2.2564C 3.164C 3.264C 3.364C 3.464C 3.564C 3.664C 3.764C 3.864C 4.164C 4.1b64C 4.264C 4.364C 4.464C 4.564C 4.664C 4.764C 4.864C 4.964C 4.1064C 4.1164C 4.1264C 4.1364C 4.1464C 4.1564C 4.1664C 4.1764C 4.1864C 4.1964C 4.2064C 4.2164C 4.2264C 4.2364C 4.2464C 4.2564C 4.2664C 4.2764C 4.2864C 4.2964C 4.3064C 4.3164C 4.3264C 4.3364C 4.3464C 4.3564C 4.3664C 4.3764C 4.3864C 4.3964C 5.164C 5.264C 5.364C 5.464C 5.564C 5.664C 5.764C 5.864C 5.964C 5.1064C 5.1164C 5.1264C 5.1364C 5.1464C 5.1564C 5.1664C 6.164C 6.264C 6.364C 6.464C 6.564C 6.664C 6.764C 6.864C 7.164C 7.264C 7.364C 7.464C 7.564C 7.664C 7.764C 7.864C 7.964C 7.1064C 7.1164C 7.1264C 7.1364C 7.14cc   dMbP?_%,*+&?'?('}'}?)'}'}?"d,, ` `? ` `?U} } 11,1,1,1,1,1,1,1,1, 1, 1, 1, 1, 1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,                                  !! "" ## $$ %% && '' (( )) ** ++ ,, -- .. // 00 1<#W%rrC! r$  Q+1@~  * q= ף3@~  r(\1@xrW/!#wr3O+r +"W#r#r!"q= ף02@#'w%&'= ףp=2@(C%)*GzT0@+;##,-(\B0@.rr0 2~ c(\2@<rrr$ r$w'  fffff2@~  rffffff1@<rO&{{$Offfff3@q= ף2@r"{$r)k$r3r+f7K ');rr0 3~ q= ף02@<(rr#r!(  Q2@ rrS(\B4@k&G(\4@r2@(\B3@rQ0@B#r!%%/r&'(\1@6(r#/rr/0Q2@ 4<grrrc$c r#  q= ף01@B %rFro!S$o4@r Kor3"%rS$O%*rrCrrrr0 5~ 2@<%rr%!%#$  (\3@ ro&Offffff4@0##;g!r{!(\O3@FrGz0@q= ף04@N$rrr/(Cr%)*fffff&0@+fffff&4@$,&rrW0 6H''rr/"?!r#;$  2@ r;(w  %Ors!r r%r&r3$"$Brr_0 7?'g%rr#!r'o&crrW$$ /$k ?Q2@T'r'"r/"(S'Kr&'q= ף0@$(&; #,-(\0@.rr/0q= ףp2@ 8~ ffffff2@0%rr%r#  fffff0@~  '( fffff2@N r#% !Csr"3@rGzT1@Gz4@x!r+#r(Cg#_&"&rr0 9~  (\B2@H rrr?"!r$s(r  Q0@x %o!K$ {$O s+ r !rrr! "Q1@T #*'?rc$s$rcrr/ 0fffff2@ : sr$rr#$r_(;!#( /?!;"?G!7&r+% (\3@ GzT3@B +'$r&'rrrrr# $(\2@ %Q2@$ &r;!#* +Q2@ ,#rr/ 0(\O3@ ; Gz0@x %rrrO#K"#!r"* k!$g g'&; (\2@` o&%#O%r%#rrr#rN$ %Gz2@$ &r"/&'* += ףp2@$ ,&r % 0 <H %{rr!r!K&7##  Gz3@0 r7##_!O% q= ף02@ Y3@Z #$"[c7&rs%"rr!W## $Q2@ %= ףp=2@ &r' (Qk0@~ )r *(\0@* +_"#rr!0 =~ g&!rrG'r "r#&S ["_#" & Qk3@ r$# (\2@B [%r& rs&#3&# $Q3@ %(\2@ &r[' (fffff0@6 )###_rr "0 >NK&r+$r3%rrr[")"  = ףp1@s"w&q= ףp0@!Grk;r#W"$r($rr%g"rr "C#+'"[rs'/0fffff&4@ ?Nrr7&r'O&w#r#7(!  1@?"{#(\0@<7!gr $r["q= ף0@<$O++%rrs$ +#$ffffff2@%$&'GzT4@$(W$G),-Q+1@.rr/0Gz3@ @Y0@r#rr%rrr{#'! %%g"r 7%)+)rC'!rrr' $$%Q2@& $7%'(q= ףp1@6)#[%"[&r0 AN_(r#r#'#!r (  Gz1@#%_ r_%$wG$r)_!r$/*!s&#$Y3@%r"'(fffff&0@)&C&,-= ףp0@.r)0 B(r#r"!w!r#?%!!C$O r?ro#$S%$r#"rrw&C#K#$%3@&#G '(Q0@6)#7;Zk%rC 0 C`&%!r$r &s#G' K!G"= ףp=1@"%3@2@ZrG#$!k'rr##_&#$fffff&3@6%!;_$g#,-(\B1@.'r30 D$K$W&r#&# r!/" g!%r#+wrGz1@&"#(\B4@$rr&!$#$(\3@%_%&'(\2@<("'rc)%0 ExW?%s$rr##!!r{#rs ##!S#SrQk3@$[$$c#Gz0@r(##o&rrr7&3r/S$",-fffff0@.rr0 Fr#r)$rrr7"*"7!#"3k%r3r"!0@B$$r%rrrr#$%(\2@$&?&#*+Gz3@$,g#;rr0 G~W%#%c(r{""r&O%3(!"#3!'%OGz4@r!O!OY1@Bc&rs("r& &W"r$%(\B3@$&r!/7#*+3@,#W#r/0= ףp3@ HN$rrr #rrrG# +w$  fffff1@ %S#(\0@!#rgq= ף2@{&K"!Q2@Hg%r)!rr7'O!'$%Gz2@0&r $r,-Y1@.#rC 0 I`r%rr%$r#%{!{"$fffff&1@$#  q= ף03@rZ'G"%"rr*"$ {# "#"{$ 0 J`'7&S(r"#%7r"'";#7#1@K"/#sQ+3@Nr#C%r'"r$*!"ffffff4@#k%$%(\3@&##&)*Q+0@+r,-q= ף0@.$s%/0= ףp3@ K?;'rrW)"%rr"r"#!"##Gk!##;!Gz2@q= ף01@B'r'+_%rr$^r#!$%3@&G$;'(Q0@)#B*+(\3@~ , %-= ףp1@.rr 0 LN'rrr?""(r;#$+!  Q+3@N!" S#'"$$N= ףp=1@r*rrw#rr$$r'#/$g{ r,-q= ף1@.c$s%/0fffff&3@ MN&$rr"O%#r'r"  q= ף03@N!G%!'"% wbk&C(\2@0G%r'!rr#!!"Gz3@#g&O"$%3@&#s#'(1@6) $w%g&Srr 0 N(\0@fr$rr#rrw'rr7"'$; (\0@0&$[!rr= ףp1@`)rr/"rr!"rr!%rr)*(\4@+"%,-2@./&r##0 O$GzT4@rr_$% rrr!/&;!sr "_%'&wwo(rr!rr !ffffff3@<"O &fg[%'[#*+(\O4@$,o"7rr!0 1,!1,"1,#1,$1,%1,&1,'1,(1,)1,*1,+1,,1,-1,.1,/1,01,11,21,31,41,51,61,71,81,91,:1,;1,<1,=1,>1,?1, PN k&w rr#r3rrr!  (\2@ %r Y3@6 !"rrr Gz0@ 1@r &r*3"rr!rr+";_%%o$S7!#, -Y1@ .#r 0 !Q!/$7 rr %r+!"rr ##"NW *! wrr[w'*r+#rr!{!'+$#7#_r,!-Y1@!.r)"0 "R"W'$rr$rrrrrK"C!$!r#K!/r%G"Gz1@T"'r'&rr   ' /!;&W''"(q= ף1@6")$#&7#r'#0 #Sr#_$!rW('r7!K&(+ "O !!S#(\4@#"? #Qk2@#rr#q= ף0@#&r(%rr ?!r! #C#SC$;#7%r'$!0 $T$7%$q= ףp4@N$rrk"g$!$rr c"$Q2@$/r$fffff3@$r($Gz0@f$K($(%rrr'{ r#$")$*(\B3@$+"",$-q= ף1@$.?%r!0 %U%(\0@H%+$ rr+"r+&rr" % Q+3@0%$!Zk%%fffff3@%rr/'#3+"S+r7$#c% g##&KC#$"r!0 &V0&{$ rr#r&3@& K#rC(C# & Q2@H&{!$_k#o%Srr&(\1@&fffff2@T&(rr'rr"K%*!# r%'&(Gz1@6&)['"%%k% 0 'W'(\0@'#!rr##rW!G$rr$ !# s s#"orr'q= ף1@'k(/%'%r)"7 _$+$ "#%W &+w C& #0 (X((\1@H(" rr&rr&r'# ( q= ף2@~(? ' _$ rk*['rrk#rr#!("Qk3@0(#r##g%7$)(*GzT3@*(+"rG&r7!0 )Y&)s% rO+%r!'C*r!_"  "rr*k{'rs( rr !rC$O&+&3"/!&K&g(!0 *Z*GzT0@H*)_rr$r##)r! * = ףp2@$*? rG !+*(\O4@$*r3r&*(\O1@*fffff2@*rr'g%&r{#%g#k!#_#;#cs$w3!G%s!r 0 +[~+'W%r+'?#r rr*$K(!S ;W(+Gz3@+r['+= ףp1@l+?)r)%&r!'$R;#c$S$*++(\4@$+,rK!$ 0 ,\,= ףp=0@~, %!rr"{'r #r%/ ? " r,= ףp=1@l,&+o'&rr(rr$O#!!!% "',((\1@~ ,)r,*Y2@,+Gz3@,,w%[-,.(\3@,/$ 0 -]-w{$rrr%r"rrr  "?!g!% r%&g%&%rr ###O"rS#'-(1@~ -)"-*Q2@-+!r,--(\1@-. W(!0 .^~.$##rr#rw#%r)c # !3[!S#.Qk3@`.r$"!rs$rr rr#$.%Y4@.&"r_&).*fffff&2@.+= ףp3@$.,s$/ %w"0 /_~/Ks$&rrS#r/#_"3&r7g%{#;  W#/= ףp3@N/r"#r*'rr!/"fffff3@Z/#c# !g#ro!K %r7!0 0`0$"rrS$#!r#&rC##![3!r(0Gz1@T0#r'Zrr"%W#+_ "r'0(Q0@0)"*0+Qk4@~ 0,r0-fffff&1@0.k$&{!0 1a1$1Y4@l1rr"r "(r G &KrO C$1(\B2@1/rc&1(\1@B1"&%'#rrwO## $1%q= ף3@01&s%W#""C!,1-1@1."*0 2b27%3"rr7#r #&rg K"%+ W!s# r(##w*#&!rr3$$? $2%GzT3@H2&?%%o$!#[$r$0 3cH3r!rr#rr_*rr 3 ffffff3@63  !#' S";%3GzT4@r3'rr'C$S%* rG%o/!r'+"%'3(q= ף0@63)'_"s" %k 0 4d4s&!r{+#(r'7"r'!#$% ;_r41@4rr$$rw)"rrC"_#&" $rO#r#rG#r&0 5e5 5Gz2@l5rr$r$ rr"#O&c%_ r5Q+4@5q= ף0@5rr  r_*$rr#r'&Orr$ rs$O$O&_"0 6f6 6= ףp3@Z6rrrrS#;%rr'!&? 3(/ 6(\O2@r6%Srs*V$&rr"3 $W$$6%2@06&$r# {$r,6-= ףp}2@6.rO%$0 7g7;;!rr$r_" rr C%w!rrrw($rrrr rC""$7%Gz2@7&s""'7(q= ף1@7)"W",7-q= ףp2@7.!r#0 8h8K"8q= ף03@N8r*?!&$/!r& "# !$8GzT2@~8gO(_rr3 "r& rr"#_$8%(\3@H8&&S#"!#K&{!/%k#0 9i~9/ $rr "r#ro"c!#K'KG#93@$9#r$S9fffff&4@$9G!&orr 9!ffffff2@69""#'$$!)9*ffffff3@9+wr,9-fffff1@9.{!$"0 :j:C(:3@T:rr"% ' rW#( %_:q= ףp3@:+$:fffff3@:rr:1@0:!"'r+&r :!2@:"o"b$:%Y2@H:&'$"K"W""rr7$#0 ;kf;# rrO#%&"r%? )O#+'S;Qk3@x;%/rW)c#)W'rr S&"$;%1@H;&?#%%/k r[r'W"0 <l<(\2@`<%S$rrrrr"rrW$%r%<(\B4@<;s!r_!!rrs##rrrrr%rW%r;&/&K& $k "rorr$0 =ml=&r'_"r%rr!$V'( =3@H=o$WrrS  r=2@=rrc!="3@$=#%rGo%r'=(Gz1@6=)7! !#'#r+#0 >n`>%rr%r;" r% %&>(\3@>3>= ףp=1@>r3>Qk0@>rr>Gz1@~ >>3@*>k '_%%r!>"Gz3@Z>#!o""'#k"_!rcs&$!0 ?o?%?Gz4@N?rrC#rW %r(%!r?q= ף2@?Q+3@?= ףp0@*? & rr?(\0@x?r'$rr r[#oK!rO!ro#r,?-(\O1@?.#%#0@1,A1,B1,C1,D1,E1,F1,G1,H1,I1,J1,K1,L1,M1,N1,O1,P1,Q1,R1,S1,T1,U1,V1,W1,X1,Y1,Z1,[1,\1,]1,^1,_1, @p`@+K)rrrr""rr$[$!r@Gz2@@s"@(\1@l@r rrr+$rrG#&r$@%= ףp2@$@&$''!!*@+= ףp3@$@,rK"&!0 AqA0@A$S#rr"ro'$+_&!#"&!Kr3wrrAfffff2@A(\2@BA!rr'$&% "rS $A%ffffff4@A&[#r'A(Gz1@6A)K$Wr?C"""0 BrBfffff&3@B)rrr"rr%rr#$c#& S$!r/ rrW o $rrrrr"&rW&#'K&_"7"rr,B-(\2@B.&&&0 CsC'!rr[#r""r'$$"r; G#%O C0@CrrC(\B4@6Cs"rK$rrr!C"Gz3@0C#r#"g r7"#)C*(\3@C+ r,C-Qk2@C.#r?&0 Dt`D_! r)%r! r# W!'%D(\1@<D 7C$r$D(\2@*D r$&r D!(\O2@6D"##!o#%$)D*Q+3@D+G",D-q= ף1@D.##W+?#0 Eu`E"r+!r!"r$K! 'EGz1@EGrE3@E(\1@Er'EGz3@E(\2@*E!#%%rr E!Y2@6E"s#g!3$ ?%)E*Gz3@*E+G$KO""'#0 FvF"F= ףp2@BFr($r#;!r/%"W F(\3@FS#'$Ffffff3@*FO# or&FY2@fFK$C'g'rr_ G%!k["K$?"k*F+Q3@~ F,rF-Gz1@F."K"0 GwTG!rrW'r !r7*# ! Gq= ףp3@~ G#G(\3@$G!G &kGGz1@Gr#Gfffff&4@ZG$rrrrkO %!o "&w")G*q= ף02@*G+3"#! 3'0 HxfH "r%w#rc#$r#$k!Zs%KHY4@H?!H1@Hr{%Hfffff1@Hq= ףp4@lH+ )b+%#!&rroo$!#,H-q= ף1@H.c# $0 Iy`I&!rr3#r#&r3)""rIq= ף04@IGzT4@I(\2@Ir/"Ifffff&3@lIr[ #rO(rrr$rr"r''I(= ףp}2@6I)#" r#r&0 Jz&Jr#rr $rrrrr%$&W&G!!&r! rr #(rrg'rr)!rr#r%!#w'rrrr'0 K{K{!_"rr$r !r' '  %OSrK(\0@Kr$3 c&%+)'r!o["!_$K#C"[-K.q= ף3@K/{!"0 L|Lk$%rrk#r!rrr##$"(r!ro' /"rrr_)$'%r$L%Qk2@0L&r$3%G rr,L-= ףp2@L.7"r&0 M}M(\2@lMk% $rr$r"rr&#+(%r!M= ףp=4@~Mr_"rr!!$r&$&r&w!rs%!r#'M(fffff2@6M)!;&#rO#rr0 N~fNk!wrr$r'"%rK&$["$Nfffff&4@N #Nffffff1@Nr%/N(\B4@*Nr')S%r!N"(\O4@N#&"$N%(\2@HN&"7's#  $)#0 ONOk_ "rg*!rS r$7! O q= ף2@$O!$_Oq= ף0@~Ow'r$#!r %##"&Z'O((\0@~ O)$O*(\1@*O+r"7%$0 P`P"rr_"&r{!rr!rPq= ף0@PP(\1@P$GPffffff1@PrC%P(\3@6P_ w'rrr? "P#(\O4@TP$!{" S#_!rg !!0 Q`QG"r(rr$!rr{!W! rQGz0@Qg%QQk3@QrrGQ2@*QKKr#&#$ Q!Q2@`Q"'" &r_#{!rSZ 0 R0R#rC*"rRq= ף04@BR r$#!#?3 Rq= ף02@~ R#RGz2@Rffffff0@Rr'R(\1@0R7!r$&r[!R"fffff&3@$R#$!S&g%'R((\0@6R)r o"S#  {#0 S0S"w%r"rS= ףp3@xS # r&?!7!s!$;Zr%c3 SQ3@6Srrrr; W&$S%(\B3@S&c!"'S(Gz0@6S)#!? cC   0 T`Ts"r*+#&g$ &C#S!k#"o"T(\B0@<T +&!rrT(\2@BT/!$&!rrOc!C"$T%q= ףp3@0T&#"r!o$,T-Gz1@T.? % 0 UU"U(\B2@Urr{#r%!r##{  & #3 r wrW#O?r#%r_O"+ $U%Gz2@$U&_!3$ #*U+fffff&4@$U,7)73"w!+!0 VNV"crr'ro o r& V = ףp3@0V G$ C"Vfffff&3@$V'r/(7V= ףp=4@VrrK%G$rS o#"3r?&rS rV?#0 W`W  $rr?#rG [!%[%"K#"&Wq= ף02@WgS"WY3@WrrW= ףp1@0Wo "r(rr;!W"= ףp3@W#"?#$W%q= ף04@W&"r#)W*(\O4@W+',W-(\1@W.;"W""0 XX[#X= ףp3@NXr+'&r#K"rC%"S"{ $Xq= ף1@Xs X(\3@~ XG$X= ףp3@Xr"X(\1@HX r(rK%r[!$X%= ףp}3@X&_"#'X(Gz0@~ X)$X*(\3@*X+g#?# #;!0 YYQ0@~Yg#+$r;%r["&r*# {!$$K rY(\2@YrrY2@0Ys !r_%rr Y!= ףp2@Y"(\3@ZY#c%W#W!#$+'%s ["rS!"[$0 ZTZ!"rr$r%*rrs!" ZY4@~ Z#ZQ1@6Zc#$rs%Z= ףp0@0Z/!rc(rr Z!Y3@<Z""#["3('#C*Z+q= ףp4@~ Z,$Z-1@Z.C! !#0 [N[S&rr#rW''/) [ fffff3@[S%[Q1@~ ["[(\0@0[;# Grr[q= ףp2@B[!r7&$rrC""$$[%Qk3@[&o$r'[(Q0@[) %'#r,[-Y1@[.##!"0 \\!\(\O3@\rr/$rw#"r*;#S#$G"{ %Crr\= ףp2@6\s!%r;!rr!\"Q3@Z\##$$GK%'S "O rg&Z_%0 ]l]$[rr"r&%rrw'%"7"{!]Gz0@]#7]= ףp1@B]rr #r{!rr ]!(\O3@*]"o"#OW"&'](Y0@])C#&/!,]-Q1@].#!"0 ^~^Zsrr%r$+'r&c#3"#![$ R;%^Q3@^r(^q= ף2@B^!$r!r%cW"!$^%Gz3@0^&C$g(+&'s#,^-1@^." $0 __#"_(\2@B_rr#rr!(s)7 #" _(\B4@_$k7 [_Y4@_#_Gz2@T_&&+!#)(/!r$j#_$= ףp3@_%_ /#f'_(Q+1@6_)k%&o#!$0`1,a1,b1,c1,d1,e1,f1,g1,h1,i1,j1,k1,l1,m1,n1,o1,p1,q1,r1,s1,t1,u1,v1,w1,x1,y1,z1,{1,|1,}1,~1,1, ``(\0@``W'rr#?%c# &'$r?"&`(\1@~ `r`(\3@`r!?!rG&K"!"$c+rrr!rs&"rk";%#rKr"O%0 a`a3$Grrr !r#### ?$aq= ף01@Har [rrRaq= ף04@~a?$%$r$!r$_&+?!r %0 b6b!rr!rrb (\B3@<b %"!$!c)!b1@brc b= ףp3@br3&b(\B2@0bo !"%+#; !b"Q3@Zb# K%O+"## + rcr%0 ccG Ow$rr7$s%! r!$G#w?%+$rcQ+2@c3@cc(\2@c%C""" c!0@c"%&$c%(\0@c&S &'c(fffff0@c)_%k"7#&,c-= ףp=1@c.c#!#0 d6d#c%r%_"d fffff&3@ld r# #G#!$_!_%W $C #dfffff3@d(\4@~d%'#c% SrrS!#$$/  r/"%0 e$eO"rreQ+4@Ber %"# &!reGz0@es$C%! rOoK {#w'k"r+w%w$c;!r'e((\1@6e)#W"S!rr_"r0 ff S"rOrr'"3!#;' C%o!rS"fGzT4@6f"$#s!!r$$f%= ףp=1@Hf&g "3##S w# %$0 g6gS!grrrW g = ףp=2@<g G(!'"#{3$_g!g(\O3@0g#s!rg= ףp3@$gkS!$!+# g!q= ף1@g"Y2@Zg#&C"S "#%rrk&!##0 h~ hhfffff&4@hfffff1@h$rh= ףp2@<hr!7(S!#( &h(\1@~ hh3@$hKK" rh(\3@hwhQk4@<hr^{!( [W"3#$h%(\0@<h& *&g o $%.h/(\2@~ h0# i~ ii= ףp=4@$i;#r!riq= ף3@0i r7% ' 'iq= ףp1@iGz2@i2@i= ףp=2@0i#(;^r7!_ Kifffff3@Ni '7"%Z'r#7#"r'i(Gz0@6i)!7#o$${'0 j$j7 +"rjQk3@jr!j Gz1@*j S%"W![%rj1@j_"c$j(\3@jw'rjGz2@j= ףp2@~ jjGzT3@*j 3#r"'#K!j"(\1@j#$3$$j%Gz1@Hj&!##&/%r$0 kk7![$r?$3'r"![%w '#!kS!k(\2@kr 3k1@Bk!''"rG%%$k%(\0@k& ''k(fffff&0@*k)"W'!.k/q= ףp3@~ k0' l$l6 ?7%rl(\3@Zl%'"!$C r//$lGz3@lrl3@~ lWl2@Bls&#G!w ;#($$l%(\1@$l&!r!*l+(\4@~ l,rl-q= ף0@~ l.%l/= ףp2@~ l0% mm_ mffffff1@BmC$)r{GS#s# # mQ+4@mrCm= ףp=1@~ mW$mfffff3@m!rmY2@mQ+3@mQ+3@m= ףp2@$mk&'$"! m!(\2@*m"+W [ r'm(Y0@m)"s!r,m-(\1@m.S$S'0 nnw"n1@`nrr"+$3 "r "'&7nfffff1@Tn!rrg sCC";&&rr n!Y3@n"Y2@n#""$n%1@Hn&r S& /!$#! +0 o$ow!C%roY3@<or(k(#!g%/?$oGz3@<oo## r o(\B3@~ o o3@~o!rrS!"/$Vr#w#C#G!rr%0 pp3#%r!{$r'r?)rr rc#Crrr$!"+"r;$*w&s#!p"q= ףp2@Bp#rr+#rW"rr##,p-(\2@p.rW#"0 q~ qqQ+4@qQ2@`qrrr#r;$r'c!"K$q3@$qo$rrqGz2@qC  q= ףp2@q#&&% q!(\2@q"= ףp2@Nq#($W$S# %"#O$.q/3@~ q0# rr"r(\2@$rrrG rK&r q= ף2@<r rr['7)+#g%+O!r(\B2@r&S#rr(\3@~ r;r(\O3@r&%rrW%%S!rJG$r'#?#r/o&0 s6s"rr[$rs 1@Hs r '$%{!$'%sGzT4@sfffff&4@Hsr"#g_${&"rC!!s"(\3@$s#r'+r's(Q0@*s)$rO#rr.s/= ףp3@~ s0f ttc t(\0@$trrC#O t q= ף02@6t r;$"!rwt= ףp3@tY2@6t+$G!r[#+{tGz2@Ht %k"%s$;3&&$r't(Gz0@6t)%W!!rO'"_$0 uuuGz0@Bu&rs#''+rs C!" uGzT3@u%uGzT1@~ u ufffff0@~ u!u3@uw'Su(\1@uGzT2@u(\2@xu;"&%r!";!'s  +/!.u/Y2@~ u0C) vlv!!rr#r# #r#c!$%r!vQ3@vfffff&2@*v{#{"Srrv(\O2@vC!g S'"%r+#$rGr_#k!" &o! r0 wlw rr r!r#$#!K%?wQk3@w+O&wq= ףp4@w;r%w(\2@w+w= ףp=3@~w$&#$s's$!rw!"k r3!$0 xrx3!orrO r"r!G#k$S #+WrxGz3@lxrr/ ##g#r#W#W%$x%0@Hx&!"%c$O"rrk$0 yy!yGz1@yrrVr/ r#+#${ r3 rWrry(\2@yk K$yffffff4@yrr y!(\2@y"s$"$y%(\1@Hy&"${"+!$!"[%0 zTz r' rG '$ & zfffff&4@zS#z= ףp1@z3@z$z(\3@Nzrrwg!k +&r$!z"q= ף2@z#)r$z%(\O1@z&c##'z(GzT0@6z)"!'?& %0 {6{o rrkr({ Gz3@*{ rrr$s!%{(\O1@{+ {Gz2@0{k%!rk!O3{(\B4@<{3#w _)$)r${%= ףp=1@{&"o#'{(0@{)C"##$,{-1@{." +#0 ||G!Orr"r$ r"$+ 'O r' !3(rG+|q= ףp4@$|{$!)W$ |!GzT2@|"o $$|%= ףp=1@H|&O!$w%w% r7rg!#&0 }$} Jrr}GzT3@Z}r#"r#"" s&#}= ףp}3@}Kr}Q2@0}? ##7'r }!0@`}"Or/%gs G$;&'&K"#"#0 ~~7W!$r r;!&&o%"!&[/ Gw)Krrk!~q= ףp4@H~7% /$g$OK%%k r'~(Q+1@~)"%/"r,~-1@~.K###0 _!Q+2@`O#rr!r&W"#[#%sw3Y1@*3#r+&ffffff2@0 %'g$c#!"q= ף2@Z#r$$'"!?"r[!'s%01,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1, `/O 7c$r!rrrr!k&s _$q= ף3@~ Cq= ף3@ "Gz4@ "$!(\B3@r '!rr" ?$o&r3 G$# '+ _",-1@.r C%0 67! #rrr (\3@* rrZ& r(\3@S$""r" /"c%r$!k3(rO r&#% r# r0 $s!!r(\3@rrr?rr!${!rS!r S!r(\3@H+ #!&r%%rO#$%1@H&g!$!"!rr?#0 wK"(\3@$rr{!rr q= ף2@ rr"r Q+4@~ rGz4@Y1@0k +$!"rrGz4@GzT2@B"'((&7% &%$%q= ף02@0&#nkK'w%!r,-Q+2@.r [(0 /"q= ף03@Nk%r r%rr )' r= ףp}3@= ףp0@~ s(\B1@*W#3!!r(Q1@0#(s&$#%[!!"q= ף2@Z#r$k!%#&!3#3&'0 S (\2@`%rrr_C#%#r $;"(\1@$S% r?#Gz2@ffffff2@(\B4@N#[%'#Z/'$$!r'((\0@6)3#!G"'r W%0 "rrSrrr*&rg!r"{# rr# (\2@Gz4@l!/%r$"r_%+ s&S%rrr,-(\1@.% #0 6      !"#$%&'()*+,-./0123456789:;<=>?@ABCDEFGHIJKLMNOPQRSTUVWXYZ[\]^_`abcdefghijklmnopqrstuvwxyz{|}~%%rG $r = ףp3@f '(w#r!& or;& rr! Y4@0! rrrr !"fffff2@Z#r&${&!$"&rw!%0 r[#K rr"rr{"r&#(K"c&!!(\3@~ r= ףp=4@Nrrr3 '  ro'r#rs#!"(\3@#r$$%(\3@0&!r!K''$_',-Gz3@.r!$0 $k!$r= ףp=4@rr = ףp2@0 rr!&O&!Q0@fs#c"3 rW%7 !&rW#O$!"3@#C(&$%Q1@<&#"r!$!rr./Y3@~ 0K" 6?K"rr #r q= ף3@0 r+#%$!r (\1@~ !(\2@'7 %rs$!K{ r+rG$r?#G%rs [($rjrWr!'0 r[3"?rrrr7&%r$"'or(\3@Zg$/'r#{ c#G%(K%O&!"Gz2@$#rC")r'((\1@6)%r#Ww& #0 $c";#rQk4@rr = ףp2@* _()#(G rQ+4@;[%k+"r"k_+!%#&'"#$c(K'{rr+%$!rO($0 f"rr# r!K!rG$rr!{'= ףp=2@6c c" rr_q= ף03@~  4@")W#( !(\3@"%{$$%(\1@H&7$'"r$&K%!g%0  !$r'rrr);"%? rg3+#!r#(\3@$$S&'{%" !Gz1@H"N&S&"r7#w"G#r,-= ףp}1@.r3 r0 l>!%r!rrrrO!r $7c (\3@6[$rrGc3@!_$&#r'#r#{;&o$o!$;!rOr+ "0 q= ף1@ZrrKrrrG$G!#7%3(\2@Z'#Wr(SR#'$!$ !Y2@`"rr'"r" r"r0 !r(rrrc%G!$/rg[!r%3@Zrr%'K%"%%GG(r$%(\1@0&r#/"r$,-= ףp0@.$!%0 /"Qk2@B%r+!r!r&'!% 3@rw k##"rrG!Z'"r#r%/$('(Gz0@6)"+ ?!"C%!{#0  Gz1@Nrr#r"r)7$$&(\3@~ Y4@fffff&1@$#!r*= ףp2@~ q= ףp3@<r['O'"r&#$%= ףp}1@&"r'(1@6)!"_!rr'0 Wfffff&2@$"rS!r^ (\2@N O'r {"!&g3#!q= ף03@r&(\2@= ףp}1@ffffff3@ G%$%r$"!$r7 '#$r7r $0 T!+"r%r!r"G!r (\O4@Br r'!r)2@Q1@Gz3@l"&(r &G"s&$Ko!rG$#3#r,-q= ף2@~ .+&/Y4@~ 0% [O"(\1@$rrrr GzT3@* rG&[$&srq= ף3@6o"J"o"r_&(\2@Gz1@= ףp3@<V/'%3""!3rr$%1@H& rOk$r"rc% #0 f rrO#r?"$r#!r!'&4@rrrr3[ r&r?$rs#{'_" !&/#!"!,-(\B2@.%#r0 ~ fffff&4@fffff&3@lrrG!rrr/%"g' 3$?r(\3@$rrY4@*#'r3$r"!"q= ף02@$#)%Zr'(fffff1@)!W%*r,-(\1@./&#G$0 6 rrO!r" (\3@` _(k$ &rwk!'rg#r(fffff&4@6{g#rc'C#r$!"fffff&2@#rr$%Gz1@H& r'G$##rr!C$0 ~ Gz3@*rr rr q= ףp3@6 r3$ r#{q= ף3@= ףp}1@0#! rr7(\4@<!c%rW"w%"J7'$$%Gz1@&; o%'(q= ף0@6)r%rr&3!0 l!Nrr!r7 r(#W#K s'Qk4@#4@No! %r;"K&r["r !"fffff1@$#{$%!C#'(q= ף01@6)#"o rr!#0 ` !rr r#;r%#%rGz3@f/# ";#r%%S'($$ != ףp3@"= ףp=2@$#rg"S$r'((\1@6)"#!r%+'0 67!rr'!r  Q+3@ r$!$ 3@HrG K" % g rr[(\1@0 ("%?$r?!!"Qk2@B#*!F _%" S#r,-= ףp1@.s& #0 T:!rr{ r "rr!$ GzT4@~ r2@(\B2@~ s2@*?%Cr?(O= ףp}1@0r/#g%r) !"(\B2@Z#C&###r[!"r"?r"g$0 0#rrrq= ףp4@f #rW#! (k(G"$"rW'GzT2@~ fffff&4@$%rr$r !Gz4@"fffff&2@#'##$%(\1@&r7&'((\1@)""/ r,-q= ףp1@.[#"/$01,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1, 7q= ף1@rr= ףp=4@BrrS#w&O" %[!+&Gz1@x k!37 r(;%%rk#+#r $%= ףp0@$&#s%G# *+(\O3@~ ,r-Q1@.#G #0 #!Gz3@$rrrr (\3@< '( #&r/ (\1@0O%_r%3q= ף04@*r'rW#"!"q= ף2@$#&Z'#!!'(ffffff2@)!$w r,-= ףp1@.o$C#"0 $Wg#rffffff2@Br _$! &'*(\0@~ '!(\1@6"orrGOfffff&4@g#r+" != ףp3@*"Sr{"O7!#'(fffff0@6)%K rr &##0 ~ :3@q= ף01@NC$rrrr$c!#{ r= ףp1@Gz1@~ Qk1@~ rq= ףp3@r{$Q0@0! C$r/#%!"q= ףp2@6#r!r/% *+Q+3@$,r+$!3%0 ~ Gz3@fWr+)3%r{% r;"%S&!/' s#$ffffff1@r"q= ףp3@'rGz3@H &w+rO(rgo?"?!$%1@0&&O! #r,-1@.#"#0 1@Nrr r'!_&O%!"? $= ףp1@~ q= ףp4@?'Q+4@Or)OK!o )r_)r'( 'r s!(,-ffffff1@.&s"0 `S!%r rrN&'##%rfffff3@~r3r/ "r!C r[$r/"rrr$%Y1@H&K"r"%!#r!##0 K7Gz0@s$rq= ף3@r! Q1@0 O#"# '%_GzT0@0#_o"r"3@0W! "#r#* !(\2@"fffff&2@~ #r$Qk4@$%W!K#$)*(\O4@+rr,-= ףp1@~ .!/(\O4@~ 0% T g%r'"rr'r [$ Q3@~ rq= ףp2@(\0@fffff&4@67rrr'(q= ףp4@3$rrrr{r{%s"O%#&S""$0 (\O1@No%rr!"%o&;$ $GzT1@ffffff0@B c"GrGo!3@~"r %"7gr_"Ks&r#!# "+$[ 7%0 sGz2@`r(_#r$ *!' #+& q= ף0@0& {k$r?Gz3@<r[$r&rG% $%Qk1@~ &r'fffff2@$(O"J{!#,-= ףp1@.$"O"0 `w!%rr##O'rgr0@lwro!/"r?' $!/_ rS%/ !"Q+2@Z#rrGw!r$" Or/&0 rr!ro$r'&r/#G"K!'' +W!!#W!$= ףp=4@</&{" [%r&r !(\1@~ " #Q2@~ $3%fffff1@&%++g!)*Gz4@+"#,-GzT3@~ ."/(\3@~ 0+# !3K!r_r?#S rr rkr;  K!rQ+1@$r2@#!'Z%!"GzT2@$#rrR r'(q= ף2@)[#r  ,-(\2@.rrK0 TKG!Grr /rr q= ף3@Tro_rk  [r'rrY0@GzT1@  "!"fffff&1@$#rr$#'(q= ףp2@)#r"+,q= ף03@-rr/0(\B2@ Z!r!g%##rr;$;$rq= ף3@$'rr(\O4@s#[&rkcC#G#[ r#rO$ !rw%rr"_+&/r0 * r!+#q= ף04@0r!/$$ r"= ףp=3@3= ףp1@6'#rK"r+ O"(\3@ffffff4@xr$rC"O K!srr %0 !K_#r%$c!g$r3 rr^ rrq= ף01@`%!#g!W#3%g!rr[%r'(Q2@0)!r! s&?&/0GzT3@ kS%r#7#r$rr#$/#!3#+!r$rQk1@6;#w 7)r3%"#fffff3@$3@%(\1@<&'33'C"r#./Q+3@~ 0r c!r $Or%#!3#+ro!_" O#  rfffff2@0_" !rW'$ !q= ף01@"W""#$(\3@%r&'Q1@(!)*Qk3@+##./= ףp}2@~ 0r *&r{%!Qk2@<;({#%r_#rs!B(\3@B(rw!%rr$"fffff3@6G"rS!"!$%q= ף02@&o;"'(= ףp}1@~ )*2@*+!r! r0 $C!k "rq= ףp4@lrG%s!&r# r;?r/%3rrGzT1@#!!!+"!rr!W#$"r+#"{rr0 $!;"rGz3@r!  = ףp1@B rr#rr3/"q= ף3@#r(\1@<#K3 $"G !"q= ף1@#rr$%(\3@*&!c%#r+,Qk2@-Gz2@.r#g0 ~ [= ףp=4@!rg##or{"!k&#rW!;3$?!S%rrr3#!##rrr"%&q= ף04@~ '(q= ף2@)?!!rr,-(\4@.{"&0  (\3@r= ףp}2@B{# ? rrK%fffff&0@fr!rr' ( K7 C#s" !"q= ף1@<##rW!&{!rc!+,Gz2@-q= ףp2@.3%V/0(\1@ f r rk!r"r#"c#"q= ף04@6?'$G$ r= ףp2@S#Q3@$r"g$k "#3@~ $%q= ףp2@<&rJrrO ./3@~ 0w) rkr!+# O("$w#O"s"!W!rGz2@~ r4@"& 2@6"k rG"r"#q= ףp3@$W  &&'q= ף2@~ ()Q3@$*+ r[!./Q2@~ 0$ ~ Y3@'&r!!fffff&3@*r?";%$7!r q= ף3@o"!q= ף01@6#%"&'W$ "q= ף03@*$r"r W$"#(\1@$q= ף3@%2@~ &K!'(\B3@(= ףp}1@~ )7*q= ף1@*+r__ w r0 'G r#/"rr?%&+$!'3[!k#S#!r"r= ףp2@= ףp1@0#ro&'!"q= ף04@#g$ r&'(\1@(fffff2@)$#'!r,-Y3@.&C&0 `  k"rr&"r$$r!r#{"q= ף00@(\O4@l!rC!r'$k#"!+o"r#%" "#Gz1@$r'(Y3@~ ) *ffffff4@+rr,-(\B2@~ .#/4@~ 0r `$r$#rk$$&o#ro+!(\O0@rKJ[r$r#rC#7  "{"r#r3k""#= ףp1@H$+ K$GW krr./4@~ 0( #r!"#r{&r '3!rW&7c!rWr;"!!r(\3@K!"= ףp3@r"r^"3"r!# #r./2@~ 0r1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1, $O7!rq= ף03@$" (\2@ ffffff0@6 "rr$g_(Q+2@~ Q2@$r!o!;"Q+4@~ Q2@0+"" /"r$%= ףp=3@0& #'k##S,-q= ף2@.r)/0(\2@ O fffff&3@$!r r{! Gz2@Z s'rr#!'$;r rrQ1@$/WO= ףp}3@r$ (\4@`!7'[%o"$GO"#" r"/0Q+4@ ~ Q+4@ "rrr"7!r&;%&o {"?s!r'G (\3@~ +Qk3@xr& rr$rGk#r rW!G!0 S(\B2@Br$o#'# "r!" Y4@H!  G!"o$/!Q+3@0+"s o)!r?!"1@$#cZr'(fffff1@)#R*+Qk3@$,r r0 W7s"rrK&/$r "rs%'&s(k#r7%r # (# !!#*3## !Gz3@"!7"$%Gz4@~ &r'(\2@(_C$)*(\3@+k#r,-(\O3@.r[ [*0 r3 #!rro#+ $rr#& !3@< ' 'r;;%#?"Y3@?+K%O"3!!"Gz0@#rr$%Gz4@H&ro%#r rr#0 <#'{%7$  Q3@* "&$%wQ+0@~ rQ+2@~ w"fffff2@""!W 7 ;)'![%#(3s#$ !& (0 ~ '(\3@[ r&;$$rrr&O#&/"OrrOr!r= ףp}3@~ "Q3@B/!rr$  !r&'(\O2@((\2@6)"r r0 $c rQk4@rr (\2@H *)W&; $/rr(\3@$!rC#= ףp3@B#W !/% +rr%&(\4@~ 'r(ffffff3@)#"%+,q= ף04@-1@.r$0 = ףp}1@(\O4@$(7%O#;  (\1@B rr&#{%?  2@r)ffffff0@r= ףp=3@!!!"!"Gz1@#rr$%(\3@&O"%'(Q2@0)"rcg$3"/0fffff1@ r'w"r&(3$rrr$+$%_"!O q= ף2@Tr{!r''/#" r$& !(\3@"GR+ $%Qk3@0&r%"r,-(\3@~ .#/2@~ 0w( $G!G r(\4@Brr!rrrr#GzT0@r #rr r%"?+rro  [&r%&'(q= ף2@6)+#r7!sgr)!0  rr/$#r#rw$r"#!ogr r#r"rC"&r_%r !Q+4@"4@$#w%r'(fffff3@) o"c#3",-(\3@.$o'0 ~ = ףp2@Brr!$rrr!+$  Y2@$r r(\2@~ #ffffff4@S!!s&Q+2@0!&%rr !Qk1@*"cr'(= ףp1@)g$!$,-= ףp2@~ .!/(\B2@~ 0% Z# ro)$rk#r$#"Q+4@Qk3@rC Q3@$OrsGk Gz3@#r &/! != ףp0@*"w7 ;_"'((\1@)!s #,-(\2@.c%'r0 f{G /"rr#S!r3"r%%!' [ q= ףp3@x!%! [$ c%rs&rKcS $%Gz3@&"/'(q= ף02@)s#w#,-(\2@.%r0 $wrq= ףp3@rr 3@ = ףp0@6 rrRr>rfffff3@q= ף04@$r(\0@<&C!{{!s#! %!"Q1@#rr$%Gz3@*&rC"r!+,(\2@-Q2@.r$0 WG#g G"r[;$r$rr[!rc rr)#& !!C%"r#rr$%3@$&"*"'*+q= ף3@~ , -(\2@.r&{0 [!q= ףp3@!r(\2@;$%c!rr;rr!grg#7r [ Gz0@$#'$!/(!"(\0@$#rr ('(Y2@)"r ,-Gz1@.S&r/0q= ףp3@ 'S o!rG#/!+o#rr rr ;!r&S#Qk3@r #G!$ ?rr#!'^&o ,-q= ף1@.c&_#0 +$W["ro r! rr r{w% "rrr(\O4@0k!#o+s$'!!"(\1@T#rr!$+);O"r##/ r!/0fffff&3@ NWK rw#"[!rr'#g"  (\O4@$rK! (\2@$r G##c#= ףp2@T"!+r!7 r&'ffffff1@$(% ?$r,-= ףp}3@.{$G)0 ~ r%'&#rr)S(!#&'! Wr= ףp}3@#"?#o%= ףp3@O"1@$C &"%!"q= ף01@$#3#cr'(Gz2@6)%! r#'0 Z' r$% rk$rG% W"(\2@B r7r!r#W$K (\2@(\4@Q+2@Ns!r%#3c r()(\B4@0*7rr ${r0 ~ fffff3@0 rw/%r  Gz3@ # rr 3@N#r#3"O$C%[ = ףp3@~ = ףp1@0 #k rr$%(\2@&r'((\1@);&rk+,fffff2@-%{"/04@  $;!O +(= ףp}3@<#' rr; &(\B0@0@~ rGz3@<'!rrr!"Gz3@B{!%&)wrr3"+&'(q= ף2@6)#r!r+$s0  ZK{7rk'#!%!rro!&$= ףp=4@K"#q= ף2@`r C%$r#k{'r#g""#Q+2@~ $%Gz1@0&rK{ rrr,-fffff&2@~ .!/Gz3@~ 0r  ~ (\O3@S)rfc$ rrrK("r!7 NorS!"&n[+"&3%rr[#!3! r#[&#w"wr0  *_rrG(!(\B4@Brrr("r#Y2@{r"o#r*[)'G#!(r#% ! o! 3$rr,-q= ף2@.rCO'0  ZC r$/# #rrr%+!3##= ףp3@~ Wffffff4@frr!!!rk#W"rK#&7!"(\3@#= ףp=2@$Kgr&'fffff&1@<(/$r"$'#&r0 63! r{rr = ףp=2@Z 'rr? ##rr;!rr= ףp0@~ 3#= ףp2@l"W"r;&"rr$r#r'&+,= ףp3@-C%C% 0 != ףp}2@fffff3@$rJ%+"  Q1@B  '(r7* or#  (\2@N #%O'  ##!"Gz1@#rr$%(\2@*&7 w%/$'$+,fffff1@-rw"/0q= ף2@1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1, </o{r#r  Gz2@ '!rr GzT3@&r# W&#?'&' [!!r rrW#'((\B2@6)#!r +0 f_"rg)!3%{"W$r'+ Or?W(\O4@6rr ; 3(rQ0@<C#S  rrs#$Q2@6%cr$"r7&,-Qk2@.#r0 rW G$rs$rW#rr!#3_rQ2@rG rrq= ףp2@xr$? 7#S&'$W%rr#%#r"+,fffff&4@-q= ף1@.!r0 3!= ףp3@o rGz2@l$%[)rr$Wgr&+!rq= ף2@r4@*K##k#!O !"Gz1@Z#rr_+"%S$r[##$C# 0  'Gz2@rr" r#'G%g ';$  rrk"!%rG/#(\4@;rrr !Qk2@"Gz3@#$%(\2@&rO#'(q= ף2@6)?!G$/"rw# r0 ~ Kq= ףp3@!r#$c $g$r?(g$3!!! &c!rr{Qk1@O!"Gz3@r r'!"fffff3@#'$%Q1@H&r"r#"#r0 ~ q= ף3@N%r%$rG%&K$!r= ףp=4@Q1@Zr#rrrw&"s"/g r[$$%!"(\3@0#7"Ss$RG)*= ףp3@+/$r,-q= ף03@.W  r0 6/# "rrr Gz3@* _'rr; r0@(\0@Br r+%r# w!(\1@~C)$C%%rr  ( G!r#[ rr 0 { Q0@r= ףp2@o$w"  Gz0@ {r' Qk3@rr_ !g#r%! 3gr"VS /rrrr'(Q1@)O"r!+,fffff&3@-rr/0Q0@ 6 # rC#  (\1@ Y1@6 rrro3W%q= ף03@~  (\2@Br$' #!/# q= ףp3@0!kr&S##%'(1@)C"#?#+,= ףp=2@-Gz2@.$#$c0 Kfffff&3@r($r"r(7"$O& Ckg$rS!!rrq= ףp2@<w$"!&r{ cC "#(\B4@$#r&'Q1@(= ףp=3@*)$$rr["./(\B3@~ 0r &rr"{%G%rr{%%#  /r+!$$O' +"7!%r&r""$%q= ף2@0&r?#3"$rr,-= ףp2@.! r0 *wrk("Gz4@rrr&  Gz3@ fffff3@Nw'sW"$r[#rg!k&(\1@~ !Y2@0rrr;W K#$= ףp2@%r'(q= ף02@~ )"*(\O3@+w#",-GzT1@.Q+3@/= ףp}1@~ 0r 3 _(\3@$(S'!  (\O2@f KK%r "3$/  S$rro!Gz3@~ /(\O2@r !'*!"(\1@$#rr_#O&'((\3@0)K%r&r$/0(\2@ Z r[%C#!rrr''r3@Bc##r$!rrffffff1@~ !GzT4@(\B3@r"# !2@~ "{#Q3@$r&'(\0@<(oW"rr{"#rr0 ~ fffff3@g r3@"r  Gz1@B ;'rrr[['&w#3@$rro#${ffffff3@_!{%r C%rr$#"rG$#O& 0  $_+ 7$rGz3@#r q= ף2@H _# %r rr[!Gz3@$(GzT1@c!{q= ף3@2@f{#'#(#o!Gro& %' %% ),-(\2@.r" 0 !~r(/(%rrr/!!r?$$KC$c#= ףp3@r"+'fffff3@6' ";"#rr%G$!"(\3@~ #["$= ףp}3@%s%&'GzT2@(q= ףp3@)"# $O%,-2@.$%r0 "62W rrCr! (\3@ Q1@ #G# = ףp3@<c&r 3#%Q+0@6(!swrW"* !(\4@"(\0@#rr$%(\2@*&rg&J;"r!+,(\B3@-r"/ 0 #&s+#rr$rrrrK+$K%c%rr/3$ c%rK%g%#&jrr"c%$?rWc!"rrrro '0 $`!#S$rrrK;!rr{ r(\0@(\0@xrO ##{G#r(!{"GO&rK!rCrr$%Gz4@H&!$ rr"##K!0 %C!Q3@l"rKrr+G!rr rrG !GzT4@`rr?r SrO%r'#rr$%Q3@&"r'(q= ף3@0)!r! &W&/0fffff&4@ &Zfr%rrrrC%"![*Q3@S!fffff3@0$C#! #r"(\4@&oGzT4@*r"r #$Gz4@$%/r?$s!)*(\4@*+?$r;#!r0 ' ?r#%%# rro$Gr k#'rc&= ףp3@$#/%C% != ףp3@"rr%&Q3@*'rO"r(k ,-Q1@.r'{ 0 (Zk!# r#[$O{"''rr%r$Y4@x!$#$r/#(r!G# r "#w#""#Qk2@$  r#'(Gz4@6)_rr+"O G*0 )${"S!rGz4@lrr#*rr{"r'g#{"r#rGzT2@r{$ Y1@3@{' r !Gz4@"q= ף2@$#rr $&'(Qk3@6)rr""7&$!0 *~ Wq= ףp4@C"rO$;#3"r{&%r/"r  !rw"#rrs#; q= ף3@r#r!"= ףp2@Z#O!Gr7{ "rrrGk$r0 +62O !)rr Q2@ (\1@ (\4@ rrr'r3$Krrc#!G!{r!!'rS?#k!#$C"3r'$0 ,Vfffff2@rrq= ף2@xr!CJ!7#rw!s%k%!G#r!Q2@~ !Q0@(\4@w*O!'$ !2@"(\1@#rr$%Q3@&%r'((\2@6) %r3;(g w$0 -fk!!rr#r  r# rQ+0@Br+ #_!W%%""ffffff1@$kr&rr!"(\O2@#rr$%q= ף3@H&r!!r!!r#?"0 ._"fffff3@rr" (\B3@< S rrrc"= ףp1@~ C#Q3@rr{"$? s!?*rW#r% G!%'(q= ףp2@)$r"!,-0@.&s$0 /O"q= ף01@ r(\4@r k  1@ #$rorr)#r"!!Wr !(\O3@*"Crr+ r'(= ףp}2@6);%rZ!#g'$01,1,1,1,1,1,1,1,1, 1, 1, 1, 1, 1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1, 0~3!#O( rG)#3K#rr;rGW"!"Q+4@*rr$W = ףp}0@6rrC"O"rr$%Y4@H&r$3$r3" Wr"o0 13@r)#rr&r'# r{ #!o%cr7"r;_' "W+r_' != ףp=2@T"_; r!s$O#o!./q= ף3@~ 0r 26S$!r&r Q3@ fffff3@* _%rr &?q= ף0@fr!r ##rK# $s "r"+ !"fffff2@Z#rr C$?%s! rr!r;*#0 3<6'"sk$r;r#  ffffff3@6 3#rr r+WrGzT4@~ G$(\3@$rrGr Gz4@B+O&r#rrr!r#!G%r #r)0 4r"rrNrr'rr rgS#ffffff3@Z7$o%rgr# !r"g$!!"Gz1@Z#rrS W"%"r"!r{$"0 5 ' rrr{rrrrwr w"3rrGzT0@~ rq= ף04@Y3@~  q= ף02@B!r K"rrG r'(= ףp=3@6)'#r#"r% 0 6Q^(@= ףp]3@3@r'ףp= 6@= ףp4@\(7@ 'r  \(4@ !g" ףp= w7@4@Q1@~  Gz4@{G1@rp= C3@rQ5@_!rq= ף6@ ,9@!= ףp1@~ "o#Q4@$l3@%q= ף0@&Hz8@~ '[(1@)S$" +,p= 6@-R1@.fffffF4@/G!'0 7Gzn%@Q3@$or?%= ףp6@ fffff0@~   Hz3@ fffffF6@ {& )\(-@~ o%p= ׃1@~ 1@{G7@~ + Gz0@~ $= ףp2@\(<2@SHz6@(\b4@ Gz4@!R1@"p= 0@~ #r$(\o6@~ %&5@'\(8@(Q0@)$rG+,R2@-p= 2@.333335@~ /3&0Hz0@ 8~  ףp=5@*{"rr" Qk2@ p= 2@*  rr r_Gz/@q= ף6@ףp= 4@~ C!(\2@rrSrףp= 3@Offfff2@Gz6@= ףp6@~  [%!Q4@"= ףp1@#rr$%Hz2@~ &!'\(9@(2@))\5@~ *r+,5@,= ףp3@-3@.rr/0{G2@ 9~   ףp=j4@ R2@ rG(! Gz6@$ "&r$$   R7@~ ?% Q5@ zG1@ r ףp= w4@~ r {G5@ ףp= 6@ (\o5@~ r Hzg6@ = ףp2@~   QK3@ Q5@ rrr ! "(\3@B #g" r+c#k!r!, -q= ף3@ .Q5@ /fffff5@ 0Qe9@ : " R5@~ r (\8@ = ףp5@B !rrr$%r'"# (\3@ "r 4@$ !!rr7! ףp= 7@ 96@ g!r+!$  !ףp= w3@ " ## $5@ %Qk2@ &rK' (333333@ )"#o &, -ףp= 3@ .$rr0 ;~ / fffff5@ (\2@ p= 4@~ r (\O3@ _&7"  \(1@~  #  Q7@*  rr r Hz7@ (\2@~ r Q%3@ p= C5@~ r `2@ Q>7@~   Gz3@~  q= ףP2@ & r  !Q>3@ "+rr$ %Gz2@ &= ףp5@~ 'r (zG2@ );"%* +Rq4@~ ,'! -Gz2@ .Gzt7@~ /W# 0(\"5@ < Hz*@ R16@ C !r 33333S4@ $r  q= ף4@  p= 4@  W)rr  )\5@ rr q= ףp3@ Gz7@ 3@ k r p= ׃8@ s! (\"3@ {G4@ 'r#  !y3@ "Q3@ #rr$ %R2@ &c&r' (33333S3@~ )w" *6@ +{G4@ , ףp=j5@ -Rq3@ .r%{"0 = Q^'@ (\"7@ \(<2@  ףp=3@~ r Gz4@~ r {G5@  O3"   ̬8@~  r Gz5@* rr# )\H3@ Q%6@~ % l1@ ro (\O0@ G% = ףp]7@~  # !(\3@ "Gz1@ #rr$ %R3@ &r+#( ))\H5@~ *r +3@$ ,K GS%%30 >Q+(@\(5@'r(\3@%c# ffffff2@ q= ף0@~    7@~  rq= ף4@ ףp=*:@q= ף0@.@rSrGz2@,7@~ %Q1@rw 4@0@Gz2@Gz4@q= ף7@ Q5@~ !!"zG2@#rr$%2@&(\4@'r()Hz5@*r ,-q= ף2@.Gz8@/rW0 ?C+ (\4@~ r{GZ:@)\4@*&rrr&%  p= 7@~ r{G5@Q1@#+"r(\•5@~ r)\4@~  )fffff3@q= ףP3@q= ף6@$ ('C#r !\(3@"{G3@#ףp= 75@$3@% ףp=j2@~ &r'Hzg3@( &)*\(7@*+r!%!r0 @(\µ)@0$!%rrC# Gz3@ 0@$ $rr!r(\0@fffff&0@~ rQ%5@Hz'7@fffffF4@rr,4@rr!333331@92@R14@)\H7@~  r!6@"Gzt3@#rr$%fffffF4@$&rr+"r*+)\6@,333334@-ףp= 3@.Hz'8@/r0 A~ WQ4@~ G$q= ףP5@~ rHz3@r' 2@ p= 2@* '%rr!rKfffff&0@~ r,5@Rq7@(\3@Q5@$rCrrg (\B1@3@~ 9@ b!!"= ףp=4@#rr%&Q5@'k(()= ףp5@0*ro"rr0 BY,@~  fffff5@~ rzGA8@Hz5@)\H8@0r&r$!3%K&4@Gz41@Q4@~ !(\2@*r!rrrK!ףp= 3@"r(\6@rrG% !5@"Q~6@~ #$= ףp]4@%fffff2@~ &r'= ףp}2@~ ( ))\6@*7%r+,zG6@-;"#%0 C~ 7(\b4@)\7@r$\(4@rrr  {G9@ Q>7@~  r y;@~ s#= ףp]5@33333S0@\(|4@(\O3@q= ף6@~ r ףp=j5@~ G&GzN5@rs!Gz3@~ $p= 6@/$rW+ Q8@!p= 5@"p= C4@#G$%̬2@~ &r'Gz3@(fffff4@)+"rr!,-3@.zG5@/? r0 DY,@q= ף04@zG4@rrHz5@)\:@ ףp=8@ rrr  (\o7@ (\5@r!= ףp=1@%rHz'7@fffff8@$!#S"r3#zGA3@Q6@~  Q5@(\@&r !(\3@"{G5@#ףp= 5@$(\3@%{r'(R15@*)"rr{"g#./zGA6@~ 0r E ףp= 3@$!rr$ 2@ q= ף2@ (\•5@ rr fffff4@~ rl0@(\0@rK \(|7@(\3@K&r= ףp1@r#5@~ '(\3@~ !Q6@ "r!")\2@#rr$% ףp=j3@&Q4@'Hz'8@(`3@)Q6@~ *r+= ףp4@~ ,# -(\3@.33333S9@~ /r0(\b2@ F ףp=*@~ !(\b4@{G6@rO rr = ףp3@ (\o2@ {G6@ rr!rHz'1@Sr(\4@~ rQK4@rr(\"2@rbGzt4@~ 'q= ףP4@fffff6@~ r Q7@!Gz4@"r;%$%\(3@&5@~ '&({GZ4@)Zr +,Q6@-ףp= 3@.rr{!0 Gp= *@\(7@~ w{G5@r+ $r zG3@ Gz1@$ !rr!r333331@'rGzt5@ro##rR1@rr!Gz0@\(3@Q5@r""!"(\3@#rrc 3$&'= ףp;@(Q4@)!rr",-3@.rr/0(\6@ HQ)@~ $(\U4@R5@$rr!?  q= ף02@ R5@ rr  ףp=4@rQ+0@~ rQ5@?$r)(\0@~ rGzt5@Q4@R10@= ףp]4@ r  7@!#krr$%Q3@&Q5@'r ()p= ׃7@~ *r+(\7@,g#wrr/0(\3@ I!Q 7@~ rHz3@Gz7@~ r l3@ _#[!&r QK6@)\9@= ףp}1@QX1@(\3@333333@~ o&Hz4@Gzt5@Rq7@ ףp=2@~ #Hz3@(\U5@fffff2@Q7@b%" ! ףp=*3@"(\3@#K(r[r&'= ףp3@(fffff3@)/#%*+6@~ ,"-33333S4@~ .Z/Gz7@~ 0& JQE-@r* ףp=5@%g# (\/9@ rG*  Hzg6@ 333334@~ rp= 7@~ ףp= 74@"!r)\5@96@$G!'#G #(\3@Q6@~ r 9@~  r!)\3@"ףp= 5@#Gzt5@$\(4@%3@&r() ףp=j7@*jr+,\(<5@-= ףp4@.K!!r0 KzG!*@6S#!"r G'r_  ffffff2@ Hzg7@ rr"r(\"1@r3zG6@Q3@̬5@~ r333332@~ rl6@R14@zG1@(\4@q= ף04@Hzg7@ fffff4@!q= ף8@"R3@#r#%$%(\"3@&rr'( ףp=5@)(\•6@~ *r+Q5@,Q5@-= ףp4@.33333S8@/'#0 L6k/!rrr7*r 3@ r!(r"#s#%+!rrw%W (&ro!&"#Gz2@$$?*'(= ףp1@6) #"S W!#r0 M6G%w S$rr3! q= ף2@ _rrorW$!  rrrr%W%'$rKrr%r)W#rr+rr/0Qk2@ N`W&$&#rrrrr!r(\1@6O!$r7%# "rrQ+4@Q3@Bg%rrr#r3r$%Gz2@H&r/%& %[ r$?)0 Or{g rrr$w r_rw)rr? "_(\2@*rV!O"7&rfffff3@T%w$rG)r$rrrNg)'(= ףp1@)Qk4@*o%+',-ffffff4@.r'r0 1,!1,"1,#1,$1,%1,&1,'1,(1,)1,*1,+1,,1,-1,.1,/1,01,11,21,31,41,51,61,71,81,91,:1,;1,<1,=1,>1,?1, P rrr "rWK&c$k%rG$ ro r? g"#S# rrr&7( " #2@~ $# %q= ףp2@ &(\O3@B '?$G${&!"r0 !QN!  r$"rrrr'+" ! 4@!r!r$ [!;#r# [%r{!r"r+r7rs&r#w&; _##0 "R*"7 rrr'"Gz3@6"r r%&r;$"Gz0@r"_#r"r$r'C#(r)r'#)W""#= ףp}3@"$r{%"&(\3@"'#{(")q= ף04@0"*!%!c!#r0 #S#G%#3@l#{!rW r#_# rrg$'r!!#(\3@N# r{rr%s#rK'!#"q= ף3@Z##rr;%"+_%r$!rr{0 $T6$S rrr%"r$ fffff2@*$ r+rr!$$GzT0@$ 'g$%"{#)%O$'$rrr#rK K'# #{ r#$&r0 %U<%${ ##rr$ % (\3@% q= ףp4@% rr r%GzT1@%Gz1@%r"f%3@%[&r+r%7&;!+#G$_rr%$*'"rrg +&r/%0= ףp}3@ &V*&!rrr$&q= ףp4@&rr_%%r#owGrC"r'r3%G#!'*rw&3%/""&#q= ףp3@&$rNr'&(= ףp}2@6&)"7!$C% !$r0 'Wf'S/$g#r"r#K #rr r'Gz1@'r{"!$rs"ro#? r&{&"rr"_#r''((\3@0')&r %K#rr/'0= ףp=3@ (X&(C rrr#!r$r'rr%!K rK!rrr%#r7&r$s#%"{#wbo$S${# &r0 )YT)$$r{"rr["rr )Y4@T)rkr!$g rr$r$)0@)(\2@)"#rr!)"Gz3@Z)#rrr"rO"%g o!_rr 0 *Z$*S" {$r*fffff&4@*rr3  !rrrr "rrr+%_$*ffffff0@~ *{*(\O4@<*c#"r rr# r'*(Q+3@6*)"r[#/$rr 0 +[&+/'&r{ r["srrrWrr3 w #!rr'$$ssG r#(rr'rc&?"rrw Orr0 ,\<,&g"ro"rr , Q1@*, "rr ro,(\1@B,rG#%k &r7r"k$,Gz0@$,!r"$!,"= ףp3@$,#rr"7!%',((\2@,)#r"s,,-Q+3@,.rr#0 -]f-w$g"rw"%"o rrr[-(\B1@-rw"-fffff3@-rr'7&%VG%G$rrr!"r##rK!!;rS&0 .^`.#go(r '#!rrO 3(.q= ף00@.r"$.= ףp3@N.rrg%r"{!%&r!."fffff&4@Z.#rr?&_"rR#r "rr0 /_6/"rrr"/ fffff&3@Z/ {#rr' rrS#$"r/Y2@/rr# &[&'!$rr{"r* %rk$!rr0 0`0# rr$"W r rr'&?&{# %#W%#rr!g'o!%?%rr# s$k('0(q= ףp2@0) r$,0-Y4@0. ##&0 1a1Gz0@H1k !r$_#%rrr&## 1 fffff&3@1#1Qk0@<1 ! r%!O!W*&_1q= ףp2@T1%$#r+r_bWr'1(Q2@61)##rr(c!')0 2b~ 22= ףp=4@N2W"r!#%rrrr"Cr2Gz4@~ 22q= ף3@62rrr"+"rrw2(\O2@*2%r?#rr% 2!Gz2@*2"rrw'2(Q2@62)#&rr% r0 3c3K%s"ro /&?#Zrr rr('rSrG'c%3Gz2@3 r#r!3"4@Z3#rr%K"r#r%C# r%K0 4d647&#r"rr4 (\B2@*4 'rr "4fffff0@4q= ף0@4rs r4q= ף04@4rrJ^? ;$ O'_!"/ rr ![* w$rrk"rG% 0 5el5!rrr"r"+(#rrs _ ' 5fffff&0@5GzT2@`5r$""$&g+$"rrrr%; "5#= ףp2@~ 5$%5%ffffff4@H5&'  !!'r!%r0 6f66'S#o"r r!6 Q2@06 !rr rc6(\B0@6r g"r $ $;$/ s'#rw rr+%#rN$rr ,6-2@6.rr/60= ףp1@ 7g7G%7(\B1@*7_$r r{" 7 1@B7 wrr7 bCr+%s"7q= ף3@7rr7(\0@$7rr"7= ףp2@7O&+'r!7"= ףp=3@$7#rrr"''7(Gz3@07)3#rs"!rO+/701@ 8hx8k"w$rg r? O!_rr;{%r 8(\B4@8"r&rc#WS#(&&S rr${ r#r"!r%0 9iT9cG$rr_"# !O'r 9q= ףp4@~ 9r9(\0@9Gr!!"rr#$w %rK#r{%rrr%r'9(= ףp=4@09)"rr&'rr/90q= ףp4@ :j~:##r"roS?%r_*sr)Z:Gz3@:s!rrrg#Or&r!rr#'r#rc%C$rr/:0(\2@ ;k<;'7#rk ro%C ; (\0@; Q3@$; rr{!rw;0@N;rr#$rr &#J;q= ףp3@Z;"rr rr+&%&W!rg',;-Q3@;.rrc0 <l<#3&{7%r!rr{+ rr rr#"rr<Gz1@<r'!$o%7"'7"rr#$K#r!rC&"grrC0 =m`=W#)rr%rr;!$rr&r=fffff0@=(\2@=rr$3#r[rr(  &$)%rr%rrr#rC'&+ rr 0 >n6>'3$w r3 rW> Gz2@> rr >Gz3@Z>rr! $rro!!>GzT1@B>K$$rrr%!)'>((\2@6>)#rc%rr0 ?o?g#?Gz2@l?[ r $ grr%>rg! ?q= ף03@r?rrr&w#w+rr# rr[# *'?(fffff&2@?)rr$+?,fffff3@?-q= ף2@?.rr0@1,A1,B1,C1,D1,E1,F1,G1,H1,I1,J1,K1,L1,M1,N1,O1,P1,Q1,R1,S1,T1,U1,V1,W1,X1,Y1,Z1,[1,\1,]1,^1,_1, @p@"@fffff1@$@#r r!@ (\3@*@ 3 rr3 r@fffff&0@0@r$s!g!r@= ףp}0@@)C'#@GzT2@@[ r$&!@"Q3@Z@#rrG&#r$r""rr+0 AqA#$w!rKrw&S rrrKwr  !O$r;ro#W#KAffffff2@AGzT3@<A%'#r7!rr')'A(2@A)!r{ ",A-Gz2@A.rr0 BrB?##B(\2@$B"rr#B Y3@B  rr Bffffff4@BrBQ0@*Br O #rBGz0@B#!!k {'r'rr+$"o&g$r!  r+0 CsNC'"r 3"rrrr* C (\3@NC?*;' r% rrr CQ0@0C%& #rrrJ!C"Q2@ZC#'s rG/!!)rro$0 DtTD_S!#rro"w#r r'w'r DQ3@D!D4@D7$#c% !$#[#C$rrrG%['&r C"!rr!)(0 EuEw EY3@$Err!g#rE q= ף2@<E rr!r'W"EQ+3@ZEr_ G!?#W s#G!C" &r#"!E"Qk4@ZE#?%Wo!3$s$r !O$r0 FvfF!rrr+#O rrrr$rk! wF(\3@xFr$rrrr"/#%'rrr[%_#O#$F%(\4@F&  'F((\2@6F) r#!W"#'&0 Gw&GW"g &rs!rr!"%r rr$#? ?#r3#%# #)K$ +rr#C$r ;$r!# rrW 0 HxH/!#$rrw! /_rrrW;r#'#W#o&;r&$H= ףp}2@HGzT3@xH/"r#!rr{"#$k r"W"7 r&/ 0 Iy~I&"r;!r; !rr? r3r""Iffffff3@rIrrr%"+Kr$S#w rr%%/&'I(q= ף3@I)$rrS ,I-(\3@I.rr/I0(\1@ JzJS$J(\2@$J rrrJ Qk3@J / rr J= ףp=4@JrJ0@Jr w!#rrr#3rrrO rr"C#rS"rr!,J-ffffff4@J.rr/J0Q+1@ K{6K"!r"rg K Q2@K rr KGzT4@*KO$;rg! K3@KrrK(\0@$K($O"Kfffff2@Krrr!K"Q3@$K#rrS'!r'K((\3@K)&r_#+K,(\4@K-s rr0 L|<L%3 r[!r! L (\0@L (\B3@$L rrrL(\0@Lr" LQ+3@6LO"r rr!7oLq= ף3@Lo$"r!L"(\2@$L#rr' r'L((\2@6L)%&S"_rr0 M}<Ms#r!$r M = ףp1@M rr M(\3@<MrSrrrMQ+0@TMr !7#[ 3&_rr#%M&q= ף2@BM''#rc rr0 N~<N'"!rRrr N fffff3@TN Vrr3r'r "srrN= ףp}0@xN?&{!3"#"r#G&rrs$ rZr+N,ffffff3@N-O&r0 OTO"; W )'w*!{3rr O3@O%Cr"" r &^S!!$C"s'krr &'O(= ףp1@6O)!r r'0 P~ P[P4@Prrr&Pfffff3@PrW!rrrr 3! KrS!rrrr!3"$(("?% "'["3"[#O& "#S)0 QrQ$"r/!rrK  "rr"#'crQ(\4@~ Q"Q(\O4@QrrQQk1@QG%c "QGz0@HQ!{&#[(grr  r'Q(fffff2@0Q)W!r [!;rW&/Q02@ R~ RoRQk4@fRrrr{&!r$r?+rr  ;S"SRGz2@*Rr!r(r;'RY3@6Rw""'")r#$"R#Y3@~ R$!R%Q3@R&Qk4@~ R'#R(ffffff2@R)q= ף2@0R*rrS !S K$0 S~ SSGzT4@ZSrr"k#C#r!&rr%# SQ2@xS r k#r$r #$$rr#K' g"$S%= ףp=3@S&"'S(q= ףp2@S)fffff3@0S*#g%$ ';!G'0 TxTOk! r{r$CrrCrrT(\O4@<TrrWrS!/!CTfffff&3@T"#(!T"2@$T#rrg#/ $'T(q= ף02@T)#$rO$ ,T-q= ףp3@T.r%0 U<U'#"r r  U GzT0@U Grr U(\2@`UrGr%S rro%  WU= ףp2@rU$;%rorr'$#%) r rr0 VxV"/#r_!(  rrk rr!V(\B4@VQ3@VrrVq= ף0@$Vr!"Vfffff&4@lVs#[&'rr$ rG!r[ 3 # r#/V0= ףp=1@ WfWCw" r!rK!rrrcW0@*Wrg!O$rW= ףp=0@xWr&w#S[ #c!&+rr% !r#k!r"+W,= ףp=4@W-r$0 XBX! !'r! X fffff&4@<X rr+ r rc!Xfffff3@0X%rr#;#X= ףp1@X= ףp=4@X{%"$!X"GzT3@<X#rr'o r"r +X,Y4@X-r&#0 Y<Yw  rr! Y (\1@TY k!S%rKr?r r_C"rY(\4@Y'S""Yq= ף01@Y(\2@Y"! Y!(\3@`Y"rr" rZrs !'%[%G0 Z$Z  c#rZ(\3@Zr Z q= ף2@rZ ?# rrr3r "rr'C("/"Z(\2@Z#G $# Z!= ףp=4@`Z"rr'_!&g$rs!rr0 [~ [[(\3@T[?&rrr;#r"$O&rr+"3![Y0@[3$""3('r " '(!rrO#["! G!([)fffff3@0[*$r"_ ;$"3&0 \\= ףp0@0\%rrr# r\ = ףp}3@\ rrrr"&!$r!!&/'r[$_%r'rr"3)" !r' $'\((\3@6\) )r% O#r0 ]]Gz$@r]K!_ r_!r _rr3rrr]Gz3@]rr ' "!CsS&k%g%rr$'+#; !r"o,]-= ףp2@].rr0 ^^$^= ףp1@*^!r $! ^ 0@^ _$rrrw!o"r;rrg"wr"rrr&!$'^(Gz2@0^)W&r ;;r%/^0Qk0@ __ss%_= ףp3@$_(r rW$_ q= ףp4@B_ #rrg!rr%_(\3@_Q3@*_rrrr"_Q+0@H_;rrrrc%{$"+'_(Y3@_)_#rr_",_-3@_.r )/_0Y1@`1,a1,b1,c1,d1,e1,f1,g1,h1,i1,j1,k1,l1,m1,n1,o1,p1,q1,r1,s1,t1,u1,v1,w1,x1,y1,z1,{1,|1,}1,~1,1, ``k%`(\3@0` r"r#  ` (\3@` rr `Qk4@~ `r`0@`1@*`r!$r`fffff1@`r$ #`Gz0@~`{grr%rrr"rS$r!#3rr0 a<a%!r !rr[ a q= ף02@a  rr rr [#rrrC#G$C;!s'r$rr!^r "r#"r&0 bb'o_"rc r$';!rr_ r7r#'$rb(\0@br%'#b2@b!$#r!b"(\2@$b#rr7("*'b(fffff2@6b) r!"r/$W0 c<c3&rC!r c fffff0@$c ; rrrc= ףp=0@lcKrZ! &rr#G#{$!&!c"Gz4@$c#rr% %'c(fffff&3@6c)%r!g rr0 dd;!d= ףp=4@d rd(\B4@dr {!gk!rr o#+r"rr" "d= ףp0@dq= ףp1@dr !! d!(\4@d"(\O4@d#r$$d%Gz4@Hd&r{!g#rr/$r&!0 ee "k%o( &#!G! rrgrwKrr $rrr#$rr&{ rr'${%;#r# ,e-4@e.r$0 f`f&$r rrK"'$rgrfQ0@fCr?!f(\O3@f#rf= ףp}1@fr"#fq= ף3@ff{ %"&W#rr/"g /$s"r!,f-q= ף3@f.r&0 ggg!g(\4@lg?$rW r C#rr r r"%gGz3@grrw$r#{ s$r#3rr##$r #r+##!&$0 hh?$%r r{;rrr'r S#w%r+%G$k#h3@`h %r&Orr+#W"$#rW +h,q= ףp4@h-{rr/h0Qk2@ i*is )rr$iq= ף3@6ir;r{%/%ro&i(\0@i= ףp3@xi?r "?"rrk#&'rr $'K%$i%(\O2@i&#s)i*Gz4@*i+rw&G !"r0 jj$jQk4@~j$r rrW"$rrwr"O#rrj(\O2@jr#$!+$rr rr'"o'r#"r'3#srr0 k6k W" &r!r[#k (\3@k [K rr k(\B4@krg7r&+$ O)rwr%'%!&rr rr$W*r!r! or%/k02@ lTl #!rr!r'$!C{rr lffffff4@~ lrl(\O0@lGz1@BlrK"/!;rrrr#lffffff2@l(\1@xl %r?$rr%"&+"rrr %0 mZm'!rrr#r#r(rr/ m= ףp=4@m!mGz2@m+'rrrrr{&%+(rrr&rrc#$C" rrs !/%[&0 n~ nnQ+4@n"rr"rrr3#"'W#&k$'$# r_!(r&r"rW'#n$(\4@n%= ףp1@~ n&rn'= ףp}0@n(= ףp=3@6n)"$rr &c(0 oow_%roQk3@Bo#rr&#S&!SroQk0@6orK"[%%[&rO%roQk4@oY2@*o'rg&rrr o!q= ף2@o"$#o$Y4@No%?r77#rK"r#{ {'0 pTpO rr' +) r%o $rr pY4@p!p= ףp1@p_%7$w"rr#S"c&r)r !r$$Co 7s 'p(ffffff3@6p)!rrV?!O r0 qqo!'rqq= ף02@Nqr!rrr#rrO#!!qffffff3@fqWrr7%rrr [+j(r"r)#""q#(\1@~ q$s!q%q= ף03@q&&/'q((\3@6q)/"rr7! $ #0 r&rg;"rrr rrrr&r&r&K&"rr! &r[+rr"rr/ ?_"'!!rrr K"'"0 ssffffff0@Zsc#rrr# r$r$%r7!#sffffff1@~s!rrrrrr$'rr+#%$k'r7%$s%q= ףp4@Hs&W&#s#O"r?!W"O#r0 t<t "3$r r" t Gz2@t rrr{r;!!; rrorG&#R!(r;&rr'!"c&3$r!"r'k0 u~ uWuq= ף3@uO&ruffffff2@<u#$r7%r"rrK!u(\3@xu"r'#r$rr$r+&r%rS#S#"u#= ףp}2@Tu$O!kk /" #r #3&0 v vk";O%O!r+"Orrr r!{" rrrr?%G 3S !G#;( rr7 G$%$r!"r"/v0= ףp=2@ ww> [ rwQk1@<w% #"?#r"$r$wffffff4@w' !wfffff&4@`wr;!r!r##%)$rw$r""w#3@<w$/r3"!;#r,w-= ףp=4@w.!!o'0 xxs  "r$rrrrr!rr#rr##!!r x3@0x(?+(rrrs!x"GzT4@x#&+!$x%GzT2@Hx&'#"rO'r$ r0 yxyow$Crr r oOOrrrBr[$yq= ףp4@Ty rrrr$!r)&)!y"Gz2@$y#rr "r*'y(q= ף3@6y)O%r!!rr0 zz&zfffff3@z$rz= ףp}3@zr z = ףp}1@z rr z3@*zrr&z3@*zrrrr"zfffff&4@Hz"$/" rr;"#o('z(Q3@z)%r" ,z-Gz3@z.r#/z0(\0@ {B{#G$rrc/ { 3@{ rr rr[$!;rrrr#k"G rrr; rr rr'{((\3@{)$r"!,{-= ףp2@{.rr0 |6|S#$r r| (\4@| Qk3@r| rr rrw Zw $r_r%#!|4@`| &$%K rrO!%rw!rrw(,|-(\3@|.r&+0 }}*}fffff&4@B}rrrrrw[rr }Qk2@<}*rw& rr}(\3@N}&r(s&%O !g&r rr$}%ffffff3@H}&#r #r *cro&0 ~B~w%S$rK #S!O ~ q= ףp4@$~ rr r~0@H~r$$ rrrc$'~(\3@~$r%+"!~"(\3@B~#rr S%&c r"r,~-(\4@~.r#0 $S!["r3@0r$Nrr = ףp=3@*r'O c Y4@*rrr$"Q3@HK%'"_(rr'?''(q= ףp2@0)"%" r"/0(\1@1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1, $cG#g$rq= ף3@~ r= ףp}3@ 2@~  ? ffffff1@l rrorGr{%;rrrr#+= ףp2@ &$#!"(\4@B#rr r$7#rrW,-ffffff3@.rr 0 $G#'!r3@r_!  = ףp}1@N rrsrOrK!W rr= ףp2@< %r$#o ;"&#!"fffff&3@$#rr !#r'(q= ף2@6) r{#r'[0 "q= ף2@Tw#r S$'rrr(\0@ro!rrsrr$K &!O(rr k!$!r S!rr#0 TK"{$r;#"Krr (\B3@`rcKr7{ s rrS$r%#(\4@<7# O& r%RK!{&'(q= ףp2@)Gz3@0*r "Grr+0 6"#rrO  q= ף2@H  rrrwr;#fffff3@rrQk2@r$$!;w G#G%# rr!O"' rs#!r"0 #Q+3@Trr"r7"[ rr rGzT1@*r#r g#rQ3@rr)"O o"rrG! r#$k!%rO&rs$!k rS&0 K"GzT3@T r ro"Crrsr= ףp0@r"c!ffffff3@rrGz3@rr${(\3@0r!&'Rrr$%= ףp=4@H&"r"r"'r#/0 * rrr"fffff3@*'!r#$r fffff3@x!!;r;$%_ rr$)c&rr+$#!"Gz4@#W$$%q= ףp2@&q= ף2@B'o!JOg$r_&   o*0 6W!c3$r7w$  GzT3@~  c fffff3@f rrkr7r!c!rrrr;%GzT3@fffff3@r)S##*rrK"%%O#r!_" rK$/0q= ף01@ GC!'r" r7#  !r K S!Sr#rrrrW!?"r&)!"/$r"#Q1@T$c#+' r[ +!rC#"r0 "q= ףp2@$"rrg (\B2@ rr (\B3@`rGro"[ "rGrr3%+= ףp=3@Z)#&[!rr %b_rr;%O ,-q= ףp2@.rr0 Tg rrrrr"""rr q= ףp3@!!+r^rrrro#+('w'$#r"r{3"S {"%  (r0 /O'(\2@$r{#rc krrS rgr"g /S"rrr'!'{K%k&&rr;b('(Q3@6)"r$s +rr0 N#r&rrw${%r!  ffffff3@Hr!#rrrrrrq= ף03@0(r%r/"r !(\B2@0"CrW[r()(\B1@$*_$rrs  ./Y3@~ 0W' <#"Oo%rr$  q= ףp1@ 2@ rrOrr"#! 7"rr#$;"rr"!rr/!o$r{"rS#{$,-q= ף3@.r%0 sK#fffff&1@G r3@~ rQ3@ (\3@ q= ף0@T /rr3rrr rr= ףp1@r'%3% %[$W#rr? !r{!rC$+#r'/0= ףp}0@ ~ (\4@Hrr{K&rr $r (\4@ fffff&4@6%"$r&(\2@B #'%&rr"g"/+%$%Gz3@&;;!)*Gz3@+/#r,-(\B4@.#;)0 $7#!rq= ף04@~ rGzT4@ q= ף1@~   q= ף3@N rrrr rr= ףp}1@<r'*"#3"'!!!"Gz3@B#rr!#$#w!ro$!,-q= ףp3@.r)0 0g"^ro rq= ףp4@ Gz2@H _Srrrr = ףp}3@#rrr###&%rr!r%{wr!S"rG$[0 6!k"rWrr (\1@ %  (\4@~ _Qk3@rr!#r/+!W!O$c S'!"q= ף03@Z#r"R# [_"'{" rr0 <&KG+r"r'_!  Q+2@* !rr!r(\1@*r &!r'3@r%rKK ##;$'*#rr#{%r!$r"{$!rr/0Q0@ 6"!rr r7  (\3@* OrrrGzT1@0@frrC rr#r&$##rrr!"ffffff4@Z#rr"s$&k#rr orr0 ` rrrr#rr!rrO!rq= ף0@rr[rrr7&r #rw'k$r{"$"#Q2@~ $r%ffffff2@H&k#&{o "rK!#3 r0 ~ = ףp3@frrr%rr %r!%"ffffff4@ZrrrO"&+ #)rg&r#r!"= ףp1@$#K'''(Gz2@)(\B4@0*rr sr0 $W7"g #rGzT4@K%# Qk3@ GzT4@ Q2@N rror7;rc! rrq= ף02@`)r%ws #?"rrrr+! %'(fffff&3@)W#rk C!,-q= ף04@.rrg0 r!rrr"rr$rr  F##o(\O3@*b$#rrY3@ZC%r++&r#${%$W()Gz3@0*+!#r!!r0 `7 rrrrrrrfr; "(\O0@(\3@lF!r##r_#7$r!7%)%s(rro"$"#(\3@$r[%&Qk3@B'##  rr!K!"r0 * o rrrrQ3@Hrr#w#rG %"SGz3@`rrr$rW #r(rr3#O)C"#Q2@T$rW+7#J or!!!r0 ` !r r$r%{%&!rGz1@l!rrW%s$_%#*!ro'r'(O$r!"Gz3@#_'7!$%(\3@H&rGrrrrrO r0 ~ q= ף04@f{&rr&Wrr"rr rS #(\B3@rrrZ*r{$rrrrr$ rw& r$!./Y4@~ 0& 6 rrrc#$ 2@ ro#rr!!F!Kr_#rrr w%r/+_)rG"&!"(\O2@#Cr$%fffff2@&(\B2@B'!w#rrK _ /*0 s&= ףp}2@l'r!r C[rrGr'#rrQk3@0"rr#o$*ffffff4@Z&r$rr rw&&rr+,ffffff4@-rr/0Gz0@1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1,1, 0&/^r? rGz3@$ Krr Y3@rO#r#+ s"rrr% ; rs%)rr _%r$rk(+ rr0 s%Q+3@rr? $q= ף3@ (\2@ Q+2@ rr q= ף3@$rrG&q= ףp4@(\B4@0rr rr%g"Gz3@Y4@*rrw&rr$%q= ף04@H&'"g$C"rs$7grr0 #(Gz2@K!rGz3@0r/ rr (\2@rGr"%r!r&$ #  rr!rr!rS$[k$r! ,-(\2@.rrs0 wr&rrs rr!_$!rr"rCrrr$S#r#rrr(%_$r&r #rr'!#r ()q= ף2@0*rr;$rr"0 `S'($rrk&$"%Ow"rr r(\4@ rr$"r;&rrk(r'%%rr3 rr;!r#"!r"rNrr/0fffff2@ r[[!rr!r{r3!r&$r{_[K!WGzT2@rrr&r%rc C"r#'S)r?$S$ $%&Q2@'$()q= ףp3@0*!k$r'! #0 `K #r3%rrc#$r r(\0@q= ף3@x#rr""%r;$r$r!r?r $%q= ף1@&r'(Qk1@6)K$r# r "K&0 Z>w!rrrr&rr#r= ףp3@fffff0@Zrr%$rrrC%r&rfffff&4@$ r++r $%(\1@~ &r'Qk0@<(3#r?"rK"rr0 N #r_'$rrrr"  (\2@rG(rr[$#!rr co$r &r;!rrVrs"?%+$r rk(0 `!rrkrrrrrrs rffffff1@l&rr&#rrrC+r'rw$r!"= ףp}3@$#r r'(Y2@6)#$r rr0 Z!#rrrr#r+$7!r= ףp=3@ rrr#7#rr&r?&r!rr$%fffff1@&r'(fffff1@6)rr'!rr$0 ` rr$rro("rWs%fffff0@rr$g$k"c&rV $r'rrr'C"#Gz1@$%$'(= ףp}2@6)W !rr G  [&0 wO!rfffff3@"&r#r$;'Cr"rrr)$#r'%rk&r#r !Q+1@*"r%Nro'(Q3@6) $%G)!r!#0 (\2@ _'rrr/! rc!r&rr;$w& 3;$o#$#!rr'[+rrrrrro r3"!rR"%rrk r#r0 6!rrrrW r q= ף1@ r%rro C$7 Krrr!rrs$rrS'r"r"rWw%'(q= ף1@6) rr "?#r0 `3g!$r7&$r%')w&r31@f!rW%r#%r#"r(r&r#!r != ףp}3@T"Cr {rG#rrr r./3@~ 0r `k rrrrrrk#rr/ $Gz1@~ r(\O0@xr$"%rrW${)rrr!['K s"%&Y4@'7'+k)*fffff&4@*+G(r " r0 ;"rrr['rS!r'rr '"  Kr7$rr3)rQ3@fr&rrr$$7$$/%rr!#&G"r0 T'!rrrrC &r7%rr q= ף04@~ #"(\1@? 'G&"rrc%r!w$r)r$rr rssr()(\B4@0*?!rr'!""r0 T!rrrr/r+'#S"r fffff&4@H"r{r##$rr$(\3@H%;*O'rr?"r#;#k%&(\3@B'K&O"{"r   #r0 Z"!r?&%r!rr$r= ףp3@wr$r?$r["rV%r$rrr r%W !g [#%#"w#{ W%0 *'G"#!rrr3@~ r GzT3@ r&rr Qk4@~ "(\O1@(\3@l; rrr &";(g(r(rr*g!"#(\3@~ $r%Gz2@H&O'"S#"rrro#W#r0 K$(\3@*"r$!  = ףp=2@T orrW rr?#wrrGz4@rr( w$rC%$w ;(r["#%r"r"{_rrW0 $(\2@*!r_r7#C  = ףp}1@ ; rr 3@& Cr!  rrO$%$;N/"#' rrsc!&og&r"W rr/0 0#rrorGz3@ Q+3@0 rrr Qk0@r3@srr3@_$$%GzT4@= ףp}2@Q3@r'r(o"rr #%"r{! rr0 <[{'"r rr  Q2@* W rrS!rGz0@r"%"rr rrS%o oZr$&$rr#%+S!O'rK$ O rr0 $' #$r4@0rc#rr = ףp=4@r?Grffffff4@6r rrrr"= ףp=4@= ףp}3@x"(+%O'/#rr!%o' !rr["{rr0PH0(  >@A `ooogg   FMicrosoft Excel 97-TabelleBiff8Oh+'0 px  Paul Robson1@9z@@V׸@Rj՜.+,D՜.+,\Root EntryFWorkbook CompObjIOle SummaryInformation(@DocumentSummaryInformation8tdestiny/vignettes/mmc6.xls0000644000175200017520000006200014516010071016646 0ustar00biocbuildbiocbuildࡱ> (0  !"#$%&'*+,-./R FAW>) Workbook JSummaryInformation(d DocumentSummaryInformation8. J\p2712 Robson Ba==pA8@"1Verdana1Verdana1Verdana1Verdana1Verdana1Arial1Verdana1Arial"$"#,##0_);\("$"#,##0\)!"$"#,##0_);[Red]\("$"#,##0\)""$"#,##0.00_);\("$"#,##0.00\)'""$"#,##0.00_);[Red]\("$"#,##0.00\)7*2_("$"* #,##0_);_("$"* \(#,##0\);_("$"* "-"_);_(@_).))_(* #,##0_);_(* \(#,##0\);_(* "-"_);_(@_)?,:_("$"* #,##0.00_);_("$"* \(#,##0.00\);_("$"* "-"??_);_(@_)6+1_(* #,##0.00_);_(* \(#,##0.00\);_(* "-"??_);_(@_)                + ) , *       8dq:Fc-2NWgFSWc-2NWgFSW̙̙3f3fff3f3f33333f33333\`Sheet1II Dilution 1 Dilution 2 Dilution 3 Dilution 4 Dilution 5 Dilution 6 Dilution 7 Dilution 8 Dilution 9 Dilution 10 Dilution 11 Dilution 12 Dilution 13 Dilution 14 Dilution 15 Dilution 16 Dilution 17 Dilution 18 Dilution 19 Dilution 20 Dilution 21 Dilution 22 Dilution 23 Dilution 24CellActbAhcyAqp3Atp12aBmp4Cdx2Creb312CebpaDab2DppaIEomesEsrrbFgf4Fgfr2Fn1GapdhGata3Gata4Gata6Grhl1Grhl2Hand1Hnf4aId2Klf2Klf4Klf5Krt8Lcp1Mbnl3MscMsx2NanogPdgfaPdgfraPecam1Pou5f1Runx1Sox2Sall4Sox17SnailSox13Tcfap2aTcfap2cTcf23Utf1Tspan8J dtCS  3 Ct  _ ed H2 `H3higocaXH{ܿ̿ ` `sPFHJSE -@"JeP_p?0@l  `P XP]Jqȿ P[CP]JqJq\NL0̿j\` PJ섢o\ CJqJq0`C\Jf NL$`pi E `]HPCOCNLE lH{ܿH|,$0HNLE  ` `_ EZ0 ` ``'XP[ ``PplH `?C `HP *HE  ` J 'I  dMbP?_*+%M= com.apple.print.PageFormat.PMHorizontalRes com.apple.print.ticket.creator com.apple.jobticket com.apple.print.ticket.itemArray com.apple.print.PageFormat.PMHorizontalRes 300 com.apple.print.ticket.stateFlag 0 com.apple.print.PageFormat.PMOrientation com.apple.print.ticket.creator com.apple.jobticket com.apple.print.ticket.itemArray com.apple.print.PageFormat.PMOrientation 1 com.apple.print.ticket.stateFlag 0 com.apple.print.PageFormat.PMScaling com.apple.print.ticket.creator com.apple.jobticket com.apple.print.ticket.itemArray com.apple.print.PageFormat.PMScaling 1 com.apple.print.ticket.stateFlag 0 com.apple.print.PageFormat.PMVerticalRes com.apple.print.ticket.creator com.apple.jobticket com.apple.print.ticket.itemArray com.apple.print.PageFormat.PMVerticalRes 300 com.apple.print.ticket.stateFlag 0 com.apple.print.PageFormat.PMVerticalScaling com.apple.print.ticket.creator com.apple.jobticket com.apple.print.ticket.itemArray com.apple.print.PageFormat.PMVerticalScaling 1 com.apple.print.ticket.stateFlag 0 com.apple.print.subTicket.paper_info_ticket PMPPDPaperCodeName com.apple.print.ticket.creator com.apple.jobticket com.apple.print.ticket.itemArray PMPPDPaperCodeName A4 com.apple.print.ticket.stateFlag 0 PMTiogaPaperName com.apple.print.ticket.creator com.apple.jobticket com.apple.print.ticket.itemArray PMTiogaPaperName iso-a4 com.apple.print.ticket.stateFlag 0 com.apple.print.PageFormat.PMAdjustedPageRect com.apple.print.ticket.creator com.apple.jobticket com.apple.print.ticket.itemArray com.apple.print.PageFormat.PMAdjustedPageRect 0.0 0.0 3262.5000000000005 2329.166666666667 com.apple.print.ticket.stateFlag 0 com.apple.print.PageFormat.PMAdjustedPaperRect com.apple.print.ticket.creator com.apple.jobticket com.apple.print.ticket.itemArray com.apple.print.PageFormat.PMAdjustedPaperRect -75 -75 3433.3333333333335 2404.166666666667 com.apple.print.ticket.stateFlag 0 com.apple.print.PaperInfo.PMPaperName com.apple.print.ticket.creator com.apple.jobticket com.apple.print.ticket.itemArray com.apple.print.PaperInfo.PMPaperName iso-a4 com.apple.print.ticket.stateFlag 0 com.apple.print.PaperInfo.PMUnadjustedPageRect com.apple.print.ticket.creator com.apple.jobticket com.apple.print.ticket.itemArray com.apple.print.PaperInfo.PMUnadjustedPageRect 0.0 0.0 783 559 com.apple.print.ticket.stateFlag 0 com.apple.print.PaperInfo.PMUnadjustedPaperRect com.apple.print.ticket.creator com.apple.jobticket com.apple.print.ticket.itemArray com.apple.print.PaperInfo.PMUnadjustedPaperRect -18 -18 824 577 com.apple.print.ticket.stateFlag 0 com.apple.print.PaperInfo.ppd.PMPaperName com.apple.print.ticket.creator com.apple.jobticket com.apple.print.ticket.itemArray com.apple.print.PaperInfo.ppd.PMPaperName A4 com.apple.print.ticket.stateFlag 0 com.apple.print.ticket.APIVersion 00.20 com.apple.print.ticket.type com.apple.print.PaperInfoTicket com.apple.print.ticket.APIVersion 00.20 com.apple.print.ticket.type com.apple.print.PageFormatTicket Mz,,  j eg{HH(dh "d??U 11,1,1, 1,p@1,@1,1,1,rp@1,iT@ 1,Ђ@ 1,@ 1, 1,i 1,1,1,@1,@1,1,@1,o1,1,1,P1, @1,P@          ! " # $ % & ' ( ) * + , - . / 0 1 2 3 4 5 6 7 8 !9 ": #; $< %= &> '? (@ )A *B +C ,D -E .F /G 0H &@@x@@b@0@@<@@@@t@|@@|@*@@n@@@T@r@@8@H@@@@`@r@T@@@\@@@X@h@0@@Z@\@(@ȟ@@4@l@x@0 &$@3@@@4@@@2@T@@@0@@r@Ҡ@@>@@@D@H@@@@@p@@@@@t@@r@`@@L@ԟ@D@@ޠ@$@X@@$@b@@3@@@T@0 &@ @@@@@2@<@@@Ě@@@@ܠ@Ğ@@@Ԙ@6@L@̤@@@N@@6@@v@/@@D@ԡ@@@T@4@@ܛ@@T@t@@Ƞ@@J@t@j@@@0 &<@@@@J@@<@@@@@@|@,@0@@Ę@ @@@b@@&@ģ@@@T@<@@Й@@X@<@<@0@ޠ@@F@ @<@$@$@h@ڠ@@ܢ@@r@@@0 &̕@@@ޡ@@4@h@@@@6@<@|@*@@@`@ʡ@@̣@@F@\@@@b@<@L@@@@<@n@5@@@@<@@@@p@@@@@<@7@@0 &@@@@@*@H@B@@t@"@ڣ@*@ܡ@<@l@@~@@(@Π@~@p@@@H@`@@@D@<@|@ء@n@6@@4@<@d@P@@@<@@j@f@&@@0 &@@j@x@<@@<@@7@z@ʤ@H@@p@6@@@@@<@|@<@<@@<@@@̟@@<@<@<@̡@<@¢@<@`@@@@@<@<@7@X@<@<@@0 &p@@<@<@<@@<@<@@@<@@<@<@<@@4@P@@<@<@v@p@<@@v@T@@4@n@<@<@<@@<@@<@6@<@@6@6@<@<@@l@<@<@F@0 & l@@@<@<@,@<@<@ܣ@p@&@<@<@<@<@@ @<@<@ģ@,@<@<@R@<@.@@@<@<@<@<@ڤ@<@<@<@@<@@@6@<@<@<@6@<@<@ޡ@0  & <@t@@<@<@@<@<@:@,@<@<@<@<@<@Р@d@<@<@<@ @<@<@,@<@~@<@ʠ@@<@<@<@6@<@<@<@@<@@<@R@<@<@<@@<@<@@0  & d@<@<@<@<@@<@<@<@@<@<@<@<@<@@@<@*@<@@@<@<@<@@<@@<@<@<@<@@<@<@<@<@<@<@<@@<@<@@ @ң@<@<@0  & 4@<@@<@<@@<@<@.@<@ԣ@<@<@<@<@ԣ@@<@<@<@<@x@<@<@<@<@<@,@<@<@<@<@<@<@<@<@<@<@<@<@<@<@<@d@@<@<@@0  & @<@<@<@<@j@<@<@<@<@<@<@<@<@<@@~@<@<@<@t@d@<@<@<@<@<@<@<@<@<@<@<@<@<@<@@<@<@<@4@<@<@@`@<@<@<@0  &V@<@<@<@<@0@<@<@<@<@<@<@<@<@<@@@<@<@<@f@@<@<@<@<@<@<@<@<@<@<@<@<@<@<@<@<@<@<@@<@<@@f@<@<@<@0 &@<@<@<@<@ @l@<@<@<@<@<@<@<@<@@L@<@<@<@<@@<@<@<@<@<@<@<@<@<@<@<@<@<@<@:@<@<@<@ޡ@<@<@@@<@<@<@0 &<@d@<@<@<@t@<@<@<@<@<@<@<@<@<@n@<@<@<@<@@<@<@<@<@<@<@<@<@<@<@<@<@<@<@<@@<@<@<@Ġ@<@<@<@5@<@<@<@0 &<@<@<@<@<@r@<@<@<@<@<@<@<@<@<@@@<@<@<@v@~@<@<@<@<@<@<@<@<@<@<@<@<@<@<@@<@<@<@0@<@<@<@@<@<@<@0 &<@̣@<@<@<@f@<@<@<@<@<@<@<@<@<@@@<@<@<@0@آ@<@<@<@<@<@<@<@<@<@<@<@<@<@<@@<@<@<@<@<@<@<@6@<@<@<@0 &Ƣ@<@<@<@<@t@<@<@<@<@<@<@<@<@<@f@Ҡ@<@<@<@<@@<@<@@R@<@<@<@<@<@<@<@<@<@<@@<@<@<@J@<@<@R@ @<@<@<@0 &<@<@<@<@<@С@<@<@<@<@<@<@<@<@<@̡@<@<@<@<@@<@<@<@<@<@<@<@<@<@<@<@<@<@<@<@&@<@<@<@<@<@<@<@@<@<@<@0 &<@<@<@<@<@@<@<@<@<@<@<@<@<@<@@@<@<@<@ҡ@<@<@<@<@<@<@<@<@<@<@<@<@<@<@<@h@<@<@<@H@<@<@v@$@<@<@<@0 &<@<@<@<@<@@<@<@<@<@<@<@<@<@<@6@@<@<@<@С@<@<@<@<@@<@<@<@<@<@<@<@<@<@<@<@<@<@<@@<@<@0@ @<@<@<@0 &<@<@<@<@<@֠@<@<@<@<@<@<@<@<@<@@z@<@<@<@t@<@<@<@<@<@<@<@<@<@<@<@<@<@<@<@j@<@<@<@d@<@<@@@<@<@<@0 &p@<@<@<@<@@<@<@<@<@<@<@<@<@<@@@<@<@<@l@v@<@<@<@<@<@<@<@<@<@<@<@<@<@<@<@<@<@<@|@<@<@@@<@<@<@06!88888888888888888888888>@dd@5   !"#$%&'()*+,-/013 Oh+'04 @H\p ' Paul Robson Paul RobsonMicrosoft Excel@QG PICT G HHG G    "",";"J"Y"h"w""""""""+":"I"X"g"v"""""""""-"<"K"Z"i"x""""""""."="L"["j"y""""" E E  E F"e " " "F "d " " "E " "f " " " "g " " 1"" "" " " "" DDQQ^^, Lucida Grande .+ 1*2*3*4*5*6*7*8*9(10*11*12*13( <A)LB)JC)KD G, Arial (Cell)KActb)KAhcy)KAqp3() Dilution 1)r10.08)K18.27)K15.02(8 Dilution 2)r10.97)\19):16.01(G Dilution 3)s11.91)J19.92)K17.09(V Dilution 4)r12.95)K21.34)K17.97(e Dilution 5)r13.95)K21.86)K18.92(t Dilution 6)r15.07)K23.71)K19.63( Dilution 7)r16.05)K26.34)K21.01( Dilution 8)r16.92)K24.32)K22.06( Dilution 9)r18.19)K27.59)K23.94( Dilution 10)r18.71)K27.46)K23.07( Dilution 11)r20.09)\28)K28( Dilution 12)y20.5)U28):25.71 G!E E ,,E ;;E JJE YYE hhE wwE E E E E E E  ee   FF F - ՜.+,0 PXd lt| 'GIS Sheet1  Worksheets FMicrosoft Excel Worksheet8FIBExcel.Sheet.8CompObj2Xdestiny/vignettes/tidyverse.Rmd0000644000175200017520000000631414516010071017744 0ustar00biocbuildbiocbuild--- title: tidyverse and ggplot integration with destiny output: rmarkdown::html_vignette vignette: > %\VignetteIndexEntry{tidyverse and ggplot integration with destiny} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} --- Interaction with the tidyverse and ggplot2 ========================================== The [tidyverse](https://www.tidyverse.org/), [ggplot2](http://ggplot2.tidyverse.org/), and destiny are a great fit! ```{r} suppressPackageStartupMessages({ library(destiny) library(tidyverse) library(forcats) # not in the default tidyverse loadout }) ``` ggplot has a peculiar method to set default scales: You just have to define certain variables. ```{r} scale_colour_continuous <- scale_color_viridis_c ``` When working mainly with dimension reductions, I suggest to hide the (useless) ticks: ```{r} theme_set(theme_gray() + theme( axis.ticks = element_blank(), axis.text = element_blank())) ``` Let’s load our dataset ```{r} data(guo_norm) ``` Of course you could use [tidyr](http://tidyr.tidyverse.org/)::[gather()](https://rdrr.io/cran/tidyr/man/gather.html) to tidy or transform the data now, but the data is already in the right form for destiny, and [R for Data Science](http://r4ds.had.co.nz/tidy-data.html) is a better resource for it than this vignette. The long form of a single cell `ExpressionSet` would look like: ```{r} guo_norm %>% as('data.frame') %>% gather(Gene, Expression, one_of(featureNames(guo_norm))) ``` But destiny doesn’t use long form data as input, since all single cell data has always a more compact structure of genes×cells, with a certain number of per-sample covariates (The structure of `ExpressionSet`). ```{r} dm <- DiffusionMap(guo_norm) ``` `names(dm)` shows what names can be used in `dm$`, `as.data.frame(dm)$`, or `ggplot(dm, aes())`: ```{r} names(dm) # namely: Diffusion Components, Genes, and Covariates ``` Due to the `fortify` method (which here just means `as.data.frame`) being defined on `DiffusionMap` objects, `ggplot` directly accepts `DiffusionMap` objects: ```{r} ggplot(dm, aes(DC1, DC2, colour = Klf2)) + geom_point() ``` When you want to use a Diffusion Map in a dplyr pipeline, you need to call `fortify`/`as.data.frame` directly: ```{r} fortify(dm) %>% mutate( EmbryoState = factor(num_cells) %>% lvls_revalue(paste(levels(.), 'cell state')) ) %>% ggplot(aes(DC1, DC2, colour = EmbryoState)) + geom_point() ``` The Diffusion Components of a converted Diffusion Map, similar to the genes in the input `ExpressionSet`, are individual variables instead of two columns in a long-form data frame, but sometimes it can be useful to “tidy” them: ```{r} fortify(dm) %>% gather(DC, OtherDC, num_range('DC', 2:5)) %>% ggplot(aes(DC1, OtherDC, colour = factor(num_cells))) + geom_point() + facet_wrap(~ DC) ``` Another tip: To reduce overplotting, use `sample_frac(., 1.0, replace = FALSE)` (the default) in a pipeline. Adding a constant `alpha` improves this even more, and also helps you see density: ```{r} fortify(dm) %>% sample_frac() %>% ggplot(aes(DC1, DC2, colour = factor(num_cells))) + geom_point(alpha = .3) ```